[cig-commits] r5899 - in geodyn/3D/MoSST: branches branches/test-mosst branches/test-mosst/mosst-data branches/test-mosst/mosst-data/fftw_v10 branches/test-mosst/mosst-dynamo branches/test-mosst/mosst-lib trunk/mosst-lib

wei at geodynamics.org wei at geodynamics.org
Thu Jan 25 15:52:27 PST 2007


Author: wei
Date: 2007-01-25 15:52:27 -0800 (Thu, 25 Jan 2007)
New Revision: 5899

Added:
   geodyn/3D/MoSST/branches/test-mosst/
   geodyn/3D/MoSST/branches/test-mosst/mosst-data/fftw_v10/
   geodyn/3D/MoSST/branches/test-mosst/mosst-data/fftw_v10/record.1001
   geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/
   geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/Makefile
   geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/bcs.f
   geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/parameter.data
   geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/run_v10
Removed:
   geodyn/3D/MoSST/branches/test-mosst/mosst-data/fftw_v10/
   geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/
   geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/bcs.f
   geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/parameter.data
   geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/run_v10
Modified:
   geodyn/3D/MoSST/branches/test-mosst/mosst-lib/makefile
   geodyn/3D/MoSST/trunk/mosst-lib/makefile
Log:
create a branch for mosst testing

Copied: geodyn/3D/MoSST/branches/test-mosst (from rev 5266, geodyn/3D/MoSST/trunk)

Copied: geodyn/3D/MoSST/branches/test-mosst/mosst-data/fftw_v10 (from rev 5385, geodyn/3D/MoSST/trunk/mosst-data/fftw_v10)

Copied: geodyn/3D/MoSST/branches/test-mosst/mosst-data/fftw_v10/record.1001 (from rev 5748, geodyn/3D/MoSST/trunk/mosst-data/fftw_v10/record.1001)

Copied: geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo (from rev 5385, geodyn/3D/MoSST/trunk/mosst-dynamo)

Copied: geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/Makefile (from rev 5448, geodyn/3D/MoSST/trunk/mosst-dynamo/Makefile)

Deleted: geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/bcs.f
===================================================================
--- geodyn/3D/MoSST/trunk/mosst-dynamo/bcs.f	2006-11-30 05:11:10 UTC (rev 5385)
+++ geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/bcs.f	2007-01-25 23:52:27 UTC (rev 5899)
@@ -1,292 +0,0 @@
-c
-c	These group of subroutines provide inhomogeneous boundary
-c	conditions arising from finitely conducting D"-layer and
-c	from CMB topography.
-c	The subroutines are running on Sun worksations with Sun
-c	Performance Library.
-c	W.Kuang 08/99
-c
-
-*************************************************************************
-*************************************************************************
-
-	subroutine bd_mag(boundi,boundm)
-ccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccc
-c
-c	This subroutine evaluates the boundary conditions at the inner
-c	core boundary and the core-mantle boundary with given fields
-c	(OMGI,OMGM,COUA,COUB,COVA,COVB,COB)
-c
-c-----------------------------------------------------------------------
-c	
-c	Notation explanation:
-c
-c		(sb,dsv,sw): the spectral coefficients at radial
-c			collocation points r_i;
-c		(vth,vph): the velocity components in physical space;
-c		(br): the radial magnetic field in physical space;
-c
-c		(boundi): the boundary conditions at r_{io};
-c		(boundm): the boundary conditions at r = 1;
-c
-ccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccccc
-	use mod_dimparam
-	use mod_sysparam
-	use mod_optparam
-
-	use mod_parity
-	use mod_radgeom
-	use mod_sphgeom
-
-	use mod_vfield
-	use mod_bfield
-	use mod_rotation
-
-	implicit none
-
-	complex (kind=8), dimension(0:Lmax_m,0:mmax_m) :: boundi,boundm
-
-	integer	i,j,k,L,m,n
-	real (kind=8) c1,c2
-	complex (kind=8) zi1,zi2,zi3,zi4,ui,uim,zeros
-
-	real (kind=8), dimension(npmax,ntmax) :: br,bth,bph,vth,vph,
-     &		tmpr1,tmpr2
-
-	complex (kind=8), dimension(0:Lmax1,0:mmax)  :: dsv,sw,sb
-	complex (kind=8), dimension(0:Lmaxa,0:mmaxa) :: tmpc1,
-     &		tmpc2,tmpc3
-
-C
-C	SUBROUTINE STARTS HERE
-C
-
-	ui	= cmplx(0.0,1.0)
-	zeros	= cmplx(0.0,0.0)
-
-C
-C-------Initializing the boundary conditions and the velocity fields
-C
-
-	boundi	= zeros
-	boundm	= zeros
-
-	if (kicbv.eq.1 .and. kcmbv.eq.1) then
-	   return
-	endif
-
-	if (kicbb.le.1 .and. kcmbb.le.1) then
-	   return
-	endif
-
-	call group
-
-C
-C-------Spectral coefficients of horizontal velocities in
-C-------the inner core (zi1,zi2,zi3,zi4)
-C
-
-	zi1	= -ui*rio**2*sqrt(2.0*pi/3.0)*conjg(omgih)
-	zi2	= rio**2*sqrt(2.0*pi/15.0)*conjg(omgih)
-	zi3	= 4.0*rio**2*sqrt(pi)*omgiz/3.0
-	zi4	= -4.0*rio**2*sqrt(pi/5.0)*omgiz/3.0
-
-C
-C-------The boundary conditions at the ICB
-C
-
-	if (kicbb.eq.2 .and. kicbv.ne.1) then
- 
-c	   obtaining (b_l^m,dv_l^m/dr,w_l^m) at r=r_io
-
-	   sb	= zeros
-	   dsv	= zeros
-	   sw	= zeros
-
-	   do L	= 1,Lmax_m
-	      sb(L,0) = 0.5*(cob(nmbic-1,L,0)+cob(nmbic+1,L,0))
-	   enddo
-	   do m	= 1,mmax_m
-	      do L = m,Lmax_m
-	         sb(L,m) = 0.5*(cob(nmbic-1,L,m)+cob(nmbic+1,L,m))
-	      enddo
-	   enddo
-
-	   do n	= 0,nmax_v
-	      do L = 1,Lmax_v
-	         dsv(L,0) = dsv(L,0)+dch1(n,0)*vlm(n,L,0)
-	         sw(L,0)  = sw(L,0)+cheb(n,0)*wlm(n,L,0)
-	      enddo
-	      do m = 1,mmax_v
-	         do L = m,Lmax_v
-	            dsv(L,m) = dsv(L,m)+dch1(n,0)*vlm(n,L,m)
-	            sw(L,m)  = sw(L,m)+cheb(n,0)*wlm(n,L,m)
-	         enddo
-	      enddo
-	   enddo
-	      
-c	   obtaining {r^2b_r, r sin(th) [v_th], r sin(th) [v_ph]}
-
-	   tmpc1= zeros
-	   do m	= 0,mmax
-	      tmpc1(m:Lmax,m) = LL(m:Lmax)*sb(m:Lmax,m)
-	   enddo
-
-           call izfspht(tmpc1,aslg,table,Lmaxa,mmaxa,ntmax,
-     &                  npmax,br)
-
-	   tmpc1= zeros
-	   tmpc2= zeros
-	   do m	= 0,mmax
-	      uim = cmplx(0.0,1.0*m)
-	      do L= m+1,Lmax
-	         tmpc1(L,m) = uim*sw(L,m)+clm(L,m,1)*dsv(L-1,m)
-     &                        -clm(L,m,2)*dsv(L+1,m)
-	         tmpc2(L,m) = uim*dsv(L,m)-clm(L,m,1)*sw(L-1,m)
-     &                        +clm(L,m,2)*sw(L+1,m)
-	      enddo
-	      tmpc1(m,m) = uim*sw(m,m)-clm(m,m,2)*dsv(m+1,m)
-	      tmpc2(m,m) = uim*dsv(m,m)+clm(m,m,2)*sw(m+1,m)
-	   enddo
-	   tmpc1(1,1) = tmpc1(1,1)-zi1
-	   tmpc2(2,1) = tmpc2(2,1)-zi2
-	   tmpc2(0,0) = tmpc2(0,0)-zi3
-	   tmpc2(2,0) = tmpc2(2,0)-zi4
-
-           call izfspht(tmpc1,aslg,table,Lmaxa,mmaxa,ntmax,
-     &                  npmax,vth)
-           call izfspht(tmpc2,aslg,table,Lmaxa,mmaxa,ntmax,
-     &                  npmax,vph)
-
-c	   evaluating the inhomogeneous boundary conditions at r=r_io
-
-	   do k	= 1,ntmax
-	      c1= 1.0/(rio*sins(k))**2
-	      tmpr1(:,k) = c1*br(:,k)*vth(:,k)
-	      tmpr2(:,k) = c1*br(:,k)*vph(:,k)
-	   enddo
-           call zfspht(tmpr1,aslg,gauwt,table,Lmaxa,mmaxa,ntmax,
-     &                 npmax,tmpc1)
-           call zfspht(tmpr2,aslg,gauwt,table,Lmaxa,mmaxa,ntmax,
-     &                 npmax,tmpc2)
-
-	   tmpc3= zeros
-	   do m = 0,mmax
-              uim = cmplx(0.0,1.0*m)
-              do L= m+1,Lmax
-                 tmpc3(L,m) = uim*tmpc1(L,m)-clm(L,m,3)*
-     &                     tmpc2(L-1,m)+clm(L,m,4)*tmpc2(L+1,m)
-              enddo
-              tmpc3(m,m) = uim*tmpc1(m,m)+clm(m,m,4)*tmpc2(m+1,m)
-           enddo
-	   do L	= 1,Lmax_m
-	      boundi(L,0) = tmpc3(L,0)/(1.0*LL(L))
-	   enddo
-	   do m	= 1,mmax_m
-	      do L = m,Lmax_m
-	         boundi(L,m) = tmpc3(L,m)/(1.0*LL(L))
-	      enddo
-	   enddo
-
-	endif
-
-C
-C-------The boundary conditions at the CMB
-C
-
-	if (kcmbb.eq.2 .and. kcmbv.ne.1) then
-
-c	   obtaining (b_l^m,dv_l^m/dr,w_l^m) at r=1
-
-	   sb	= zeros
-	   dsv	= zeros
-	   sw	= zeros
-
-	   do L	= 1,Lmax_m
-	      sb(L,0) = cob(nmx3+nmbic-1,L,0)
-	   enddo
-	   do m	= 1,mmax_m
-	      do L = m,Lmax_m
-	         sb(L,m) = cob(nmx3+nmbic-1,L,m)
-	      enddo
-	   enddo
-
-	   do n	= 0,nmax_v
-	      do L = 1,Lmax_v
-	         dsv(L,0) = dsv(L,0)+dch1(n,nmaxo)*vlm(n,L,0)
-	         sw(L,0)  = sw(L,0)+cheb(n,nmaxo)*wlm(n,L,0)
-	      enddo
-	      do m = 1,mmax_v
-	         do L = m,Lmax_v
-	            dsv(L,m) = dsv(L,m)+dch1(n,nmaxo)*vlm(n,L,m)
-	            sw(L,m)  = sw(L,m)+cheb(n,nmaxo)*wlm(n,L,m)
-	         enddo
-	      enddo
-	   enddo
-	      
-c	   obtaining {r^2b_r, r sin(th) [v_th], r sin(th) [v_ph]}
-
-	   tmpc1= zeros
-	   do m	= 0,mmax
-	      tmpc1(m:Lmax,m) = LL(m:Lmax)*sb(m:Lmax,m)
-	   enddo
-
-           call izfspht(tmpc1,aslg,table,Lmaxa,mmaxa,ntmax,
-     &                  npmax,br)
-
-	   tmpc1= zeros
-	   tmpc2= zeros
-	   do m	= 0,mmax
-	      uim = cmplx(0.0,1.0*m)
-	      do L= m+1,Lmax
-	         tmpc1(L,m) = uim*sw(L,m)+clm(L,m,1)*dsv(L-1,m)
-     &                        -clm(L,m,2)*dsv(L+1,m)
-	         tmpc2(L,m) = uim*dsv(L,m)-clm(L,m,1)*sw(L-1,m)
-     &                        +clm(L,m,2)*sw(L+1,m)
-	      enddo
-	      tmpc1(m,m) = uim*sw(m,m)-clm(m,m,2)*dsv(m+1,m)
-	      tmpc2(m,m) = uim*dsv(m,m)+clm(m,m,2)*sw(m+1,m)
-	   enddo
-
-           call izfspht(tmpc1,aslg,table,Lmaxa,mmaxa,ntmax,
-     &                  npmax,vth)
-           call izfspht(tmpc2,aslg,table,Lmaxa,mmaxa,ntmax,
-     &                  npmax,vph)
-
-c	   evaluating the inhomogeneous boundary conditions
-
-	   do k	= 1,ntmax
-	      c1= 1.0/sins(k)**2
-	      tmpr1(:,k) = c1*br(:,k)*vth(:,k)
-	      tmpr2(:,k) = c1*br(:,k)*vph(:,k)
-	   enddo
-           call zfspht(tmpr1,aslg,gauwt,table,Lmaxa,mmaxa,ntmax,
-     &                 npmax,tmpc1)
-           call zfspht(tmpr2,aslg,gauwt,table,Lmaxa,mmaxa,ntmax,
-     &                 npmax,tmpc2)
-
-	   tmpc3 = zeros
-	   do m = 0,mmax
-	      uim  = cmplx(0.0,1.0*m)
-	      do L = m+1,Lmax
-		 tmpc3(L,m) = uim*tmpc1(L,m)-clm(L,m,3)*
-     &                     tmpc2(L-1,m)+clm(L,m,4)*tmpc2(L+1,m)
-	      enddo
-	      tmpc3(m,m) = uim*tmpc1(m,m)+clm(m,m,4)*tmpc2(m+1,m)
-           enddo
-
-	   do L	= 1,Lmax_m
-	      boundm(L,0) = tmpc3(L,0)/(1.0*LL(L))
-	   enddo
-	   do m	= 1,mmax_m
-	      do L = m,Lmax_m
-	         boundm(L,m) = tmpc3(L,m)/(1.0*LL(L))
-	      enddo
-	   enddo
-
-	endif
-
-	return
-	end
-
-

Copied: geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/bcs.f (from rev 5450, geodyn/3D/MoSST/trunk/mosst-dynamo/bcs.f)

Deleted: geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/parameter.data
===================================================================
--- geodyn/3D/MoSST/trunk/mosst-dynamo/parameter.data	2006-11-30 05:11:10 UTC (rev 5385)
+++ geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/parameter.data	2007-01-25 23:52:27 UTC (rev 5899)
@@ -1,68 +0,0 @@
- $phypar
-	rcc=120
-	ricb=1200
-	rcmb=3500
-	rdpp=3520
-	rear=6400
-	rhooc=10.0
-	rhoio=1.1
-	rhomo=0.4
-	etaio=1.0
-	etado=10.0
-	alpht=0.01
-	alphj=0.0
-	ro=1.25e-6
-	ron=1.25e-6
-	cm=1.0
-	ekman=1.25e-6
-	rm=1.0
-	qk=1.0
-	rath=15000.0
-	kicbv=0
-	kcmbv=0
-	kccbb=1
-	kicbb=2
-	kcmbb=2
-	kicbt=1
-	kcmbt=1
-	itucmb=1
-	itvcmb=1
-	itbcmb=1
-	itjcmb=1
-	ittcmb=1
-	indxt=0
-	k_icrot=2
-	avisv1=0.05
-	avisv2=0.05
-	avisb=0.05
-	avist=0.05
-	navfb=0
-	navft=0
-	navfv1=0
-	navfv2=0
-	deltt=0.4425891e-6
-	tt0=0.0
-	toutf=0.001
-	toutd=0.0001
-	ntt=500
-	nevol=0
-	ncfl=1
-	cflmin=0.7
-	cflmax=1.1
-	usr_name="wei/mosst-svn/trunk"
-	code_geom="sphere"
-	disc_in="home"
-	subdir_in="mosst-data"
-	version_in="fftw_v10"
-	fileno_in=1000
-	disc_out="home"
-	subdir_out="mosst-data"
-	version_out="fftw_v10"
-	fileno_out=1001
-	disc_diag="home"
-	subdir_diag="data"
-	version_diag="fftw_v10"
-	disc_anom="home"
-	subdir_anom="data"
-	version_anom="anomaly_data"
- $

Copied: geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/parameter.data (from rev 5448, geodyn/3D/MoSST/trunk/mosst-dynamo/parameter.data)

Deleted: geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/run_v10
===================================================================
--- geodyn/3D/MoSST/trunk/mosst-dynamo/run_v10	2006-11-30 05:11:10 UTC (rev 5385)
+++ geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/run_v10	2007-01-25 23:52:27 UTC (rev 5899)
@@ -1,63 +0,0 @@
-#/bin/rm parameter.data
-
-#cp $HOME/research/src/model/params_v10.data parameter.data
-
-ex parameter.data << EOF
-1,\$s/ellpm=3.274e-3/ellpm=3.274e-3/
-1,\$s/rdpp=3700/rdpp=3520/
-1,\$s/etado=200.0/etado=10.0/
-1,\$s/scale_mdens=1.0/scale_mdens=1.0/
-1,\$s/epstp=0.0/epstp=0.0/
-1,\$s/altpnh=0.0/altpnh=0.5/
-1,\$s/ro=2.e-5/ro=1.25e-6/
-1,\$s/ron=2.e-5/ron=1.25e-6/
-1,\$s/ekman=2.e-5/ekman=1.25e-6/
-1,\$s/rath=15000.0/rath=15000.0/
-1,\$s/kicbv=2/kicbv=0/
-1,\$s/kcmbv=2/kcmbv=0/
-1,\$s/kccbb=1/kccbb=1/
-1,\$s/kicbb=2/kicbb=2/
-1,\$s/kcmbb=2/kcmbb=2/
-1,\$s/kicbt=1/kicbt=1/
-1,\$s/kcmbt=1/kcmbt=1/
-1,\$s/k_icrot=2/k_icrot=2/
-1,\$s/itvcmb=1/itvcmb=1/
-1,\$s/itucmb=1/itucmb=1/
-1,\$s/itbcmb=1/itbcmb=1/
-1,\$s/itjcmb=1/itjcmb=1/
-1,\$s/ittcmb=1/ittcmb=1/
-1,\$s/indxt=0/indxt=0/
-1,\$s/nevol=0/nevol=0/
-1,\$s/ncfl=1/ncfl=1/
-1,\$s/cflmin=0.8/cflmin=0.7
-1,\$s/cflmax=1.1/cflmax=1.1
-1,\$s/avisv1=0.05/avisv1=0.05/
-1,\$s/avisv2=0.05/avisv2=0.05/
-1,\$s/avisb=0.05/avisb=0.05/
-1,\$s/avist=0.05/avist=0.05/
-1,\$s/navfb=2/navfb=0/
-1,\$s/navft=2/navft=0/
-1,\$s/navfv1=0/navfv1=0/
-1,\$s/navfv2=25/navfv2=0/
-1,\$s/deltt=0.1e-05/deltt=0.4425891e-6/
-1,\$s/tt0=0.0/tt0=0.0/
-1,\$s/toutf=0.001/toutf=0.001/
-1,\$s/toutd=0.0001/toutd=0.0001/
-1,\$s/ntt=200000/ntt=500/
-1,\$s/fileno_in=1000/fileno_in=1000/
-1,\$s/fileno_out=1000/fileno_out=1001/
-1,\$s/disc_in="sea10"/disc_in="home"/
-1,\$s/disc_out="sea10"/disc_out="home"/
-1,\$s/disc_diag="sea10"/disc_diag="home"/
-1,\$s/disc_anom="sea10"/disc_anom="home"/
-1,\$s/version_in="fini01"/version_in="fftw_v10"/
-1,\$s/version_out="fini01"/version_out="fftw_v10"/
-1,\$s/version_diag="fini01"/version_diag="fftw_v10"/
-1,\$s/k_mdens=0/k_mdens=0/
-1,\$s/k_cmbheat=0/k_cmbheat=0/
-1,\$s/k_cmbtopo=0/k_cmbtopo=0/
-wq
-EOF
-
-#substitute your local MoSST path in the following line 
-$HOME/mosst-svn/trunk/mosst-dynamo/mode10 &

Copied: geodyn/3D/MoSST/branches/test-mosst/mosst-dynamo/run_v10 (from rev 5448, geodyn/3D/MoSST/trunk/mosst-dynamo/run_v10)

Modified: geodyn/3D/MoSST/branches/test-mosst/mosst-lib/makefile
===================================================================
--- geodyn/3D/MoSST/trunk/mosst-lib/makefile	2006-11-14 23:34:50 UTC (rev 5266)
+++ geodyn/3D/MoSST/branches/test-mosst/mosst-lib/makefile	2007-01-25 23:52:27 UTC (rev 5899)
@@ -1,7 +1,7 @@
-LIBDIR=$HOME/lib
+LIBDIR=$HOME/mosst-svn/trunk/mosst-lib
 LIB=intelsub90d
 
-ifort -static -r8 -nofor_main -c *.f -L/opt/fftw3.0.1/lib -lfftw3 -L/usr/lib -lblas
+ifort -static -r8 -nofor_main -c *.f 
 ar -cru $LIBDIR/lib$LIB.a *.o
-rm -f *.o
-rm -f *.out
+#rm -f *.o
+#rm -f *.out

Modified: geodyn/3D/MoSST/trunk/mosst-lib/makefile
===================================================================
--- geodyn/3D/MoSST/trunk/mosst-lib/makefile	2007-01-25 23:41:54 UTC (rev 5898)
+++ geodyn/3D/MoSST/trunk/mosst-lib/makefile	2007-01-25 23:52:27 UTC (rev 5899)
@@ -1,7 +1,7 @@
-LIBDIR=$HOME/lib
+LIBDIR=$HOME/mosst-svn/trunk/mosst-lib
 LIB=intelsub90d
 
-ifort -static -r8 -nofor_main -c *.f -L/opt/fftw3.0.1/lib -lfftw3 -L/usr/lib -lblas
+ifort -static -r8 -nofor_main -c *.f 
 ar -cru $LIBDIR/lib$LIB.a *.o
-rm -f *.o
-rm -f *.out
+#rm -f *.o
+#rm -f *.out



More information about the cig-commits mailing list