C------------------------------------------------- C A.Klypin 25 Nov.1997 (NMSU) C Bound-Density-Maxima code: C Find maxima of mass in spheres of radius Rsearch1 C for particles in a periodic cube of size Box C Coordinates: 0-NGRID, Box =NGRID C All variables and constants are scaled to the Hubble constant of your C model. Only FINAL values are rescled to H=100km/s/Mpc C More detailed description of the algorithm and the code can be C found in file BDM_describe C-------------------------------------------------- C Arrays Label and Lst provide quick access to neibhor particles C Label(i,j,k) = number of the first particle in c the cell (i,j,k), if Label .ne. 0 C = 0 - empty cell C Cell = size of a cell for Label C Lst(i) = number of the next particle in the cell, C where i-th was found. C If Lst=0 - last point in the cell was found. C INCLUDE 'PMparameters.h' INCLUDE 'PMlists.h' Real INPUT,Mhalo Real Overdens(Nrad),Mass(Nrad),MnMass(Nrad) COMMON /OVER/ Ovlim,Ovcnt DIMENSION Radsc(Nrad) Ovcnt =INPUT('Enter Min. Center Overdensity for Halos => ') Ovlim =INPUT('Enter Overdensity Threshold for Halos => ') Amassl =INPUT('Enter Minimum halo mass in Msun/h => ') Rsearch1=INPUT('Enter comoving search radius(Mpc/h) => ') Rsearch2=INPUT('Enter smaller radius(Mpc/h) of final halos=> ') Rminhalo=INPUT('Enter min.radius for halos(Mpc/h) => ') Fract =INPUT('Enter fraction of DM particles (1/4,1/2,1)=> ') Fract =Min(Max(Fract,0.),1.0) Toohot =INPUT('Enter rejection velocity limit (V/Vescape)=> ') dRdubl =INPUT('Distance to check for Velocity duplicates => ') fVdubl =INPUT('Define duplicates if (v1-v2)/Vrms < ') Box =INPUT('Enter Comoving Box size(Mpc/h) => ') write (*,*) C ------------------------------------------ Open files Open( 2,file='Catshort.DAT') ! short list of halos Open( 3,file='SelSph.DAT',FORM='UNFORMATTED') ! short list of particles Open(20,file='Catalog.DAT') ! complete catalog with data for shells C ------------------------------------------ Read data CALL RDTAPE write (*,*) ' RDTAPE is done' write (*,*) ' Nnu=Number of Species=',Nspecies CALL SetWeights CALL ReadPnt(N,Fract) ! particles C CALL ReadMax(N,Fract) ! particles c Rsearch1=Rsearch1/AEXPN ! scale to proper distances c Rsearch2=Rsearch2/AEXPN c dRdubl =dRdubl /AEXPN Boxx =Box WRITE (2,100) HEADER, + AEXPN,AEXP0,AMPLT,ASTEP,ISTEP,PARTW, + EKIN,NROW,NGRID,Om0,Oml0,hubble WRITE (20,100) HEADER, + AEXPN,AEXP0,AMPLT,ASTEP,ISTEP,PARTW, + EKIN,NROW,NGRID,Om0,Oml0,hubble 100 FORMAT(1X,'Header=>',A45,/ + ' A=',F8.3,' A0=',F8.3,' Ampl=',F8.3,' Step=',F8.3,/ + ' I =',I4,' WEIGHT=',F8.3,' Ekin=',E12.3, + ' Nrow=',I4,' Ngrid=',I4,/' Omega_0=',f6.3, + ' Omega_L=',f6.3,' h=',f6.3) C ------------------------------------------ Constants --------- hsmall= hubble ! Hubble/100. Box = Box /hsmall ! Scale to real Mpc Omcold= Om0 Omhot = 0. Amassl= Amassl/hsmall ! Scale to real masses Radius= Rsearch1/hsmall ! Comoving Search radius in real Mpc Rminhalo=Rminhalo/hsmall dRdubl= dRdubl/hsmall Xscale= Box/Ngrid ! Scale for comoving coordinates Vscale= 100.*hsmall*Xscale/AEXPN ! Scale for velocities Dscale= 2.746e+11*hsmall**2*(Box/NROW)**3 ! mass scale C Dscale is a factor used to convert particles to mass C = mass of a particle for Omega=1 model C Xscale is a factor to convert PM coordinates into Mpc C = Box / Ngrid = length of a PM cell in Mpc C Vscale is a factor to convert PM pomenta to V (km/sec) C = the Hubble velocity at the distance of 1 PM cell C the factor AEXPN is needed to go from momenta to pec.velocity write (*,*) ' Vscale=',Vscale, ' X=',Xscale,' Box(Mpc)=',Box Radius=Radius/Xscale ! comoving radius in cell units RadSr1 =Rsearch1/hsmall/Xscale ! max Min search radii RadSr2 =Rsearch2/hsmall/Xscale Cell =1.0 ! Cell-size for Linker List in grid units Box =NGRID ! all internal variables are in Grid units Riter =0.0001 ! Error for iteration of radius in cell units Rmax =Radius ! Treat maxima Identical if dR',f5.1,'V_escape were removed') CALL SmallRem(ANlimit,Ncentr) ! Remove small halos c CALL CATALOG(Box,Ncentr) ! Remove duplicates C Final touch: if Rsearch1 and Rsearch2 are different C then improve position of halos by shrinking C the search Radius to Rsearch2 in Nit steps IF(ABS(Rsearch1-Rsearch2).gt.0.001*Rsearch1)Then Nit =5 hNit =(Rsearch1/Rsearch2)**(1./Nit) write (*,*) ' Nit =',Nit,' Factor:',hNit Do ii =1,Nit n1 = 0 r1 =0. Do i=1,Ncentr If(Rmc(i).gt.RadSr2)Then n1 =n1 +1 Rmc(i)=Rmc(i)/hNit r1 =r1 +Rmc(i) Endif Enddo write (*,*)'Iterate:', & ' Mean Comoving Radius for halos(Mpc/h)=', & r1/(max(n1,1))*Xscale*hsmall,' n=',n1 CALL Pairs(Box,N,Ncentr,Riter) EndDo Radius=Rsearch1 CALL CATALOG(Box,Ncentr) ! Remove duplicates EndIf write (*,20) N,Ncentr,Box*Xscale*hsmall,Ovlim,Fract write (2,20) N,Ncentr,Box*Xscale*hsmall,Ovlim,Fract write (20,20)N,Ncentr,Box*Xscale*hsmall,Ovlim,Fract 20 Format(5x,'Statistics for ',i9,' points. Maxima=',i6,/ . 5x,'Box(Mpc)=',f6.1, . 5x,'Overdensity Limit=',f6.1, . ' Fraction of DM particles=',f5.3) CALL SPairs(Box,N,Ncentr) ! Accumulate statistics C----------------------------- Auxiliary Settings nfalse =0 Do ir=1,Nrad ! all scaled to hubble, not h^(-1) Radsc(ir) =Rad(ir) *Xscale ! scale radii to comoving Mpc MnMass(ir)=Om0*4.188*2.746e+11*hubble**2*Radsc(ir)**3 c mass at the mean density EndDo write (*,12) (Radsc(i)*hsmall*1000.,i=1,Nrad) write (2,12) (Radsc(i)*hsmall*1000.,i=1,Nrad) write (20,12) (Radsc(i)*hsmall*1000.,i=1,Nrad) 12 Format(5x,'Radii of shells in comoving kpc/h:',/20(4x,10g10.3/)) C---------------------------- Process Halos : Undind, Dublicates CALL CLEAN(Ncentr,Xscale,Vscale,Dscale, + Fract,Radsc,MnMass,Toohot,Rminhalo) IF(fVdubl .gt.0. .and. dRdubl.gt.0.)Then ! Remove VelDublicates dRdubl =dRdubl/Xscale ! scale to cell units CALL RemVelDubl(Box,Ncentr,dRdubl,fVdubl,Xscale,Vscale) write (*,25) Ncentr,dRdubl*Xscale*hsmall ,fVdubl write (2,25) Ncentr,dRdubl*Xscale*hsmall ,fVdubl write (20,25)Ncentr,dRdubl*Xscale*hsmall ,fVdubl 25 Format(5x,'Number of centers=',i6, & 2x,'Velocity Duplicates: dR(Mpc/h)<',f6.3, & 2x,'dV/Vrms<',f6.3) ENDIF C---------------------------------- Find largest halo NpMax =0 inpMax =0 Do i=1,Ncentr write (*,*) ' halo=',i,NbcS(i,1),NbcS(i,2),NbcS(i,3) If(NbcS(i,2).gt. NpMax)Then inpMax =i NpMax =NbcS(i,2) EndIf EndDo If(inpMax.eq.0.or.NpMax.eq.0)Write (*,*) ' Errrror' Do i=1,Ncentr If(i.ne.inpMax) iRadius(i) =0 c If(NbcS(i,2).lt. NpMax-30) iRadius(i) =0 EndDo iRadius(inpMax) =Nrad C------------------------------- Print Results write ( 2,13) write (20,13) 13 Format(6x,'Coordinates Mpc',9x,'Velocity km/s',7x, & 'Mass Radius Vrms(3D) Vcirc Npart( C dublicates: keep only one (largest) halo C C Condition of proximity in velocity depends on how close are halos C in space. Halos with velocity difference dv =sqrt(vx_1-vx_2)^2 +(y)+ (z)), C at distance d one from the other, with mass ratio 1/1.5 < M1/M2 < 1.5 C and with internal velocity dispersions Vrms_1 and Vrms_2 C are considered too close ('dublicates') C if dv < fVdubl*max(Vrms_1,Vrms_2)*sqrt(6-5(d/dRdubl)^2) SUBROUTINE RemVelDubl(Box,Ncentr,dRdubl,fVdubl,Xscale,Vscale) C-------------------------------------------------------------- INCLUDE 'PMparameters.h' INCLUDE 'PMlists.h' Logical Lab(Nc) Real Mhalo,Mhalo2 dR2 = dRdubl**2 fV2 = fVdubl**2 Vol_2 =Rad(2)**3-Rad(1)**3 nrem= 0 Do i=1,Ncentr Lab(i) =.true. EndDo write (*,50) 50 format(5X,'<======== Remove fake halos ========>', & /17x,'difference in velocities dV is small as compared with', & /17x,'internal rms velocity Vrms', & ' and halos are close in space',/ & 4x,'dR(Mpc)',' dV(km/s)',' Vrms(km/s)', & ' N_part_halo_1',' N_part_halo_2', & ' dVx(km/s) dVy(km/s) dVz(km/s)') Do i=1,Ncentr-1 Mhalo =Amc(i) irad =Max(iRadius(i),2) Rh_1 =Rad(irad) Vrh2 =(Vrmc(i,irad)/Vscale)**2 If(Mhalo.eq.0. .or. irad.eq.0)Lab(i) =.false. If(Lab(i))Then Do j=i+1,Ncentr dd =(Xm(j)-Xm(i))**2 + . (Ym(j)-Ym(i))**2 + . (Zm(j)-Zm(i))**2 Mhalo2 =Amc(j) If(dd.lt.dR2.and.Mhalo2.gt.Mhalo/1.5)Then ! close distance pair If(Mhalo2.lt.Mhalo*1.5)Then ! close mass range jrad=Max(iRadius(j),2) Rh_2 =Rad(jrad) Rhh =MAX(Rh_1,Rh_2,1.e-8) dv =(Wxc(j,jrad)-Wxc(i,irad))**2 + . (Wyc(j,jrad)-Wyc(i,irad))**2 + . (Wzc(j,jrad)-Wzc(i,irad))**2 VV =MAX(Vrh2,(Vrmc(j,jrad)/Vscale)**2) ! max Vrms of the two c If(dv.lt.(6.-5.*dd/dR2)*fV2*VV)Then ! close in velocity If(dv.lt.(2.-dd/(dRdubl*Rhh))*fV2*VV)Then ! close in velocity If(Nbc(i,2).gt.Nbc(j,2))Then ! find if density at the distance idens =i ! between halos does not change more than idens_0 =j Else ! five times -- then this is dublicates idens_0 =i idens =j Endif dist =sqrt(dd) Do irr =1,Nrad If(dist.lt.rad(irr))Then idist =irr goto 300 Endif Enddo 300 irr=max(irr,2) rho_cent =(Nbc(idens_0,2)-Nbc(idens_0,1))/Vol_2 rho_dist =(Nbc(idens,irr)-Nbc(idens,irr-1))/ + (Rad(irr)**3-Rad(irr-1)**3) c write (*,31) sqrt(dd)*Xscale,sqrt(dv)*Vscale, c + sqrt(VV)*Vscale, c . Nbc(i,irad),Nbc(j,jrad), c . (Wxc(j,jrad)-Wxc(i,irad))*Vscale, c + (Wyc(j,jrad)-Wyc(i,irad))*Vscale, c + (Wzc(j,jrad)-Wzc(i,irad))*Vscale, c + rho_cent,rho_dist,irr,Nbc(idens_0,2), c + Nbc(idens,2),idens_0,idens IF(rho_dist.gt.rho_cent/100.)Then ! dublicates nrem = nrem +1 31 format(f10.4,f9.3,f11.2,2i14,3f10.3,2g11.3,i4,2i5,2i3) 30 format(f10.4,f9.3,f11.2,2i14,3f10.3,2g11.3,i4) c If(Mhalo.gt.Mhalo2)Then ! choose the biggest If(Nbc(i,2).gt.Nbc(j,2))Then ! choose the densiest Lab(j)=.false. c write (*,30) sqrt(dd)*Xscale,sqrt(dv)*Vscale, c + sqrt(VV)*Vscale, c . Nbc(i,irad),Nbc(j,jrad), c . (Wxc(j,jrad)-Wxc(i,irad))*Vscale, c + (Wyc(j,jrad)-Wyc(i,irad))*Vscale, c + (Wzc(j,jrad)-Wzc(i,irad))*Vscale, c + rho_cent,rho_dist,irr c + Xm(j)*Xscale,Ym(j)*Xscale,Zm(j)*Xscale Else Lab(i)=.false. c write (*,30) sqrt(dd)*Xscale,sqrt(dv)*Vscale, c + sqrt(VV)*Vscale, c . Nbc(i,irad),Nbc(j,jrad), c . (Wxc(j,jrad)-Wxc(i,irad))*Vscale, c + (Wyc(j,jrad)-Wyc(i,irad))*Vscale, c + (Wzc(j,jrad)-Wzc(i,irad))*Vscale, c + rho_cent,rho_dist,irr c + Xm(i)*Xscale,Ym(i)*Xscale,Zm(i)*Xscale EndIf EndIf EndIf EndIf EndIf EndDo EndIf EndDo m =0 meanmass =0 Do i=1,Ncentr If(Lab(i))Then m = m +1 Xm(m) =Xm(i) Ym(m) =Ym(i) Zm(m) =Zm(i) Amc(m) =Amc(i) Rmc(m) =Rmc(i) Vrm(m) =Vrm(i) iRadius(m) =iRadius(i) Do ir=1,Nrad ! Store Results Wxc(m,ir) =Wxc(i,ir) Wyc(m,ir) =Wyc(i,ir) Wzc(m,ir) =Wzc(i,ir) Nbc(m,ir) =Nbc(i,ir) NbcS(m,ir) =NbcS(i,ir) NbcM(m,ir) =NbcM(i,ir) NbcG(m,ir) =NbcG(i,ir) Rrc(m,ir) =Rrc(i,ir) Vrmc(m,ir) =Vrmc(i,ir) EndDo meanmass =meanmass +Nbc(m,Nrad) EndIf EndDo xmeanmass = FLOAT(meanmass)/FLOAT(m) write(*,10) m,Ncentr,xmeanmass write(20,10) m,Ncentr,xmeanmass write(*,20) dRdubl*Xscale*hubble,fVdubl 10 format(5x,'Vel.Dublicates: New number of objects=',i6,' Old=',i6, . ' mean N_particles=',g11.3) 20 format(' Distance Difference=',f8.4,/ . ' Vrelative/Vrms < ',f8.4) Ncentr =m Return End C-------------------------------- Update Statistics of pairs C SUBROUTINE SPairs(Box,N,Ncentr) C--------------------------------------------------- INCLUDE 'PMparameters.h' INCLUDE 'PMlists.h' DIMENSION Vx1(Nrad),Vy1(Nrad),Vz1(Nrad),Vxx(Nrad),Nob1(Nrad), . Rob1(Nrad),NobM(Nrad),NobG(Nrad),NobS(Nrad) Do i=1,Ncentr Do ir=1,Nrad Wxc(i,ir) = 0. Wyc(i,ir) = 0. Wzc(i,ir) = 0. Nbc(i,ir) = 0 NbcM(i,ir) = 0 NbcG(i,ir) = 0 Rrc(i,ir) = 0. Vrmc(i,ir)= 0. EndDo EndDo C.... Open_MP C$OMP PARALLEL DO DEFAULT(SHARED) C$OMP+PRIVATE (i,ir,Xc,Yc,Zc,Vx1,Vy1,Vz1,Nob1,NobS,NobM) C$OMP+PRIVATE (NobG,Rob1,Vxx ) Do i=1,Ncentr Xc =Xm(i) Yc =Ym(i) Zc =Zm(i) Call SNeib(Xc,Yc,Zc,Vx1,Vy1,Vz1,Nob1,NobS,NobM, & NobG,Rob1,Vxx ) Do ir=1,Nrad ! Store Results Wxc(i,ir) =Vx1(ir) Wyc(i,ir) =Vy1(ir) Wzc(i,ir) =Vz1(ir) Nbc(i,ir) =Nob1(ir) NbcS(i,ir) =NobS(ir) NbcM(i,ir) =NobM(ir) NbcG(i,ir) =NobG(ir) Rrc(i,ir) =Rob1(ir) Vrmc(i,ir)=Vxx(ir) EndDo EndDo Return End C-------------------------------- Remove small halos C C SUBROUTINE SmallRem(ANlimit,Ncentr) C-------------------------------------------------------------- INCLUDE 'PMparameters.h' INCLUDE 'PMlists.h' New =0 Do i=1,Ncentr If(Amc(i).GT.ANlimit)Then New =New +1 Xm(New) =Xm(i) Ym(New) =Ym(i) Zm(New) =Zm(i) Amc(New)=Amc(i) Rmc(New)=Rmc(i) EndIf EndDo Ncentr =New Return End C-------------------------------- Get Catalog of Halos C Remove close centers, keep only the largest C Emass - small difference in mass SUBROUTINE CATALOG(Box,Ncentr) C-------------------------------------------------------------- INCLUDE 'PMparameters.h' INCLUDE 'PMlists.h' Dimension Lab(Nc) New =0 Do i=1,Ncentr Lab(i) =1 EndDo Do i=1,Ncentr If(Rmc(i).lt.1.e-8)Lab(i)=0 Xc =Xm(i) Yc =Ym(i) Zc =Zm(i) a0 =Amc(i) Rh =Rmc(i) Do j=1,Ncentr If(i.ne.j)Then dd =((Xc-Xm(j))**2+(Yc-Ym(j))**2+(Zc-Zm(j))**2) IF(dd.lt.( (Rh+Rmc(j))/2. )**2 )Then If(a0.GT.Amc(j))Then! take largest of maxima Lab(j)=0 Else If(a0.lt.Amc(j))Then Lab(i)=0 Else ! equal masses -> take max(i,j) Lab(min(i,j)) =0 EndIf EndIf EndIf EndIf EndDo EndDo c icount =0 c Do i=1,Ncentr c icount =icount +Lab(i) c Enddo c write (*,*) ' Count=',icount c write (*,'(40i2)') (Lab(i),i=1,Ncentr) c STOP C Remove maxima with Label =0 Do i=1,Ncentr If(Lab(i).eq.1)Then New =New +1 Xm(New) =Xm(i) Ym(New) =Ym(i) Zm(New) =Zm(i) Amc(New)=Amc(i) Rmc(New)=Rmc(i) Vrm(New)=Vrm(i) Wxc(New,1)=Wxc(i,1) Wyc(New,1)=Wyc(i,1) Wzc(New,1)=Wzc(i,1) EndIf EndDo Ncentr =New Return End C--------------------------------------------------------- C Select particles c as initial seeds of centers SUBROUTINE ReadCent(N,Ncentr,Boxx) C-------------------------------------------------------------- INCLUDE 'PMparameters.h' INCLUDE 'PMlists.h' Real INPUT Logical Ldiff Xccc =INPUT(' Center x=') write (*,*) Xccc Yccc =INPUT(' Center y=') write (*,*) Yccc Zccc =INPUT(' Center z=') write (*,*) Zccc Rccc =INPUT(' Center r=') write (*,*) Rccc Xccc =Xccc/Boxx*NGRID Yccc =Yccc/Boxx*NGRID Zccc =Zccc/Boxx*NGRID Rccc =Rccc/Boxx*NGRID Ncentr =0 Iweigh_first =iWeight(1) Iweigh_last =iWeight(N) Iweigh_min = Iweigh_first write (*,*) ' Weights: first species=',Iweigh_first, & ' last=',Iweigh_last,' Weight minimum center=',Iweigh_min If(RadSr1.lt.1.1*RadSr2.or.ABS(RadSr2).lt.1.e-8)Then ! there is only one radius Ldiff =.false. Radius = RadSr1 Else Ldiff =.true. R1 = 1.1*RadSr2 R2 = 0.9*RadSr1 Rhalf =(RadSr1+RadSr2)/2. n1 = 0 nhalf = 0 n2 = 0 ialpha =3 RRs = (RadSr1-RadSr2) write(*,*) ' Min Radius=',RadSr2,' Max=',RadSr1 write(*,*) ' Power index =',ialpha Endif Nline=INPUT(' Number of particles for initial seeds= ') jneib=INPUT(' Number of neibhours for a seed= ') If(Nline.eq.0)Return fr = N/FLOAT(Nline) xrand =1.00001 Nstep =MAX(INT(fr+1.),1) fr =1./fr Nseed = 121071 write (*,*) ' Every ',Nstep,' particle is used', & ' as initial center',' Fraction=',fr Nplast =0 Do i=1,N ! take centers if weight is less than Iweigh_min If( iWeight(i).le.Iweigh_min)Then Nplast =Nplast +1 Endif Enddo write (*,*) ' Total pool for particles centers=',Nplast C Do i=1,N,Nstep Do i=1,Nplast If(fr.lt.0.999)xrand =RANDd(Nseed) IF(xrand.lt.fr)Then IF(ABS(Xp(i)-Xccc).lt.Rccc.and. . ABS(Yp(i)-Yccc).lt.Rccc.and. . ABS(Zp(i)-Zccc).lt.Rccc)THEN Ncentr =Ncentr+1 IF(Ldiff)Then ! different radii Rrrr =RadSr2+ & RRs*(MAX(RANDd(Nseed),1.e-8))**ialpha Rmc(Ncentr) = Rrrr If(Rrrr.lt.R1)n1 = n1+1 If(Rrrr.lt.Rhalf)nhalf = nhalf+1 If(Rrrr.gt.R2)n2 = n2+1 Else Rmc(Ncentr) =Radius Endif Amc(Ncentr) =1. c Rmc(Ncentr) =1. Xm(Ncentr) =Xp(i) Ym(Ncentr) =Yp(i) Zm(Ncentr) =Zp(i) j=Ncentr EndIf ! endif for small box test EndIf EndDo write (*,*) ' Ncenters=',Ncentr If(jneib.eq.0)goto 150 ! No more points Imax =MIN(INT(NGRID/Cell),Nb) write (*,*) ' Size of Grid centers=',Imax,Cell,NGRID Do k=0,Imax Do j=0,Imax Do i=0,Imax jp =Label(i,j,k) Ncount =0 jcount =0 10 jcount= jcount+1 If(jp.ne.0.and.jcount.lt.jneib)Then jp=Lst(jp) ! find if there are enough neib goto 10 endif jcount =0 If(jp.ne.0.and.iWeight(jp).le.Iweigh_min)Then Ncount =Ncount +1 IF(ABS(Xp(jp)-Xccc).lt.Rccc.and. . ABS(Yp(jp)-Yccc).lt.Rccc.and. . ABS(Zp(jp)-Zccc).lt.Rccc)THEN Ncentr=Ncentr+1 If(Ncentr.le.Nc)Then IF(Ldiff)Then ! different radii Rrrr =RadSr2+ & RRs*(MAX(RANDd(Nseed),1.e-8))**ialpha Rmc(Ncentr) = Rrrr If(Rrrr.lt.R1)n1 = n1+1 If(Rrrr.lt.Rhalf)nhalf = nhalf+1 If(Rrrr.gt.R2)n2 = n2+1 Else Rmc(Ncentr) =Radius Endif Amc(Ncentr) =1. Xm(Ncentr) =Xp(jp) Ym(Ncentr) =Yp(jp) Zm(Ncentr) =Zp(jp) EndIf EndIf ! endif for small-box test c write (*,*) ' Count=',Ncount,i,j,k,Ncentr If(Ncount.lt.3) Goto 10 EndIf EndDo EndDo EndDo 150 write(*,*) ' Ncentr=',Ncentr,' Max=',Nc If(Ncentr.gt.Nc)Then write (*,*) ' Too many centers' pause Endif If(Ncentr.gt.0)Then write (*,200) RadSR2,R1,n1,Rhalf,nhalf,R2,RadSR1,n2 write (2,200) RadSR2,R1,n1,Rhalf,nhalf,R2,RadSR1,n2 write (20,200) RadSR2,R1,n1,Rhalf,nhalf,R2,RadSR1,n2 200 format(' Number of centers with radii between ',3x,2f7.4, & ' was ',i6, & /18x,' with radius less than ',f7.4,7x,' was ',i6, & /18x,' with radii between ',3x,2f7.4,' was ',i6) Endif Return End C--------------------------------------------------------- C Read list of maxima c Xnew =X-1: coord. now are 0-NGRID SUBROUTINE ReadMax(N,Xscale) C-------------------------------------------------------------- INCLUDE 'PMparameters.h' INCLUDE 'PMlists.h' read(3) + AEXPN,AEXP0,AMPLT,ASTEP,ISTEP,PARTW, + EKIN, + NROWC,NGRIDC,NREC0,Om0,Oml0,hubble, + Ocurv write(*,200) + AEXPN,AEXP0,AMPLT,ASTEP,ISTEP,PARTW, + EKIN, + NROWC,NGRIDC,NREC0,Om0,Oml0,hubble, + Ocurv 200 FORMAT( + 1X,' A=',F8.3,' A0=',F8.3,' Ampl=',F8.3,' Step=',F8.3,/ + 1X,' I =',I4,' WEIGHT=',F8.3,' Ekin=',E12.3,/ + 1X,' Nrow=',I4,' Ngrid=',I4,' Nrecl=',I6,/ + 1x,' Omega_0=',F7.3,' OmLam_0=',F7.4,' Hubble=',f7.3,/ + 1x,' Omega_curvature=',F7.3) N =0 xxm =1000. xxn =-1000. 10 read (3,err=5,end=5) X0, Y0, Z0, VvX,VvY,VvZ N=N+1 If(N.le.Np)Then Xp(N) =X0-1. Yp(N) =Y0-1. Zp(N) =Z0-1. VXp(N)=VvX VYp(N)=VvY VZp(N)=VvZ xxm =min(xxm,Xp(N)) xxn =max(xxn,Xp(N)) EndIf GoTo 10 5 write(*,*) ' Read Particles: X{Min,Max}=',xxm,xxn,' N=',N If(N.GT.Np)Then write (*,*) ' Too many particles: Max=',Np Stop EndIf Return End C--------------------------------------------------------- C Read particles SUBROUTINE ReadPnt(N,Fract) C-------------------------------------------------------------- INCLUDE 'PMparameters.h' INCLUDE 'PMlists.h' N =0 Iz=1 Iy=1 Ff=1. If(Fract.le.0.666)Then Iz=2 Ff=0.5 If(Fract.le.0.333)Then Iy=2 Ff=0.25 Endif EndIf Fract =Ff If(Nspecies.eq.0)Then ! old case: 1 complete set Npages =NROW ! Number of pages N_in_last=NPAGE ! Number of particles in last page Else ! multiple masses N_particles =lspecies(Nspecies) ! Total number of particles Npages = (N_particles -1)/NPAGE +1 N_in_last=N_particles -NPAGE*(Npages-1) EndIf c write (*,*) ' Pages=',Npages,' Species=',Nspecies c write (*,*) ' N_in_last=',N_in_last DO IROW=1, Npages,Iz ! Loop over particle pages In_page =NPAGE If(IROW.eq.Npages)In_page =N_in_last iL = NPAGE*(IROW-1) C Loop over particles READ (21,REC=IROW) RECDAT DO IN=1,In_page,Iy N = N +1 Xp(N) =XPAR(IN)-1. Yp(N) =YPAR(IN)-1. Zp(N) =ZPAR(IN)-1. VXp(N)=VX(IN) VYp(N)=VY(IN) VZp(N)=VZ(IN) Ipart =IN+iL ! current particle number iWeight(N) =iWeight(Ipart) ! particles weight ENDDO ENDDO Return End C--------------------------------------------------- C Remove Unbound particles, find radius and mass C No removal of unbound particles If: C Toohot =< 0 or Toohot =>5 C Vscale =100.*hsmall*Xscale/AEXPN C Xscale=Box/Ngrid C Dscale=2.75e+11*hsmall**2*(Box/NROW)**3 SUBROUTINE CLEAN(Ncentr,Xscale,Vscale,Dscale, + Fract,Radsc,MnMass,Toohot,Rminhalo) C-------------------------------------------------------------- INCLUDE 'PMparameters.h' INCLUDE 'PMlists.h' dimension Mass(Nrad),MnMass(Nrad),Overdens(Nrad),Radsc(Nrad) Real Mass,MnMass,Mhalo C.... Open_MP C$OMP PARALLEL DO DEFAULT(SHARED) C$OMP+PRIVATE (i,ir,iter,Xc,Yc,Zc,Summass,Mass,Overdens) C$OMP+PRIVATE (irad,Mhalo,Rhalo,Vmaxrot,Rmaxrot,Vcirc,Vcc) C$OMP+PRIVATE (NobG,Rob1,Vxx ) Do i=1,Ncentr Xc =Xm(i) *Xscale ! Scale all to physical units: comoving Yc =Ym(i) *Xscale Zc =Zm(i) *Xscale Do ir =1,Nrad Vrmc(i,ir)=Vrmc(i,ir) *Vscale ! Scale to km/s Summass = Om0*Nbc(i,ir)/Fract Mass(ir) = Dscale*Summass Overdens(ir)= Mass(ir)/MnMass(ir) EndDo C find size, mass, rad ... for a halo Call Decide(Mass,Radsc,Overdens,Nrad,irad,Mhalo,Rhalo, + Vmaxrot,Rmaxrot ) Vcirc=sqrt(Vmaxrot/AEXPN)*6.58e-5 ! =10^-5*sqrt(G 2e33/3.08e24) c If(Vcirc.gt.100.)write (*,'(i3,3f8.3,f7.2,i3,2g11.3)') c & i,Xc*0.7,Yc*0.7,Zc*0.7,Vcirc,irad,Mhalo,Rhalo c If(Vcirc.gt.100.)write (*,'(10g11.3)') (Mass(ir),ir=1,Nrad) If(Toohot.gt.0. .and. Toohot.lt.15.)Then Do iter =0,4 ! Remove High Energy particles from halos If(irad .ge.1 .and. Rhalo.gt.Rminhalo)Then Vcc =Vcirc/Vscale ! back to dimensionless units Vmaxrot=Vcc*Toohot*1.1**(4-iter) ! Increase the Rotatioanl Vel. Call RemEng(i,Vmaxrot,Rmaxrot/Xscale) ! Remove Unbound Particles Do ir =1,Nrad Vrmc(i,ir)=Vrmc(i,ir) *Vscale Summass =Om0*Nbc(i,ir)/Fract Mass(ir) = Dscale*Summass Overdens(ir)=Mass(ir)/MnMass(ir) EndDo Call Decide(Mass,Radsc,Overdens,Nrad,irad,Mhalo,Rhalo, + Vmaxrot,Rmaxrot) Vcirc=sqrt(Vmaxrot/AEXPN)*6.58e-5 !=10^-5*sqrt(2e33/3.08e24) c If(Vcirc.gt.100.)write (*,'(5x,f7.2,i3,2g11.3)') c & Vcirc,irad,Mhalo,Rhalo EndIf EndDo ! end iter energy EndIf Amc(i) =Mhalo ! store results Rmc(i) = Rhalo ! Rmaxrot Vrm(i) =Vcirc iRadius(i) =irad c write (*,*) ' ',Mhalo,Rhalo,Vcirc,irad Enddo ! end i (Ncentr) Return End C------------------------------------------------------------- C Find halo radius and mass SUBROUTINE Decide(Mass,Rad,Overdens,Nrad,irad,Mhalo,Rhalo, + Vmaxrot,Rmaxrot ) C-------------------------------------------------------------- COMMON /OVER/ Ovlim,Ovcnt Real Rad(Nrad),Overdens(Nrad),Mass(Nrad),Mhalo DATA slope/0.999/ Vmaxrot =0 Rmaxrot =0. Mhalo=0. Rhalo=0. If(MAX(Overdens(1),Overdens(2)).LT.Ovcnt)Then irad =0 ! max overdensity is less then Ovcnt RETURN EndIf iov =0 Do ir=Nrad,1,-1 If(Overdens(ir).gt.Ovlim .and. iov.eq.0)Then iov =ir EndIf EndDo If(iov.eq.0)Then irad =0 ! max overdensity is less then Ovlim RETURN EndIf iovv =0 Do ir=1,iov irleft =max(ir-1,1) irr1 =min(ir+1,Nrad) irr2 =min(ir+2,Nrad) Overright =(Overdens(irr1)+Overdens(irr2))/2. Overleft =(Overdens(ir)+Overdens(irleft))/2. If(Overright.gt.0.97*Overleft)Then !stop:rising profile If(ir.eq.1)Then ! softer conditions for the first bin If(Overright.gt.1.2*Overleft)Then iovv =ir goto 20 EndIf else iovv =ir goto 20 EndIf EndIf EndDo 20 If(iovv.ne.0)iov =iovv irad =iov 30 irleft =max(irad-2,1) ! check if overdens is steep irright =min(irad+1,Nrad) gradlf =Overdens(irleft) * (Rad(irleft))**slope gradrt =Overdens(irright)* (Rad(irright))**slope If(gradlf.lt.gradrt)Then ! not a steep gradient irad =irad -1 ! reduce radius iovv =irad If(irad.eq.0)Then ! zero radius -> quit RETURN Else goto 30 ! iterate EndIf EndIf If(irad.lt.Nrad)Then ! interpolate to Overlim If(Ovlim.gt.Overdens(irad+1) .and. . Overdens(irad).gt.Ovlim)Then Mhalo=(Mass(irad)*(Ovlim-Overdens(irad+1))+ . Mass(irad+1)*(Overdens(irad)-Ovlim)) / . (Overdens(irad)-Overdens(irad+1)) Rhalo=(Rad(irad)*(Ovlim-Overdens(irad+1))+ . Rad(irad+1)*(Overdens(irad)-Ovlim)) / . (Overdens(irad)-Overdens(irad+1)) Else ! Overdens is > Overlim Mhalo =Mass(irad) Rhalo =Rad(irad) EndIf Else ! Overdens is > Overlim Mhalo =Mass(irad) Rhalo =Rad(irad) EndIf Do ir =1,irad ! find max rotational velocity V2 = Mass(ir)/Rad(ir) If (V2.gt.Vmaxrot)Then Vmaxrot =V2 Rmaxrot =Rad(ir) EndIf EndDo Return End C------------------------------------------------ C Remove unbound particles for i-th halo C irad = radius of the halo C Vmaxrot = max rotational Velocity C Rmaxrot = radius at max rot.velocity SUBROUTINE RemEng(i,Vmaxrot,Rmaxrot) C----------------------------------------------- INCLUDE 'PMparameters.h' INCLUDE 'PMlists.h' DIMENSION VXxc(Nrad), VYyc(Nrad), VZzc(Nrad), & Vescape2(Nrad) DIMENSION Vx1(Nrad),Vy1(Nrad),Vz1(Nrad),Vxx(Nrad),Nob1(Nrad), . Rob1(Nrad),NobM(Nrad),NobG(Nrad),NobS(Nrad) DIMENSION Vrad0(Nrad),Vrad2(Nrad),Nob2(Nrad) Xc =Xm(i) ! store center of mass and velocity Yc =Ym(i) Zc =Zm(i) Do ir =1,Nrad ! store mean velocity VXxc(ir) =Wxc(i,ir) VYyc(ir) =Wyc(i,ir) VZzc(ir) =Wzc(i,ir) ! escape velocity for NFW profile Vescape2(ir) = (2.15*Vmaxrot)**2 * & log(1.0+2.*Rad(ir)/Rmaxrot)/(Rad(ir)/Rmaxrot) Wxc(i,ir) = 0. Wyc(i,ir) = 0. Wzc(i,ir) = 0. Nbc(i,ir) = 0 NbcM(i,ir) = 0 NbcG(i,ir) = 0 Rrc(i,ir) = 0. Vrmc(i,ir)= 0. Nrad0(i,ir)= 0 Wrad0(i,ir)= 0. Wrad2(i,ir)= 0. EndDo Call SrejNeib(VXxc,VYyc,VZzc,Xc,Yc,Zc,Vescape2, & Vx1,Vy1,Vz1,Nob1,NobS,NobM,NobG,Rob1,Vxx, & Vrad0,Vrad2,Nob2 ) Do ir=1,Nrad ! Store Results Wxc(i,ir) =Vx1(ir) Wyc(i,ir) =Vy1(ir) Wzc(i,ir) =Vz1(ir) Nbc(i,ir) =Nob1(ir) NbcS(i,ir) =NobS(ir) NbcM(i,ir) =NobM(ir) NbcG(i,ir) =NobG(ir) Rrc(i,ir) =Rob1(ir) Vrmc(i,ir)=Vxx(ir) Nrad0(i,ir)=Nob2(ir) Wrad0(i,ir)=Vrad0(ir) Wrad2(i,ir)=Vrad2(ir) EndDo Return End C-------------------------------------------------------------- C Accumilate statistics only C if relative velocity is not large C Xc,Yc,Zc - center; C SUBROUTINE SrejNeib(VXxc,VYyc,VZzc,Xc,Yc,Zc,Vescape2, & Vx1,Vy1,Vz1,Nob1,NobS,NobM,NobG,Rob1,Vxx, & Vrad0,Vrad2,Nob2 ) C-------------------------------------------------------------- INCLUDE 'PMparameters.h' INCLUDE 'PMlists.h' DIMENSION VXxc(Nrad), VYyc(Nrad), VZzc(Nrad),Vescape2(Nrad) DIMENSION Vx1(Nrad),Vy1(Nrad),Vz1(Nrad),Vxx(Nrad),Nob1(Nrad), . Rob1(Nrad),NobM(Nrad),NobG(Nrad),NobS(Nrad) DIMENSION Vrad0(Nrad),Vrad2(Nrad),Nob2(Nrad) Radmax =Rad(Nrad) alph =Rad(1)**2 Do i=1,Nrad Nob1(i) =0 NobS(i) =0 NobM(i) =0 NobG(i) =0 Rob1(i) =0. Vx1(i) =0. Vy1(i) =0. Vz1(i) =0. Vxx(i) =0. Nob2(i) =0. Vrad0(i) =0. Vrad2(i) =0. EndDo c limits for Label i1=INT((Xc-Radmax)/Cell) j1=INT((Yc-Radmax)/Cell) k1=INT((Zc-Radmax)/Cell) i1=MIN(MAX(Nm,i1),Nb) j1=MIN(MAX(Nm,j1),Nb) k1=MIN(MAX(Nm,k1),Nb) i2=INT((Xc+Radmax)/Cell) j2=INT((Yc+Radmax)/Cell) k2=INT((Zc+Radmax)/Cell) i2=MIN(MAX(Nm,i2),Nb) j2=MIN(MAX(Nm,j2),Nb) k2=MIN(MAX(Nm,k2),Nb) C Look for neibhours Do k=k1,k2 Do j=j1,j2 Do i=i1,i2 jp =Label(i,j,k) ! Dark matter 10 If(jp.ne.0)Then dd =(Xc-Xp(jp))**2+(Yc-Yp(jp))**2+(Zc-Zp(jp))**2 If(dd.lt.Rad2(Nrad))Then c iov =max(1,INT(4.*sqrt(sqrt(dd/alph)) ) -2) iov =0 Do ir =1,Nrad ! find bin If(dd.le.Rad2(ir))Then iov =ir goto 30 EndIf EndDo 30 If(iov.eq. 0)Then ! error write (*,*) ' Error SrejNeib: iov =',iov,' d=',sqrt(dd) Stop EndIf dv = (VXxc(iov)-VXp(jp))**2+ + (VYyc(iov)-VYp(jp))**2+ + (VZzc(iov)-VZp(jp))**2 If(dv .lt. Vescape2(iov))Then iww =iWeight(jp) Nob2(iov) = Nob2(iov) + iww drad = sqrt(dd) vv = VXp(jp)**2+VYp(jp)**2+VZp(jp)**2 vrad = -( (VXp(jp) -VXxc(2))*(Xc-Xp(jp)) + & (VYp(jp) -VYyc(2))*(Yc-Yp(jp)) + & (VZp(jp) -VZzc(2))*(Zc-Zp(jp)) ) / & drad Vrad0(iov) =Vrad0(iov) + iww*vrad Vrad2(iov) =Vrad2(iov) + iww*vrad**2 Do ir =iov,Nrad ! Nrad c If(dd.lt.Rad2(ir))Then Nob1(ir)= Nob1(ir)+ iww If(iww.eq.iWeight(1))NobS(ir)= NobS(ir)+ 1 If(iww.eq.8*iWeight(1))NobM(ir)= NobM(ir)+ 1 If(iww.eq.64*iWeight(1))NobG(ir)= NobG(ir)+ 1 Rob1(ir)= Rob1(ir)+ drad*iww Vxx(ir) = Vxx(ir) + + iww*vv Vx1(ir) = Vx1(ir) +iww*VXp(jp) Vy1(ir) = Vy1(ir) +iww*VYp(jp) Vz1(ir) = Vz1(ir) +iww*VZp(jp) c EndIf EndDo EndIf EndIf jp =Lst(jp) GoTo10 EndIf EndDo EndDo EndDo Do ir=1,Nrad Vmn =0. If(Nob1(ir).GT.0)Then Nobj =Nob1(ir) Vx1(ir) = Vx1(ir)/Nobj Vy1(ir) = Vy1(ir)/Nobj Vz1(ir) = Vz1(ir)/Nobj Vmn = Vx1(ir)**2+Vy1(ir)**2+Vz1(ir)**2 Vxx(ir) = SQRT(ABS(Vxx(ir)/Nobj -Vmn)) EndIf If(Nob2(ir).GT.0)Then Vrad0(ir) =Vrad0(ir)/Nob2(ir) Vrad2(ir) =SQRT(Vrad2(ir)/Nob2(ir)-Vrad0(ir)**2) EndIf EndDo Return End C-------------------------------------------------- C Set Weights of particles for C fast access SUBROUTINE SetWeights C-------------------------------------------------- INCLUDE 'PMparameters.h' Wpr =NGRID**3/FLOAT(NROW**3) If(Nspecies.eq.0)Then ! old constant weights N_particles =lspecies(1) Ww = wspecies(1)/Wpr Do i=1,N_particles iWeight(i) =Ww EndDo Else N_particles =lspecies(Nspecies) jstart =1 write (*,*) ' N_Particles=',N_particles If(N_particles.le.0)Then write (*,*) ' Wrong number of particles:',N_particles write (*,*) ' Nspecies=',Nspecies,' N=',lspecies STop endif Do j=1,Nspecies jend =lspecies(j) Do k=jstart ,jend iWeight(k) =wspecies(j)/Wpr EndDo jstart =jend EndDo EndIf write (*,*) ' Set Weights for ',N_particles,' particles:', & ' w_first=' ,iWeight(1),' w_last=', iWeight(N_particles) write (*,*) ' Nspecies=',Nspecies,' Weights=',wspecies(1), & wspecies(2), wspecies(3) RETURN END