From c6797efb125ff66dfc87715e4775336f7109ba33 Mon Sep 17 00:00:00 2001 From: "Igor S. Gerasimov" Date: Sat, 5 Feb 2022 13:55:36 +0900 Subject: [PATCH] Use UTF-8 charset --- basin.f90 | 4 +-- excittrans.f90 | 2 +- fuzzy.f90 | 6 ++--- hyper_polar.f90 | 2 +- noGUI.sh | 2 +- otherfunc3.f90 | 2 +- population.f90 | 4 +-- sub.f90 | 70 ++++++++++++++++++++++++------------------------- topology.f90 | 6 ++--- util.f90 | 12 ++++----- 10 files changed, 55 insertions(+), 55 deletions(-) diff --git a/basin.f90 b/basin.f90 index fa42509..7182abd 100644 --- a/basin.f90 +++ b/basin.f90 @@ -2486,7 +2486,7 @@ if (any(MOocc<0)) then end if write(*,*) "Calculating LI and DI..." -!RHF,R-post-HF, DI_A,B=2¡Æ[i,j]dsqrt(n_i*n_j)*S_i,j_A * S_i,j_B where i and j are spatial orbitals +!RHF,R-post-HF, DI_A,B=2∑[i,j]dsqrt(n_i*n_j)*S_i,j_A * S_i,j_B where i and j are spatial orbitals if (wfntype==0.or.wfntype==3) then DI=0D0 do ibas=1,numrealatt @@ -2541,7 +2541,7 @@ else if (wfntype==2) then !Combine alpha and Beta to total DI=DIa+DIb LI=LIa+LIb -!UHF,U-post-HF DI(A,B)=2¡Æ[i,j]dsqrt(n_i*n_j)*S_i,j_A * S_i,j_B where i and j are spin orbitals +!UHF,U-post-HF DI(A,B)=2∑[i,j]dsqrt(n_i*n_j)*S_i,j_A * S_i,j_B where i and j are spin orbitals else if (wfntype==1.or.wfntype==4) then !Alpha DIa=0D0 diff --git a/excittrans.f90 b/excittrans.f90 index 2107652..85269f1 100644 --- a/excittrans.f90 +++ b/excittrans.f90 @@ -4405,7 +4405,7 @@ end subroutine !---------- Generate transition density matrix between ground state and an excited state ---------- !-------------------------------------------------------------------------------------------------- !There are two ways to construct TDM for TD method, see eqs. 22~24 in & -!JCP,66,3460 (Abinitio calculations of oscillator and rotatory strengths in the random©\phase approximatio-Twisted mono©\olefins) for detail +!JCP,66,3460 (Abinitio calculations of oscillator and rotatory strengths in the random-phase approximatio-Twisted mono-olefins) for detail !iTDMtype=1: Correct for transition electric dipole moment, excitation and de-excitation are not distinguished !iTDMtype=2: Correct for transition velocity/magnetic dipole moment, excitation and de-excitation are considered individually !isym=1: Ask user if symmetrizing the TDM. =3: Skip symmetrizing diff --git a/fuzzy.f90 b/fuzzy.f90 index 3e4f0e9..c9ae49d 100644 --- a/fuzzy.f90 +++ b/fuzzy.f90 @@ -1028,7 +1028,7 @@ end if write(*,*) "Press ENTER button to continue" read(*,*) end if - !RHF,R-post-HF, DI_A,B=2¡Æ[i,j]dsqrt(n_i*n_j)*S_i,j_A * S_i,j_B where i and j are non-spin orbitals + !RHF,R-post-HF, DI_A,B=2∑[i,j]dsqrt(n_i*n_j)*S_i,j_A * S_i,j_B where i and j are non-spin orbitals if (wfntype==0.or.wfntype==3) then DI=0D0 do iatm=1,ncenter @@ -1085,7 +1085,7 @@ end if !Combine alpha and Beta to total DI=DIa+DIb LI=LIa+LIb - !UHF,U-post-HF DI(A,B)=2¡Æ[i,j]dsqrt(n_i*n_j)*S_i,j_A * S_i,j_B where i and j are spin orbitals + !UHF,U-post-HF DI(A,B)=2∑[i,j]dsqrt(n_i*n_j)*S_i,j_A * S_i,j_B where i and j are spin orbitals else if (wfntype==1.or.wfntype==4) then !Alpha DIa=0D0 @@ -1541,7 +1541,7 @@ else if (isel==7) then !FLU-pi write(*,*) "Which occupied orbitals are pi orbitals? Input their indices, e.g. 17,20,21" read(*,"(a)") c80inp call str2arr(c80inp,nFLUorb,FLUorb) - !Generate DI for pi orbitals. DI_A,B=2¡Æ[i,j]dsqrt(n_i*n_j)*S_i,j_A * S_i,j_B where i and j are non-spin orbital + !Generate DI for pi orbitals. DI_A,B=2∑[i,j]dsqrt(n_i*n_j)*S_i,j_A * S_i,j_B where i and j are non-spin orbital DI=0D0 do iatm=1,ncenter do jatm=iatm+1,ncenter diff --git a/hyper_polar.f90 b/hyper_polar.f90 index de0b096..854dad1 100644 --- a/hyper_polar.f90 +++ b/hyper_polar.f90 @@ -544,7 +544,7 @@ if (isel==1.or.isel==3.or.isel==5) then !Beta(-2w;w,w) as been parsed before, in this case we also output HRS related quantites if (ibeta==2) then !Calculate and , without Kleinman condition approximation - !Below, the Eqs. 4 and 5 in Phys. Chem. Chem. Phys., 10, 6223¨C6232 (2008) are employed + !Below, the Eqs. 4 and 5 in Phys. Chem. Chem. Phys., 10, 6223-6232 (2008) are employed !Note that is equivalent to the occured in many literatures u1=0;u2=0;u3=0;u4=0;u5=0;u6=0;u7=0;u8=0;u9=0;u10=0;u11=0 t1=0;t2=0;t3=0;t4=0;t5=0;t6=0;t7=0;t8=0;t9=0;t10=0;t11=0 diff --git a/noGUI.sh b/noGUI.sh index 8905212..eb9463a 100644 --- a/noGUI.sh +++ b/noGUI.sh @@ -8,7 +8,7 @@ cp -r libreta_slow noGUI cp -r libreta_fast noGUI for f90 in *.f90 do -grep -a -v -E "use dislin_d|use plot|use GUI|call gifmod|call pngmod|call angle|\ +grep -v -E "use dislin_d|use plot|use GUI|call gifmod|call pngmod|call angle|\ call drawdomaingui|call drawmolgui|call drawplanegui|call drawisosurgui|call drawmoltopogui|\ call drawsurfanalysis|call drawbasinintgui|call drawmol|call drawcurve|call drawscatter|\ call drawmatcolor|call drawplane|call useclrind|metafl|call window|scrmod|imgfmt|\ diff --git a/otherfunc3.f90 b/otherfunc3.f90 index 727f4fe..9cded07 100644 --- a/otherfunc3.f90 +++ b/otherfunc3.f90 @@ -1764,7 +1764,7 @@ open(10,file="new.xyz",status="replace") do igen=1,numgen do i=1,nsel iatm=atmlist(i) - !Use basic form of Box¨CMuller transform to generate random numbers & + !Use basic form of Box-Muller transform to generate random numbers & !satisfying normal distribution (https://en.wikipedia.org/wiki/Box%E2%80%93Muller_transform) CALL RANDOM_NUMBER(ran1) CALL RANDOM_NUMBER(ran2) diff --git a/population.f90 b/population.f90 index 7076806..28ec249 100644 --- a/population.f90 +++ b/population.f90 @@ -648,7 +648,7 @@ if (isel==1.or.isel==2.or.isel==4) then call outatmchg(10,charge(:)) else if (isel==3) then - write(ides,*) "The (i,j) element corresponds to ¡Æ[imo] Occ(imo)*C(i,imo)*C(j,imo)*S(i,j)" + write(ides,*) "The (i,j) element corresponds to ∑[imo] Occ(imo)*C(i,imo)*C(j,imo)*S(i,j)" write(ides,*) call showmatgau(Ptot*Sbas,"Total gross basis function population matrix",0,"f14.8",ides) write(ides,*) @@ -4613,7 +4613,7 @@ do icyc=1,maxcyc charge=charge+delta_q if (outmedinfo==1) then do iatm=1,ncenter - write(*,"(i6,'(',a,') ¦¤q=',f10.6,' X=',f10.3,' eV q=',f12.6)") iatm,ind2name(a(iatm)%index),delta_q(iatm),eleneg(iatm),charge(iatm) + write(*,"(i6,'(',a,') ∆q=',f10.6,' X=',f10.3,' eV q=',f12.6)") iatm,ind2name(a(iatm)%index),delta_q(iatm),eleneg(iatm),charge(iatm) end do end if if (deltamax1) then !Use BB2 (see "STABILIZED BARZILAI-BORWEIN METHOD") to determine stepsize, corresponding to Barzilai¨CBorwein in https://en.wikipedia.org/wiki/Gradient_descent + if (i>1) then !Use BB2 (see "STABILIZED BARZILAI-BORWEIN METHOD") to determine stepsize, corresponding to Barzilai-Borwein in https://en.wikipedia.org/wiki/Gradient_descent dvec(:)=disp(:,1) val1=sum(dvec(:)*(gvec-gvec_old)) val2=sum((gvec-gvec_old)**2) @@ -2046,7 +2046,7 @@ do i=1,topomaxcyc disp(:,1)=-gvec(:)*stepinit/dsqrt(sum(gvec(:)**2)) end if grad(:,1)=gvec(:) - else if (itopomethod==3) then !Barzilai¨CBorwein steep ascent to determine displacement vector, proposed by Tian Lu by modifying BB2 + else if (itopomethod==3) then !Barzilai-Borwein steep ascent to determine displacement vector, proposed by Tian Lu by modifying BB2 gvec_old=gvec call gencalchessmat(1,ifunc,coord(1,1),coord(2,1),coord(3,1),value,gvec(:),hess) !Obtain gradient if (i>1) then diff --git a/util.f90 b/util.f90 index 7a704e4..5633a05 100644 --- a/util.f90 +++ b/util.f90 @@ -268,7 +268,7 @@ v34y=y3-y4 v34z=z3-z4 call vecprod(v12x,v12y,v12z,v23x,v23y,v23z,p1x,p1y,p1z) call vecprod(v23x,v23y,v23z,v34x,v34y,v34z,p2x,p2y,p2z) -!a¡¤b=|a||b|cos¦È, so ¦È=acos[a¡¤b/(|a||b|)] +!aâ‹…b=|a||b|cosθ, so θ=acos[aâ‹…b/(|a||b|)] tmp=(p1x*p2x+p1y*p2y+p1z*p2z)/(sqrt(p1x*p1x+p1y*p1y+p1z*p1z)*sqrt(p2x*p2x+p2y*p2y+p2z*p2z)) if (tmp>1D0) tmp=1D0 !acos(x) should <1 and >-1, the x may marginally violate this condition due to numerical reason, making acos return NaN, so fix it if (tmp<-1D0) tmp=-1D0 @@ -318,7 +318,7 @@ va3=pbz-paz vb1=pcx-pax vb2=pcy-pay vb3=pcz-paz -call vecprod(va1,va2,va3,vb1,vb2,vb3,vc1,vc2,vc3) !vc=va¡Ávb=|va||vb|sin¦È*i where i is unit vector perpendicular to va and vb +call vecprod(va1,va2,va3,vb1,vb2,vb3,vc1,vc2,vc3) !vc=va⨯vb=|va||vb|sinθ*i where i is unit vector perpendicular to va and vb absvc=dsqrt(vc1**2+vc2**2+vc3**2) gettriangarea=0.5D0*absvc end function @@ -335,7 +335,7 @@ real*8 pax,pay,paz,pbx,pby,pbz,pcx,pcy,pcz,pdx,pdy,pdz ! volmat(:,4)=1D0 ! gettetravol=abs(detmat(volmat))/6D0 ! call showmatgau(volmat) -!vol=abs( (a-d)¡¤((b-d)¡Á(c-d)) )/6, see http://en.wikipedia.org/wiki/Tetrahedron +!vol=abs( (a-d)â‹…((b-d)⨯(c-d)) )/6, see http://en.wikipedia.org/wiki/Tetrahedron vec1x=pax-pdx vec1y=pay-pdy vec1z=paz-pdz @@ -462,7 +462,7 @@ end subroutine !!---------- Input a set of atoms to fit a best plane. Return A, B, C, D of plane equation A*x+B*y+C*z+D=0 !"atmarr" with size of "natm" is the array containing atom indices in the ring. rmsfit measures RMS fitting error in Bohr ! Based on joriki's answer: https://math.stackexchange.com/questions/99299/best-fitting-plane-given-a-set-of-points -! "Subtract out the centroid, form a 3¡ÁN matrix X out of the resulting coordinates and calculate its singular value decomposition. & +! "Subtract out the centroid, form a 3⨯N matrix X out of the resulting coordinates and calculate its singular value decomposition. & !The normal vector of the best-fitting plane is the left singular vector corresponding to the least singular value" subroutine ptsfitplane(atmarr,natm,planeA,planeB,planeC,planeD,rmsfit) use defvar @@ -1556,7 +1556,7 @@ end subroutine !------- Calculate how much is a matrix deviates from identity matrix -!error=¡Æ[i,j]abs( abs(mat(i,j))-¦Ä(i,j) ) +!error=∑[i,j]abs( abs(mat(i,j))-ð›¿(i,j) ) real*8 function identmaterr(mat) implicit real*8 (a-h,o-z) real*8 mat(:,:) @@ -1787,7 +1787,7 @@ subroutine readmatgau(fileid,mat,insemi,inform,inskipcol,inncol,innspace,iostat) !innspace: Number of useless lines in between each frame, default is 1 !iostat: Returned reading status. /=0 means error occurs -!Before use, loclabel should be used to move reading position to title line of the matrix£¬namely move to "*** Overlap ***" +!Before use, loclabel should be used to move reading position to title line of the matrix, namely move to "*** Overlap ***" ! *** Overlap *** ! 1 2 3 4 5 ! 1 0.100000D+01 -- 2.25.1