[cig-commits] r18325 - seismo/3D/FAULT_SOURCE/branches/new_fault_db/src

ampuero at geodynamics.org ampuero at geodynamics.org
Thu May 5 22:37:55 PDT 2011


Author: ampuero
Date: 2011-05-05 22:37:55 -0700 (Thu, 05 May 2011)
New Revision: 18325

Modified:
   seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/compute_forces_elastic.f90
   seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/compute_forces_elastic_noDev.f90
   seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/create_regions_mesh.f90
   seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/fault_object.f90
   seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/fault_solver.f90
   seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/fault_solver_kinematic.f90
Log:
reordered some, including kelvin voigt

Modified: seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/compute_forces_elastic.f90
===================================================================
--- seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/compute_forces_elastic.f90	2011-05-06 00:48:28 UTC (rev 18324)
+++ seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/compute_forces_elastic.f90	2011-05-06 05:37:55 UTC (rev 18325)
@@ -80,9 +80,6 @@
                         num_phase_ispec_elastic,nspec_inner_elastic,nspec_outer_elastic,&
                         phase_ispec_inner_elastic)
     else
-! FAULT 
-! Percy , adding "veloc",Kelvin_voigt_eta input for Damping in compute_forces_elastic_noDev. 
-!                 
       call compute_forces_elastic_noDev( iphase, NSPEC_AB,NGLOB_AB,displ,veloc,accel, &
                         xix,xiy,xiz,etax,etay,etaz,gammax,gammay,gammaz, &
                         hprime_xx,hprime_yy,hprime_zz, &

Modified: seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/compute_forces_elastic_noDev.f90
===================================================================
--- seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/compute_forces_elastic_noDev.f90	2011-05-06 00:48:28 UTC (rev 18324)
+++ seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/compute_forces_elastic_noDev.f90	2011-05-06 05:37:55 UTC (rev 18325)
@@ -23,8 +23,7 @@
 !
 !=====================================================================
 ! Fault implementation 
-! Adding input : veloc 
-!                Kelvin_Voigt_eta
+! Adding input : veloc for Kelvin Voigt viscosity
 !  
 subroutine compute_forces_elastic_noDev(iphase, &
                        NSPEC_AB,NGLOB_AB,displ,veloc,accel,&
@@ -60,7 +59,6 @@
  use constants,only: CUSTOM_REAL,NGLLX,NGLLY,NGLLZ,NDIM, &
                      NUM_REGIONS_ATTENUATION,N_SLS,SAVE_MOHO_MESH, &
                      ONE_THIRD,FOUR_THIRDS
-!Percy , loading Kelving Voigt term damping . 
  use fault_solver, only : Kelvin_Voigt_eta
 
  implicit none
@@ -209,6 +207,8 @@
  real(kind=CUSTOM_REAL) b_R_xx_val,b_R_yy_val  
  ! adjoint
 
+ real(kind=CUSTOM_REAL) :: eta
+
  if( iphase == 1 ) then
    num_elements = nspec_outer_elastic
  else
@@ -233,17 +233,18 @@
          endif
        endif
 
-! Fault KELVIN_VOIGT_DAMPING implementation.
-!--------- DAMPING ETA*vloc TERM  ---------------
+      ! Kelvin Voigt damping: artificial viscosity around dynamic faults
        if (allocated(Kelvin_Voigt_eta)) then
+         eta = Kelvin_Voigt_eta(ispec)
          do k=1,NGLLZ
            do j=1,NGLLY
              do i=1,NGLLX
                iglob = ibool(i,j,k,ispec)
-               dloc(:,i,j,k) = displ(:,iglob) + Kelvin_Voigt_eta(ispec)*veloc(:,iglob)
+               dloc(:,i,j,k) = displ(:,iglob) + eta*veloc(:,iglob)
              enddo
            enddo
          enddo
+
        else
          do k=1,NGLLZ
            do j=1,NGLLY
@@ -254,7 +255,6 @@
            enddo
          enddo
        endif
-!---------------- END DAMPING ----------------
 
        do k=1,NGLLZ
          do j=1,NGLLY

Modified: seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/create_regions_mesh.f90
===================================================================
--- seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/create_regions_mesh.f90	2011-05-06 00:48:28 UTC (rev 18324)
+++ seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/create_regions_mesh.f90	2011-05-06 05:37:55 UTC (rev 18325)
@@ -194,10 +194,9 @@
                       xstore,ystore,zstore,nspec,nglob,npointot, &
                       nnodes_ext_mesh,nodes_coords_ext_mesh,myrank)
 
+  call fault_read_input(prname)
+  call fault_setup (ibool,xstore,ystore,zstore,nspec,nglob,myrank)
 
-  call fault_read_input()
-  call fault_setup (ibool,xstore,ystore,zstore,nspec,nglob,prname,myrank)
-
  
 ! sets up MPI interfaces between partitions
   call sync_all()

Modified: seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/fault_object.f90
===================================================================
--- seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/fault_object.f90	2011-05-06 00:48:28 UTC (rev 18324)
+++ seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/fault_object.f90	2011-05-06 05:37:55 UTC (rev 18325)
@@ -74,17 +74,20 @@
 contains
 
 !=================================================================================================================
-subroutine fault_read_input()
+subroutine fault_read_input(prname)
 
-  integer :: nb, i,ier 
+  character(len=256), intent(in) :: prname 
+  
+  integer :: nb,i,iflt,ier
+  integer, parameter :: IIN = 100  
   real(kind=CUSTOM_REAL) :: eta
   
+ ! read fault input file
   nb = 0
- 
-  open(unit=100,file='DATA/FAULT/Par_file_faults.in',status='old',action='read',iostat=ier)
+  open(unit=IIN,file='DATA/FAULT/Par_file_faults.in',status='old',action='read',iostat=ier)
   if (ier==0) then    
-    read(100,*) nb  
-    read(100,*) eta
+    read(IIN,*) nb  
+    read(IIN,*) eta
     if (nb>0) then
       allocate(fault_db(nb))
       do i=1,nb
@@ -95,28 +98,52 @@
     write(6,*) 'File Par_file_faults.in does not exist '
     return
   end if
+  close(IIN)
 
-  close(100)
+ ! read fault database file
+  open(unit=IIN,file=prname(1:len_trim(prname))//'Database_fault', &
+       status='old',action='read',form='formatted',iostat=ier)
+  if( ier /= 0 ) then
+    write(IMAIN,*) 'error opening file: ',prname(1:len_trim(prname))//'Database_fault'
+    write(IMAIN,*) 'make sure file exists'
+    stop
+  endif
 
+  do iflt=1,size(fault_db) 
 
-end subroutine fault_read_input
+    read(IIN,*) fault_db(iflt)%nspec 
 
+    if (fault_db(iflt)%nspec == 0) cycle
 
+    allocate(fault_db(iflt)%ispec1(fdb%nspec))
+    allocate(fault_db(iflt)%iface1(fdb%nspec))
+    allocate(fault_db(iflt)%ispec2(fdb%nspec))
+    allocate(fault_db(iflt)%iface2(fdb%nspec))
+
+   ! loading ispec1 ispec2 iface1 iface2 of fault elements.
+    do i=1,fault_db(iflt)%nspec
+      read(IIN,*) fault_db(iflt)%ispec1(i), fault_db(iflt)%ispec2(i), &
+                  fault_db(iflt)%iface1(i), fault_db(iflt)%iface2(i)
+    enddo
+
+  enddo
+
+  close(IIN)
+
+end subroutine fault_read_input
+
 !==================================================================================================================
-subroutine fault_setup(ibool,xstore,ystore,zstore,nspec,nglob,prname,myrank)
+subroutine fault_setup(ibool,xstore,ystore,zstore,nspec,nglob,myrank)
 
   integer, intent(in) :: nspec ! number of spectral elements in each block
   double precision, dimension(NGLLX,NGLLY,NGLLZ,nspec), intent(in) :: xstore,ystore,zstore
   integer, dimension(NGLLX,NGLLY,NGLLZ,nspec), intent(in) :: ibool
   integer, intent(in) :: myrank
-  character(len=256), intent(in) :: prname ! 'proc***'
-  
-  integer, intent(out) :: nglob
+  integer, intent(in) :: nglob
 
-  integer :: iflt,npointot
-  logical :: fault_exists,KELVIN_VOIGT_DAMPING
+  integer :: iflt
+  logical :: fault_exists
 
-
   if (.not. allocated(fault_db)) return
 
 ! 1. Generate node indexing (ibool) from original coordinates. Fault nodes are split in CUBIT.
@@ -124,35 +151,20 @@
 
 ! to do: what happens to nodes at the edges of a fault ??? : still thinking.
 
-  npointot = nspec * NGLLX*NGLLY*NGLLZ
-
   fault_exists = .false.
-
-  call loading_coords_and_setup(fault_db,nglob,nspec,prname,myrank)
- 
   do iflt=1,size(fault_db)
-    if (fault_db(iflt)%nspec>0) fault_exists = .true.
-  enddo
-  
-  if (fault_exists) then
- 
-    !--------------  Kelvin voigt damping -------------------------
-    KELVIN_VOIGT_DAMPING = .false.
-    do iflt = 1, size(fault_db)
-       if (fault_db(iflt)%eta > 0.0_CUSTOM_REAL) KELVIN_VOIGT_DAMPING = .true.
-    end do
-    if (KELVIN_VOIGT_DAMPING) then
-       allocate(Kelvin_Voigt_eta(nspec)) 
-       Kelvin_Voigt_eta(:) = 0.0_CUSTOM_REAL
+    if (fault_db(iflt)%nspec>0) then
+      fault_exists = .true.
+      exit
     endif
-    !-------------------------------------------------------------
-
-  endif
-
+  enddo
   if (.not.fault_exists) return
-
+  
   do iflt=1,size(fault_db)
 
+    ! saving gll indices for each fault face, needed for ibulks
+    call setup_ijk(fault_db(iflt))
+
     ! ibools = mapping from local indices on the fault (GLL index, element
     !          index) to global indices on the fault
     call setup_ibools(fault_db(iflt),xstore,ystore,zstore,nspec,fault_db(iflt)%nspec*NGLLSQUARE)
@@ -161,7 +173,7 @@
     !          from global indices on the fault to global indices on the bulk
     call setup_ibulks(fault_db(iflt),ibool,nspec)
 
-    call setup_Kelvin_Voigt_eta(fault_db(iflt))
+    call setup_Kelvin_Voigt_eta(fault_db(iflt),nspec)
   
     call setup_normal_jacobian(fault_db(iflt),ibool,nspec,nglob,myrank)
 
@@ -169,79 +181,44 @@
 
 end subroutine fault_setup
 
-!==============================================================================================================
 
-subroutine loading_coords_and_setup(faults,nglob,nspec,prname,myrank)
+!=============================================================================================================
+subroutine setup_ijk(fdb)
 
-  integer, intent(in) :: nspec,nglob,i 
-  integer, dimension(NGLLX,NGLLY,NGLLZ,nspec), intent(in) :: ibool
-  integer,intent(in) :: myrank
-  character(len=256), intent(in) :: prname ! 'proc***'
+  type(fault_db_type), intent(inout) :: fdb  
   
-  integer :: ifault,iflt
-  integer, dimension(3,NGLLSQUARE,nspec*6) :: ijk1, ijk2
-  integer :: ijk_face(3,NGLLX,NGLLY)
-! The tolerance in get_global is SMALLVALTOTAL=1-10*(whole size of the model).
-  integer :: IIN = 100  
+  integer :: e,i,j,igll, iface_ref1, iface_ref2
+  integer :: ijk_face1(3,NGLLX,NGLLY), ijk_face2(3,NGLLX,NGLLY)
 
-  open(unit=IIN,file=prname(1:len_trim(prname))//'Database_fault',status='old',action='read',form='formatted',iostat=ier)
-  if( ier /= 0 ) then
-    write(IMAIN,*) 'error opening file: ',prname(1:len_trim(prname))//'Database_fault'
-    write(IMAIN,*) 'make sure file exists'
-    stop
-  endif
+  allocate(fdb%ijk1(3,NGLLX*NGLLY,fdb%nspec))
+  allocate(fdb%ijk2(3,NGLLX*NGLLY,fdb%nspec))
 
-  do iflt=1,size(faults) 
-
-    read(IIN,*) faults(iflt)%nspec 
-
-    if (faults(iflt)%nspec == 0) cycle
-
-    allocate(faults(iflt)%ispec1(fdb%nspec))
-    allocate(faults(iflt)%iface1(fdb%nspec))
-    allocate(faults(iflt)%ijk1(3,NGLLX*NGLLY,fdb%nspec))
-
-    allocate(faults(iflt)%ispec2(fdb%nspec))
-    allocate(faults(iflt)%iface2(fdb%nspec))
-    allocate(faults(iflt)%ijk2(3,NGLLX*NGLLY,fdb%nspec))
-
-   ! loading ispec1 ispec2 iface1 iface2 of fault elements.
-    do i=1,faults(iflt)%nspec
-      read(IIN,*) faults(iflt)%ispec1(i),faults(iflt)%ispec2(i),faults(iflt)%iface1(i),faults(iflt)%iface2(i)
-    enddo
-
-    do ifault=1,faults(iflt)%nspec
-     ! we have identified a new fault element on fault side 1
-      iface_ref1 = faults(iflt)%iface1(ifault)
-      iface_ref2 = faults(iflt)%iface2(ifault)
-     ! gets i,j,k indices of GLL nodes in element face
-      call get_element_face_gll_indices(iface_ref1,ijk_face1,NGLLX,NGLLY)
-      call get_element_face_gll_indices(iface_ref2,ijk_face2,NGLLX,NGLLY)
-      igll = 0
-      do j=1,NGLLY
-        do i=1,NGLLX
-          igll = igll + 1
-          ijk1(:,igll,ifault)=ijk_face1(:,i,j)  ! saving gll points of side 1 , needed for ibulk1
-          ijk2(:,igll,ifault)=ijk_face2(:,i,j)  ! saving gll points of side 2 , needed for ibulk2
-        enddo
+  do e=1,fdb%nspec
+    call get_element_face_gll_indices(fdb%iface1(e),ijk_face1,NGLLX,NGLLY)
+    call get_element_face_gll_indices(fdb%iface2(e),ijk_face2,NGLLX,NGLLY)
+    igll = 0
+    do j=1,NGLLY
+      do i=1,NGLLX
+        igll = igll + 1
+        fdb%ijk1(:,igll,e)=ijk_face1(:,i,j)  
+        fdb%ijk2(:,igll,e)=ijk_face2(:,i,j)
       enddo
     enddo
-    faults(iflt)%ijk1 = ijk1(:,:,1:faults(iflt)%nspec)
-    faults(iflt)%ijk2 = ijk2(:,:,1:faults(iflt)%nspec)
-
   enddo
 
-  close(IIN)
+end subroutine setup_ijk
 
-end subroutine loading_coords_and_setup
-
-
 !=============================================================================================================
- subroutine setup_Kelvin_Voigt_eta(fdb)
+ subroutine setup_Kelvin_Voigt_eta(fdb,nspec)
         
   type(fault_db_type), intent(in) :: fdb  
+  integer, intent(in) :: nspec ! number of spectral elements in each block
 
-  if (allocated(Kelvin_Voigt_eta)) then
+  if (fdb(iflt)%eta > 0.0_CUSTOM_REAL) then
+    if (.not.allocated(Kelvin_Voigt_eta)) then
+      allocate(Kelvin_Voigt_eta(nspec)) 
+      Kelvin_Voigt_eta(:) = 0.0_CUSTOM_REAL
+    endif
     Kelvin_Voigt_eta(fdb%ispec1) = fdb%eta
     Kelvin_Voigt_eta(fdb%ispec2) = fdb%eta
   endif
@@ -347,7 +324,6 @@
       ke=fdb%ijk1(3,k,e)
       K1= fdb%ibool1(k,e)
       fdb%ibulk1(K1)=ibool(ie,je,ke,fdb%ispec1(e))
-! Adding coordinates of fault nodes side 1 .
       fdb%xcoordbulk1(K1) = xstore_dummy(fdb%ibulk1(K1))
       fdb%ycoordbulk1(K1) = ystore_dummy(fdb%ibulk1(K1))
       fdb%zcoordbulk1(K1) = zstore_dummy(fdb%ibulk1(K1)) 
@@ -357,7 +333,6 @@
       ke=fdb%ijk2(3,k,e)
       K2= fdb%ibool2(k,e)
       fdb%ibulk2(K2)=ibool(ie,je,ke,fdb%ispec2(e))
-! Adding coordinates of fault nodes side 2 .
       fdb%xcoordbulk2(K2) = xstore_dummy(fdb%ibulk2(K2))
       fdb%ycoordbulk2(K2) = ystore_dummy(fdb%ibulk2(K2))
       fdb%zcoordbulk2(K2) = zstore_dummy(fdb%ibulk2(K2))
@@ -528,27 +503,30 @@
   character(len=256), intent(in) :: prname ! 'proc***'
   integer, intent(in) :: IOUT
 
-  integer :: nbfaults,iflt,ier,size_Kelvin_Voigt
+  integer :: nbfaults,iflt,ier
   character(len=256) :: filename
 
 
 ! saves mesh file proc***_Kelvin_voigt_eta.bin
-  filename = prname(1:len_trim(prname))//'Kelvin_voigt_eta.bin'
-  open(unit=IOUT,file=trim(filename),status='unknown',action='write',form='unformatted',iostat=ier)
-    if( ier /= 0 ) stop 'error opening database proc######_external_mesh.bin' 
-    if (allocated(Kelvin_Voigt_eta)) then
-       size_Kelvin_Voigt = size(Kelvin_Voigt_eta)
-    else 
-       size_Kelvin_Voigt = 0
+  if (allocated(Kelvin_Voigt_eta)) then
+    filename = prname(1:len_trim(prname))//'Kelvin_voigt_eta.bin'
+    open(unit=IOUT,file=trim(filename),status='unknown',action='write',form='unformatted',iostat=ier)
+    if( ier /= 0 ) then
+      write(IMAIN,*) 'error opening file ',trim(filename)
+      stop 
     endif
-    write(IOUT) size_Kelvin_Voigt
-    if (size_Kelvin_Voigt /= 0) Write(IOUT) Kelvin_Voigt_eta  
-  Close(IOUT)
+    write(IOUT) size(Kelvin_Voigt_eta)
+    write(IOUT) Kelvin_Voigt_eta  
+    close(IOUT)
+  endif
 
 ! saves mesh file proc***_fault_db.bin
   filename = prname(1:len_trim(prname))//'fault_db.bin'
   open(unit=IOUT,file=trim(filename),status='unknown',action='write',form='unformatted',iostat=ier)
-  if( ier /= 0 ) stop 'error opening database proc######_external_mesh.bin'
+  if( ier /= 0 ) then
+    write(IMAIN,*) 'error opening file ',trim(filename)
+    stop 
+  endif
   
   if (allocated(fault_db)) then
     nbfaults = size(fault_db)
@@ -582,10 +560,6 @@
   write(IOUT) f%ycoordbulk1
   write(IOUT) f%zcoordbulk1
 
-! ispec1 and ispec2 might be needed to define a Kelvin-Voigt damping region
-!  write(IOUT) f%ispec1
-!  write(IOUT) f%ispec2
-
 end subroutine save_one_fault_bin
 
 !------------------------------------------------

Modified: seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/fault_solver.f90
===================================================================
--- seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/fault_solver.f90	2011-05-06 00:48:28 UTC (rev 18324)
+++ seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/fault_solver.f90	2011-05-06 05:37:55 UTC (rev 18325)
@@ -91,13 +91,10 @@
 
   integer, save :: SIMULATION_TYPE_DYN = 1
 
-
-  integer , save :: size_Kelvin_Voigt
-
   real(kind=CUSTOM_REAL), allocatable, save :: Kelvin_Voigt_eta(:)
   
   public :: BC_DYNFLT_init, BC_DYNFLT_set3d_all, Kelvin_Voigt_eta, &
-            size_Kelvin_Voigt, SIMULATION_TYPE_DYN
+            SIMULATION_TYPE_DYN
 
 
 contains
@@ -120,6 +117,7 @@
   real(kind=CUSTOM_REAL) :: dt
   integer :: iflt,ier,dummy_idfault
   integer :: nbfaults
+  integer :: size_Kelvin_Voigt
   character(len=256) :: filename
   integer, parameter :: IIN_PAR =151
   integer, parameter :: IIN_BIN =170
@@ -128,34 +126,32 @@
 
   dummy_idfault = 0
 
-  filename = prname(1:len_trim(prname))//'Kelvin_voigt_eta.bin'
-  open(unit=IIN_BIN,file=trim(filename),status='old',action='read',form='unformatted',iostat=ier)
-  if( ier /= 0 ) stop 'Haven not found proc*_Kelvin_voigt_eta.bin'
-    read(IIN_BIN) size_Kelvin_Voigt
-    if (size_Kelvin_Voigt > 0) then
-        allocate(Kelvin_Voigt_eta(size_Kelvin_Voigt))
-        read(IIN_BIN) Kelvin_Voigt_eta
-    endif
-  Close(IIN_BIN)
-
   open(unit=IIN_PAR,file='DATA/FAULT/Par_file_faults.in',status='old',iostat=ier)
   if( ier /= 0 ) then
-    write(6,*) 'Have not found Par_file_faults.in: assume no faults' 
+    write(6,*) 'File Par_file_faults.in not found: assume no faults' 
     return 
   endif
 
   dt = real(DTglobal)
   filename = prname(1:len_trim(prname))//'fault_db.bin'
   open(unit=IIN_BIN,file=trim(filename),status='old',action='read',form='unformatted',iostat=ier)
-  if( ier /= 0 ) stop 'Have not found proc*_fault_db.bin'
+  if( ier /= 0 ) then
+    write(6,*) 'File ',trim(filename),' not found. Abort' 
+    stop
+  endif
 ! WARNING TO DO: should be an MPI abort
   
   read(IIN_PAR,*) nbfaults
+  if (nbfaults==0) return
   do iflt=1,nbfaults
     read(IIN_PAR,*) 
   enddo 
   read(IIN_PAR,*) SIMULATION_TYPE_DYN 
-  if ( SIMULATION_TYPE_DYN == 2 ) goto 99
+  if ( SIMULATION_TYPE_DYN == 2 ) then
+    close(IIN_BIN)
+    close(IIN_PAR)
+    return 
+  endif
   read(IIN_PAR,*) NTOUT
   read(IIN_PAR,*) NSNAP 
   read(IIN_PAR,*) V_HEALING
@@ -167,9 +163,22 @@
     read(IIN_PAR,nml=BEGIN_FAULT,end=100)
     call init_one_fault(faults(iflt),IIN_BIN,IIN_PAR,Minv,dt,nt,iflt)
   enddo 
-99 close(IIN_BIN)
-   close(IIN_PAR)
+  close(IIN_BIN)
+  close(IIN_PAR)
 
+  filename = prname(1:len_trim(prname))//'Kelvin_voigt_eta.bin'
+  open(unit=IIN_BIN,file=trim(filename),status='old',action='read',form='unformatted',iostat=ier)
+  if( ier /= 0 ) then
+    write(6,*) 'File ',trim(filename),' not found. Abort' 
+    stop
+  endif
+  read(IIN_BIN) size_Kelvin_Voigt
+  if (size_Kelvin_Voigt > 0) then
+    allocate(Kelvin_Voigt_eta(size_Kelvin_Voigt))
+    read(IIN_BIN) Kelvin_Voigt_eta
+  endif
+  close(IIN_BIN)
+
   return
 100 stop 'Did not find BEGIN_FAULT block #'
    ! WARNING TO DO: should be an MPI abort

Modified: seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/fault_solver_kinematic.f90
===================================================================
--- seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/fault_solver_kinematic.f90	2011-05-06 00:48:28 UTC (rev 18324)
+++ seismo/3D/FAULT_SOURCE/branches/new_fault_db/src/fault_solver_kinematic.f90	2011-05-06 05:37:55 UTC (rev 18325)
@@ -74,14 +74,6 @@
 
  integer, save :: SIMULATION_TYPE_KIN = 2
  
-! integer , save :: size_Kelvin_Voigt
-
-! real(kind=CUSTOM_REAL), allocatable, save :: Kelvin_Voigt_eta(:)
-
-
-! public :: BC_KINFLT_init, BC_KINFLT_set_all, Kelvin_Voigt_eta, &
-!           size_Kelvin_Voigt, SIMULATION_TYPE_KIN
-
  public :: BC_KINFLT_init, BC_KINFLT_set_all, SIMULATION_TYPE_KIN
 
 
@@ -114,16 +106,6 @@
 
  dummy_idfault = 0
 
-! filename = prname(1:len_trim(prname))//'Kelvin_voigt_eta.bin'
-! open(unit=IIN_BIN,file=trim(filename),status='old',action='read',form='unformatted',iostat=ier)
-! if( ier /= 0 ) stop 'Haven not found proc*_Kelvin_voigt_eta.bin'
-!   read(IIN_BIN) size_Kelvin_Voigt
-!   if (size_Kelvin_Voigt > 0) then
-!       allocate(Kelvin_Voigt_eta(size_Kelvin_Voigt))
-!       read(IIN_BIN) Kelvin_Voigt_eta
-!   endif
-! Close(IIN_BIN)
-
  open(unit=IIN_PAR,file='DATA/FAULT/Par_file_faults.in',status='old',iostat=ier)
  if( ier /= 0 ) then
    write(6,*) 'Have not found Par_file_faults.in: assume no faults' 



More information about the CIG-COMMITS mailing list