[cig-commits] r16415 - seismo/2D/SPECFEM2D/trunk

dkomati1 at geodynamics.org dkomati1 at geodynamics.org
Sat Mar 13 05:23:22 PST 2010


Author: dkomati1
Date: 2010-03-13 05:23:19 -0800 (Sat, 13 Mar 2010)
New Revision: 16415

Modified:
   seismo/2D/SPECFEM2D/trunk/README_MANUAL.txt
   seismo/2D/SPECFEM2D/trunk/adj_seismogram.f90
   seismo/2D/SPECFEM2D/trunk/assemble_MPI.F90
   seismo/2D/SPECFEM2D/trunk/attenuation_model.f90
   seismo/2D/SPECFEM2D/trunk/checkgrid.F90
   seismo/2D/SPECFEM2D/trunk/compute_Bielak_conditions.f90
   seismo/2D/SPECFEM2D/trunk/compute_arrays_source.f90
   seismo/2D/SPECFEM2D/trunk/compute_curl_one_element.f90
   seismo/2D/SPECFEM2D/trunk/compute_energy.f90
   seismo/2D/SPECFEM2D/trunk/compute_forces_acoustic.f90
   seismo/2D/SPECFEM2D/trunk/compute_forces_elastic.f90
   seismo/2D/SPECFEM2D/trunk/compute_gradient_attenuation.f90
   seismo/2D/SPECFEM2D/trunk/compute_pressure.f90
   seismo/2D/SPECFEM2D/trunk/compute_vector_field.f90
   seismo/2D/SPECFEM2D/trunk/construct_acoustic_surface.f90
   seismo/2D/SPECFEM2D/trunk/convolve_source_timefunction.f90
   seismo/2D/SPECFEM2D/trunk/create_color_image.f90
   seismo/2D/SPECFEM2D/trunk/createnum_fast.f90
   seismo/2D/SPECFEM2D/trunk/createnum_slow.f90
   seismo/2D/SPECFEM2D/trunk/datim.f90
   seismo/2D/SPECFEM2D/trunk/define_derivation_matrices.f90
   seismo/2D/SPECFEM2D/trunk/define_external_model.f90
   seismo/2D/SPECFEM2D/trunk/define_shape_functions.f90
   seismo/2D/SPECFEM2D/trunk/enforce_acoustic_free_surface.f90
   seismo/2D/SPECFEM2D/trunk/get_perm_cuthill_mckee.f90
   seismo/2D/SPECFEM2D/trunk/get_poroelastic_velocities.f90
   seismo/2D/SPECFEM2D/trunk/gmat01.f90
   seismo/2D/SPECFEM2D/trunk/invert_mass_matrix.f90
   seismo/2D/SPECFEM2D/trunk/is_in_convex_quadrilateral.f90
   seismo/2D/SPECFEM2D/trunk/lagrange_poly.f90
   seismo/2D/SPECFEM2D/trunk/locate_receivers.F90
   seismo/2D/SPECFEM2D/trunk/locate_source_force.F90
   seismo/2D/SPECFEM2D/trunk/locate_source_moment_tensor.F90
   seismo/2D/SPECFEM2D/trunk/meshfem2D.F90
   seismo/2D/SPECFEM2D/trunk/part_unstruct.F90
   seismo/2D/SPECFEM2D/trunk/plotgll.f90
   seismo/2D/SPECFEM2D/trunk/plotpost.F90
   seismo/2D/SPECFEM2D/trunk/read_external_model.f90
   seismo/2D/SPECFEM2D/trunk/read_value_parameters.f90
   seismo/2D/SPECFEM2D/trunk/recompute_jacobian.f90
   seismo/2D/SPECFEM2D/trunk/setup_sources_receivers.f90
   seismo/2D/SPECFEM2D/trunk/specfem2D.F90
   seismo/2D/SPECFEM2D/trunk/spline_routines.f90
   seismo/2D/SPECFEM2D/trunk/write_seismograms.F90
Log:
done updating the copyright information


Modified: seismo/2D/SPECFEM2D/trunk/README_MANUAL.txt
===================================================================
--- seismo/2D/SPECFEM2D/trunk/README_MANUAL.txt	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/README_MANUAL.txt	2010-03-13 13:23:19 UTC (rev 16415)
@@ -301,14 +301,14 @@
 S****.AA.BHZ.semd
 
 Second: define the adjoint source
-Use adj_seismogram.f90 
+Use adj_seismogram.f90
 Edit to update NSTEP, nrec, t0, deltat, and the position of the cut to pic
 any given phase if needed (tstart,tend), add the right number of stations, and
 put one component of the source to zero if needed.
-The ouput files of adj_seismogram.f90 are S****.AA.BHX.adj and S****.AA.BHZ.adj, for P-SV waves (and 
+The ouput files of adj_seismogram.f90 are S****.AA.BHX.adj and S****.AA.BHZ.adj, for P-SV waves (and
 S****.AA.BHY.adj, for SH (membrane) waves). Note that you will need these three
-files (S****.AA.BHX.adj, S****.AA.BHY.adj and S****.AA.BHZ.adj) to be present in the OUTPUT_FILES directory 
-together with the absorb_elastic_****.bin and lastframe_elastic.bin files to be read 
+files (S****.AA.BHX.adj, S****.AA.BHY.adj and S****.AA.BHZ.adj) to be present in the OUTPUT_FILES directory
+together with the absorb_elastic_****.bin and lastframe_elastic.bin files to be read
 when running the adjoint simulation.
 
 Third: run the adjoint simulation
@@ -320,14 +320,14 @@
 Output_files (for example for the elastic case)
 snapshot_rho_kappa_mu*****
 snapshot_rhop_alpha_beta*****
-which are the primary moduli kernels and the phase velocities kernels respectively, in ascii format 
+which are the primary moduli kernels and the phase velocities kernels respectively, in ascii format
 and at the local level, that is as "kernels(i,j,ispec)".
 
 Note1: At the moment, adjoint simulations do not support anisotropy, attenuation, and viscous damping.
 Note2: You will need S****.AA.BHX.adj, S****.AA.BHY.adj and S****.AA.BHZ.adj
 to be present in OUTPUT_FILES even if you are just running an acoustic or
-poroelastic adjoint simulation. 
-S****.AA.BHX.adj is the only relevant component for an acoustic case. 
+poroelastic adjoint simulation.
+S****.AA.BHX.adj is the only relevant component for an acoustic case.
 S****.AA.BHX.adj and S****.AA.BHZ.adj are the only relevant components for a
 poroelastic case.
 
@@ -344,7 +344,7 @@
 
 How to run P-SV or SH (membrane) waves simulation :
 ---------------------------------------------------
-To run a P-SV waves calculation propagating in the x-z plane, 
+To run a P-SV waves calculation propagating in the x-z plane,
 set p_sv = .true. in the Par_file.
 To run a SH (membrane) waves calculation traveling in the x-z plane with a
 y-component of motion, set p_sv = .false.

Modified: seismo/2D/SPECFEM2D/trunk/adj_seismogram.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/adj_seismogram.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/adj_seismogram.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,3 +1,47 @@
+
+!========================================================================
+!
+!                   S P E C F E M 2 D  Version 6.1
+!                   ------------------------------
+!
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
+! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
+!               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
+!               Roland Martin, roland DOT martin aT univ-pau DOT fr
+!               Christina Morency, cmorency aT princeton DOT edu
+!
+! This software is a computer program whose purpose is to solve
+! the two-dimensional viscoelastic anisotropic or poroelastic wave equation
+! using a spectral-element method (SEM).
+!
+! This software is governed by the CeCILL license under French law and
+! abiding by the rules of distribution of free software. You can use,
+! modify and/or redistribute the software under the terms of the CeCILL
+! license as circulated by CEA, CNRS and INRIA at the following URL
+! "http://www.cecill.info".
+!
+! As a counterpart to the access to the source code and rights to copy,
+! modify and redistribute granted by the license, users are provided only
+! with a limited warranty and the software's author, the holder of the
+! economic rights, and the successive licensors have only limited
+! liability.
+!
+! In this respect, the user's attention is drawn to the risks associated
+! with loading, using, modifying and/or developing or reproducing the
+! software by the user in light of its specific status of free software,
+! that may mean that it is complicated to manipulate, and that also
+! therefore means that it is reserved for developers and experienced
+! professionals having in-depth computer knowledge. Users are therefore
+! encouraged to load and test the software's suitability as regards their
+! requirements in conditions enabling the security of their systems and/or
+! data to be ensured and, more generally, to use and operate it in the
+! same conditions as regards security.
+!
+! The full text of the license is available in file "LICENSE".
+!
+!========================================================================
+
       program adj_seismogram
 
 ! This program cuts a certain portion of the seismograms and convert it
@@ -62,8 +106,8 @@
           endif
 
       close(10)
-       
 
+
          istart = max(floor(tstart(irec)/deltat),1)
          iend = min(floor(tend(irec)/deltat),NSTEP)
          print*,'istart =',istart, 'iend =', iend
@@ -125,8 +169,8 @@
       close(11)
 
       enddo
-      print*,'*************************' 
-      print*,'The input files (S****.AA.BHX/BHY/BHZ.adj) needed to run the adjoint simulation are in OUTPUT_FILES' 
-      print*,'*************************' 
+      print*,'*************************'
+      print*,'The input files (S****.AA.BHX/BHY/BHZ.adj) needed to run the adjoint simulation are in OUTPUT_FILES'
+      print*,'*************************'
 
       end program adj_seismogram

Modified: seismo/2D/SPECFEM2D/trunk/assemble_MPI.F90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/assemble_MPI.F90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/assemble_MPI.F90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/attenuation_model.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/attenuation_model.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/attenuation_model.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/checkgrid.F90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/checkgrid.F90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/checkgrid.F90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr
@@ -1363,7 +1363,7 @@
 ! Bisque
   red(236) = 1.00000000000000
   green(236) = 0.894117647058824
-  blue(236) = 0.768627450980392 
+  blue(236) = 0.768627450980392
 
 !---- compute parameters for the spectral elements
 
@@ -1806,7 +1806,7 @@
       zinterp(i,j) = zinterp(i,j) + shapeint(in,i,j)*coorg(2,nnum)
   enddo
   enddo
-  enddo 
+  enddo
 
   is = 1
   ir = 1

Modified: seismo/2D/SPECFEM2D/trunk/compute_Bielak_conditions.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/compute_Bielak_conditions.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/compute_Bielak_conditions.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/compute_arrays_source.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/compute_arrays_source.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/compute_arrays_source.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr
@@ -167,7 +167,7 @@
 
   comp = (/"BHX","BHY","BHZ"/)
 
-  do icomp = 1,3 
+  do icomp = 1,3
 
     filename = 'OUTPUT_FILES/'//trim(adj_source_file) // '.'// comp(icomp) // '.adj'
     open(unit = IIN, file = trim(filename), iostat = ios)

Modified: seismo/2D/SPECFEM2D/trunk/compute_curl_one_element.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/compute_curl_one_element.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/compute_curl_one_element.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,7 +1,7 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
 ! Copyright Universite de Pau et des Pays de l'Adour and CNRS, France.

Modified: seismo/2D/SPECFEM2D/trunk/compute_energy.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/compute_energy.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/compute_energy.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/compute_forces_acoustic.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/compute_forces_acoustic.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/compute_forces_acoustic.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/compute_forces_elastic.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/compute_forces_elastic.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/compute_forces_elastic.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr
@@ -100,7 +100,7 @@
   double precision, dimension(6,numat) :: anisotropy
   real(kind=CUSTOM_REAL), dimension(NGLLX,NGLLZ,nspec) :: xix,xiz,gammax,gammaz,jacobian
   double precision, dimension(NGLLX,NGLLZ,nspec) :: vpext,vsext,rhoext
-  double precision, dimension(NGLLX,NGLLZ,nspec) ::  c11ext,c15ext,c13ext,c33ext,c35ext,c55ext 
+  double precision, dimension(NGLLX,NGLLZ,nspec) ::  c11ext,c15ext,c13ext,c33ext,c35ext,c55ext
 
   real(kind=CUSTOM_REAL), dimension(NSOURCE,NSTEP) :: source_time_function
   real(kind=CUSTOM_REAL), dimension(NSOURCE,NDIM,NGLLX,NGLLZ) :: sourcearray
@@ -163,7 +163,7 @@
   real(kind=CUSTOM_REAL) :: Un,Unp1,tauinv,Sn,Snp1,theta_n,theta_np1,tauinvsquare,tauinvcube,tauinvUn
 
   ! for anisotropy
-  double precision ::  c11,c15,c13,c33,c35,c55 
+  double precision ::  c11,c15,c13,c33,c35,c55
 
   ! for analytical initial plane wave for Bielak's conditions
   double precision :: veloc_horiz,veloc_vert,dxUx,dzUx,dxUz,dzUz,traction_x_t0,traction_z_t0,deltat
@@ -368,7 +368,7 @@
                     c35 = anisotropy(5,kmato(ispec))
                     c55 = anisotropy(6,kmato(ispec))
                  end if
-                 
+
                  ! implement anisotropy in 2D
                  sigma_xx = c11*dux_dxl + c15*(duz_dxl + dux_dzl) + c13*duz_dzl
                  sigma_zz = c13*dux_dxl + c35*(duz_dxl + dux_dzl) + c33*duz_dzl
@@ -528,7 +528,7 @@
               ! Clayton-Engquist condition if elastic
               if(elastic(ispec)) then
                  vx = veloc_elastic(1,iglob) - veloc_horiz
-                 !          vy = veloc_elastic(2,iglob) 
+                 !          vy = veloc_elastic(2,iglob)
                  vz = veloc_elastic(3,iglob) - veloc_vert
 
                  vn = nx*vx+nz*vz
@@ -619,7 +619,7 @@
               ! Clayton-Engquist condition if elastic
               if(elastic(ispec)) then
                  vx = veloc_elastic(1,iglob) - veloc_horiz
-                 vy = veloc_elastic(2,iglob) 
+                 vy = veloc_elastic(2,iglob)
                  vz = veloc_elastic(3,iglob) - veloc_vert
 
                  vn = nx*vx+nz*vz
@@ -716,7 +716,7 @@
               ! Clayton-Engquist condition if elastic
               if(elastic(ispec)) then
                  vx = veloc_elastic(1,iglob) - veloc_horiz
-                 vy = veloc_elastic(2,iglob) 
+                 vy = veloc_elastic(2,iglob)
                  vz = veloc_elastic(3,iglob) - veloc_vert
 
                  vn = nx*vx+nz*vz
@@ -805,7 +805,7 @@
               ! Clayton-Engquist condition if elastic
               if(elastic(ispec)) then
                  vx = veloc_elastic(1,iglob) - veloc_horiz
-                 vy = veloc_elastic(2,iglob) 
+                 vy = veloc_elastic(2,iglob)
                  vz = veloc_elastic(3,iglob) - veloc_vert
 
                  vn = nx*vx+nz*vz
@@ -854,7 +854,7 @@
            ! moment tensor
            if(source_type(i_source) == 2) then
 
-              if(.not.p_sv)  call exit_MPI('cannot have moment tensor source in SH (membrane) waves calculation')  
+              if(.not.p_sv)  call exit_MPI('cannot have moment tensor source in SH (membrane) waves calculation')
 
               if(isolver == 1) then  ! forward wavefield
                  ! add source array

Modified: seismo/2D/SPECFEM2D/trunk/compute_gradient_attenuation.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/compute_gradient_attenuation.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/compute_gradient_attenuation.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/compute_pressure.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/compute_pressure.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/compute_pressure.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr
@@ -190,7 +190,7 @@
   real(kind=CUSTOM_REAL) :: mul_G,lambdal_G,lambdalplus2mul_G
 
 ! for anisotropy
-  double precision ::  c11,c15,c13,c33,c35,c55 
+  double precision ::  c11,c15,c13,c33,c35,c55
 
 ! if elastic element
 !

Modified: seismo/2D/SPECFEM2D/trunk/compute_vector_field.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/compute_vector_field.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/compute_vector_field.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/construct_acoustic_surface.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/construct_acoustic_surface.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/construct_acoustic_surface.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/convolve_source_timefunction.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/convolve_source_timefunction.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/convolve_source_timefunction.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/create_color_image.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/create_color_image.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/create_color_image.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/createnum_fast.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/createnum_fast.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/createnum_fast.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/createnum_slow.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/createnum_slow.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/createnum_slow.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/datim.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/datim.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/datim.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/define_derivation_matrices.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/define_derivation_matrices.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/define_derivation_matrices.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/define_external_model.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/define_external_model.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/define_external_model.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr
@@ -41,8 +41,8 @@
 ! The full text of the license is available in file "LICENSE".
 !
 !========================================================================
- 
 
+
   subroutine define_external_model(x,y,iflag_element,myrank,rho,vp,vs,Qp_attenuation,&
        Qs_attenuation,c11,c13,c15,c33,c35,c55 )
 
@@ -59,7 +59,7 @@
 
   double precision, intent(out) :: rho,vp,vs
   double precision, intent(out) :: Qp_attenuation,Qs_attenuation
-  double precision, intent(out) :: c11,c15,c13,c33,c35,c55 
+  double precision, intent(out) :: c11,c15,c13,c33,c35,c55
 
 ! dummy routine here, just to demonstrate how the model can be assigned
    if(myrank == 0 .and. iflag_element == 1 .or. x < 1700.d0 .or. y >= 2300.d0) then
@@ -73,7 +73,7 @@
      c15 = 0.d0
      c33 = c11
      c35 = 0.d0
-     c55 = 75.3d9 
+     c55 = 75.3d9
    else
      rho = 2500.d0
      vp = 3600.d0
@@ -85,7 +85,7 @@
      c15 = 0.d0
      c33 = 0.d0
      c35 = 0.d0
-     c55 = 0.d0 
+     c55 = 0.d0
    endif
 
   end subroutine define_external_model

Modified: seismo/2D/SPECFEM2D/trunk/define_shape_functions.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/define_shape_functions.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/define_shape_functions.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/enforce_acoustic_free_surface.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/enforce_acoustic_free_surface.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/enforce_acoustic_free_surface.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/get_perm_cuthill_mckee.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/get_perm_cuthill_mckee.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/get_perm_cuthill_mckee.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/get_poroelastic_velocities.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/get_poroelastic_velocities.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/get_poroelastic_velocities.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,10 +1,10 @@
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr
@@ -62,32 +62,32 @@
   double precision :: a_r,a_i,b_r,b_i,cc,alpha,aa1,aa2
   double precision :: xx,yy, gXI, gYI,gXII,gYII,w_c,f_c
   double precision :: wi,fi,taus,taue,Q0,bbr,bbi
-  
-  double precision :: gA,gB,sa,sb,xxs,yys  
+
+  double precision :: gA,gB,sa,sb,xxs,yys
   logical :: TURN_VISCATTENUATION_ON
 
     rhol_bar =  (1.d0 - phil)*rhol_s + phil*rhol_f
 
     w_c = etal_f*phil/(tortl*rhol_f*perm)
-    f_c = w_c/(2*pi) 
+    f_c = w_c/(2*pi)
 
-    wi=2.d0*pi*fi                                                        
+    wi=2.d0*pi*fi
 
     alpha=10.d0**dlog10(wi)
     w0il =  2.d0*pi*f0
     taue = (sqrt(Q0*Q0+1) +1)/(w0il*Q0)
     taus = (sqrt(Q0*Q0+1) -1)/(w0il*Q0)
 
-     if(TURN_VISCATTENUATION_ON) then              
+     if(TURN_VISCATTENUATION_ON) then
 ! high frequency, with memory variables
     bbr = etal_f/perm*(1.d0+alpha*alpha*taus*taue)/(1.d0 + alpha*alpha*taus*taus)
     bbi = etal_f/perm*alpha*(taue-taus)/(1.d0 + alpha*alpha*taus*taus)
      else
-! low frequency   
+! low frequency
     bbr = etal_f/perm
     bbi = 0.d0
      endif
- 
+
 ! cs
      gA = (rhol_f*tortl*rhol_bar-phil*rhol_f**2)**2/(phil*rhol_bar)**2 - (bbr**2-bbi**2)/alpha**2*&
           (phil*rhol_f/(rhol_bar*tortl) -1.d0) - bbi/alpha*phil*rhol_f/(rhol_bar*tortl)*&
@@ -100,7 +100,7 @@
 !
      xxs = sa*gA + sb*gB
      yys = gA*sb - sa*gB
-    
+
      cssquare = mul_fr/(rhol_bar-phil*rhol_f/tortl) * 2.d0*(gA**2+gB**2)/(sqrt(xxs**2+yys**2)+xxs)
 
 

Modified: seismo/2D/SPECFEM2D/trunk/gmat01.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/gmat01.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/gmat01.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr
@@ -66,7 +66,7 @@
   double precision cpIsquare,cpIIsquare,cssquare,mu_s,mu_fr,eta_f,lambda_s,lambda_fr
   double precision val1,val2,val3,val4,val5,val6
   double precision val7,val8,val9,val10,val11,val12,val0
-  double precision ::  c11,c13,c15,c33,c35,c55 
+  double precision ::  c11,c13,c15,c33,c35,c55
   double precision D_biot,H_biot,C_biot,M_biot
   double precision f0,Q0,freq0,w_c
   logical  TURN_VISCATTENUATION_ON
@@ -159,7 +159,7 @@
         young = 9.d0*kappa*mu/(3.d0*kappa + mu)
 
         ! Poisson's ratio
-        poisson = half*(3.d0*kappa-two_mu)/(3.d0*kappa+mu)      
+        poisson = half*(3.d0*kappa-two_mu)/(3.d0*kappa+mu)
 
         !---- isotropic material, moduli are given, allows for declaration of poroelastic material
         !---- poroelastic (<0phi<1)
@@ -242,7 +242,7 @@
         poroelastcoef(2,1,n) = mu
         poroelastcoef(3,1,n) = lambdaplus2mu
         poroelastcoef(4,1,n) = zero
-        aniso_array(1,n) = c11  
+        aniso_array(1,n) = c11
         aniso_array(2,n) = c13
         aniso_array(3,n) = c15
         aniso_array(4,n) = c33

Modified: seismo/2D/SPECFEM2D/trunk/invert_mass_matrix.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/invert_mass_matrix.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/invert_mass_matrix.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/is_in_convex_quadrilateral.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/is_in_convex_quadrilateral.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/is_in_convex_quadrilateral.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/lagrange_poly.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/lagrange_poly.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/lagrange_poly.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/locate_receivers.F90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/locate_receivers.F90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/locate_receivers.F90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/locate_source_force.F90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/locate_source_force.F90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/locate_source_force.F90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/locate_source_moment_tensor.F90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/locate_source_moment_tensor.F90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/locate_source_moment_tensor.F90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/meshfem2D.F90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/meshfem2D.F90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/meshfem2D.F90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr
@@ -278,7 +278,7 @@
 
   double precision :: Q0,freq0
 
-  logical :: p_sv 
+  logical :: p_sv
 
   logical, dimension(:), allocatable :: enreg_surf
 
@@ -739,7 +739,7 @@
   allocate(aniso5(nb_materials))
   allocate(aniso6(nb_materials))
   allocate(aniso7(nb_materials))
-  allocate(aniso8(nb_materials))  
+  allocate(aniso8(nb_materials))
   allocate(Qp(nb_materials))
   allocate(Qs(nb_materials))
   allocate(rho_s(nb_materials))
@@ -811,9 +811,9 @@
         aniso3(i) = val3read
         aniso4(i) = val4read
         aniso5(i) = val5read
-        aniso6(i) = val6read      
+        aniso6(i) = val6read
         aniso7(i) = val7read
-        aniso8(i) = val8read 
+        aniso8(i) = val8read
         Qp(i) = val9read
         Qs(i) = val10read
      else                 ! poroelastic
@@ -935,9 +935,9 @@
            print *,'c11 = ',aniso3(imaterial_number)
            print *,'c13 = ',aniso4(imaterial_number)
            print *,'c15 = ',aniso5(imaterial_number)
-           print *,'c33 = ',aniso6(imaterial_number)           
+           print *,'c33 = ',aniso6(imaterial_number)
            print *,'c35 = ',aniso7(imaterial_number)
-           print *,'c55 = ',aniso8(imaterial_number)         
+           print *,'c55 = ',aniso8(imaterial_number)
            print *,'rho = ',rho_s(imaterial_number)
            print *,'Qp = ',Qp(imaterial_number)
            print *,'Qs = ',Qs(imaterial_number)

Modified: seismo/2D/SPECFEM2D/trunk/part_unstruct.F90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/part_unstruct.F90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/part_unstruct.F90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr
@@ -1032,7 +1032,7 @@
        jend_left(:) = NGLLZ
 
         is_acoustic(:) = .false.
- 
+
         do i = 1, nb_materials
            if (phi_material(i) >= 1.d0) then
               is_acoustic(i) = .true.

Modified: seismo/2D/SPECFEM2D/trunk/plotgll.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/plotgll.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/plotgll.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/plotpost.F90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/plotpost.F90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/plotpost.F90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/read_external_model.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/read_external_model.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/read_external_model.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr
@@ -48,7 +48,7 @@
                 elastic,poroelastic,anisotropic,nspec,npoin,N_SLS,ibool, &
                 f0_attenuation,inv_tau_sigma_nu1_sent,phi_nu1_sent, &
                 inv_tau_sigma_nu2_sent,phi_nu2_sent,Mu_nu1_sent,Mu_nu2_sent, &
-                inv_tau_sigma_nu1,inv_tau_sigma_nu2,phi_nu1,phi_nu2,Mu_nu1,Mu_nu2,& 
+                inv_tau_sigma_nu1,inv_tau_sigma_nu2,phi_nu1,phi_nu2,Mu_nu1,Mu_nu2,&
                 coord,kmato,myrank,rhoext,vpext,vsext, &
                 Qp_attenuationext,Qs_attenuationext,c11ext,c13ext,c15ext,c33ext,c35ext,c55ext)
 
@@ -58,7 +58,7 @@
 integer :: nspec,myrank,npoin
 double precision  :: f0_attenuation
 
-! Mesh 
+! Mesh
 integer, dimension(NGLLX,NGLLZ,nspec) :: ibool
 double precision, dimension(NDIM,npoin) :: coord
 

Modified: seismo/2D/SPECFEM2D/trunk/read_value_parameters.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/read_value_parameters.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/read_value_parameters.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/recompute_jacobian.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/recompute_jacobian.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/recompute_jacobian.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/setup_sources_receivers.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/setup_sources_receivers.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/setup_sources_receivers.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr
@@ -61,11 +61,11 @@
   integer :: npgeo,ngnod,myrank,ipass,nproc
   integer :: npoin,nspec,nelem_acoustic_surface
 
-  ! Gauss-Lobatto-Legendre points 
+  ! Gauss-Lobatto-Legendre points
   double precision, dimension(NGLLX) :: xigll
   double precision, dimension(NGLLZ) :: zigll
 
-  ! for receivers 
+  ! for receivers
   integer  :: nrec,nrecloc
   integer, dimension(nrec) :: recloc, which_proc_receiver
   integer, dimension(nrec) :: ispec_selected_rec
@@ -78,7 +78,7 @@
 
   ! for sources
   integer, dimension(NSOURCE) :: source_type
-  integer, dimension(NSOURCE) :: ispec_selected_source,is_proc_source,nb_proc_source  
+  integer, dimension(NSOURCE) :: ispec_selected_source,is_proc_source,nb_proc_source
   real(kind=CUSTOM_REAL), dimension(NSOURCE,NDIM,NGLLX,NGLLZ) :: sourcearray
   double precision, dimension(NSOURCE) :: x_source,z_source,xi_source,gamma_source,Mxx,Mzz,Mxz
 

Modified: seismo/2D/SPECFEM2D/trunk/specfem2D.F90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/specfem2D.F90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/specfem2D.F90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr
@@ -213,8 +213,8 @@
 ! This is the reason why a simple displacement potential u = grad(Chi) would
 ! not work because it would be discontinuous at such an interface and would
 ! therefore not be consistent with the basis functions.
-  
 
+
   program specfem2D
 
   implicit none
@@ -295,7 +295,7 @@
 
 ! anisotropy parameters
   logical :: all_anisotropic
-  double precision ::  c11,c13,c15,c33,c35,c55 
+  double precision ::  c11,c13,c15,c33,c35,c55
   logical, dimension(:), allocatable :: anisotropic
   double precision, dimension(:,:), allocatable :: anisotropy
 
@@ -318,9 +318,9 @@
 
   double precision, dimension(:), allocatable :: vp_display
 
-  double precision, dimension(:,:,:), allocatable :: vpext,vsext,rhoext     
-  double precision, dimension(:,:,:), allocatable :: Qp_attenuationext,Qs_attenuationext      
-  double precision, dimension(:,:,:), allocatable :: c11ext,c13ext,c15ext,c33ext,c35ext,c55ext    
+  double precision, dimension(:,:,:), allocatable :: vpext,vsext,rhoext
+  double precision, dimension(:,:,:), allocatable :: Qp_attenuationext,Qs_attenuationext
+  double precision, dimension(:,:,:), allocatable :: c11ext,c13ext,c15ext,c33ext,c35ext,c55ext
 
   double precision, dimension(:,:,:), allocatable :: shape2D,shape2D_display
   real(kind=CUSTOM_REAL), dimension(:,:,:), allocatable  :: xix,xiz,gammax,gammaz,jacobian
@@ -1064,8 +1064,8 @@
   print*, '*************** WARNING ***************'
   stop
   endif
-  
 
+
   if(TURN_ATTENUATION_ON) then
     nspec_allocate = nspec
   else
@@ -1231,7 +1231,7 @@
        allocate(b_absorb_elastic_left(1,1,1,1))
        allocate(b_absorb_elastic_right(1,1,1,1))
        allocate(b_absorb_elastic_bottom(1,1,1,1))
-       allocate(b_absorb_elastic_top(1,1,1,1)) 
+       allocate(b_absorb_elastic_top(1,1,1,1))
      endif
      if(any_poroelastic .and. (save_forward .or. isolver == 2)) then
        allocate(b_absorb_poro_s_left(NDIM,NGLLZ,nspec_xmin,NSTEP))
@@ -1250,7 +1250,7 @@
        allocate(b_absorb_poro_w_left(1,1,1,1))
        allocate(b_absorb_poro_w_right(1,1,1,1))
        allocate(b_absorb_poro_w_bottom(1,1,1,1))
-       allocate(b_absorb_poro_w_top(1,1,1,1))      
+       allocate(b_absorb_poro_w_top(1,1,1,1))
      endif
      if(any_acoustic .and. (save_forward .or. isolver == 2)) then
        allocate(b_absorb_acoustic_left(NGLLZ,nspec_xmin,NSTEP))
@@ -1279,7 +1279,7 @@
     allocate(b_absorb_elastic_left(1,1,1,1))
     allocate(b_absorb_elastic_right(1,1,1,1))
     allocate(b_absorb_elastic_bottom(1,1,1,1))
-    allocate(b_absorb_elastic_top(1,1,1,1)) 
+    allocate(b_absorb_elastic_top(1,1,1,1))
     allocate(b_absorb_poro_s_left(1,1,1,1))
     allocate(b_absorb_poro_s_right(1,1,1,1))
     allocate(b_absorb_poro_s_bottom(1,1,1,1))
@@ -1287,7 +1287,7 @@
     allocate(b_absorb_poro_w_left(1,1,1,1))
     allocate(b_absorb_poro_w_right(1,1,1,1))
     allocate(b_absorb_poro_w_bottom(1,1,1,1))
-    allocate(b_absorb_poro_w_top(1,1,1,1))   
+    allocate(b_absorb_poro_w_top(1,1,1,1))
     allocate(b_absorb_acoustic_left(1,1,1))
     allocate(b_absorb_acoustic_right(1,1,1))
     allocate(b_absorb_acoustic_bottom(1,1,1))
@@ -1748,17 +1748,17 @@
                 elastic,poroelastic,anisotropic,nspec,npoin,N_SLS,ibool, &
                 f0_attenuation,inv_tau_sigma_nu1_sent,phi_nu1_sent, &
                 inv_tau_sigma_nu2_sent,phi_nu2_sent,Mu_nu1_sent,Mu_nu2_sent, &
-                inv_tau_sigma_nu1,inv_tau_sigma_nu2,phi_nu1,phi_nu2,Mu_nu1,Mu_nu2,& 
+                inv_tau_sigma_nu1,inv_tau_sigma_nu2,phi_nu1,phi_nu2,Mu_nu1,Mu_nu2,&
                 coord,kmato,myrank,rhoext,vpext,vsext, &
                 Qp_attenuationext,Qs_attenuationext,c11ext,c13ext,c15ext,c33ext,c35ext,c55ext)
         end if
 
     if(count(anisotropic(:) .eqv. .true.) == nspec) all_anisotropic = .true.
-    if(all_anisotropic .and. anyabs) stop 'Cannot put absorbing boundaries if anisotropic materials along edges' 
+    if(all_anisotropic .and. anyabs) stop 'Cannot put absorbing boundaries if anisotropic materials along edges'
     if(TURN_ATTENUATION_ON .and. all_anisotropic) then
-       stop 'Cannot turn attenuation on in anisotropic materials'   
+       stop 'Cannot turn attenuation on in anisotropic materials'
     end if
- 
+
 !
 !----  perform basic checks on parameters read
 !
@@ -4430,7 +4430,7 @@
       cssquare = mul_fr/afactor
 
 ! Approximated ratio r = amplitude "w" field/amplitude "s" field (no viscous dissipation)
-! used later for wavespeed kernels calculation, which are presently implemented for inviscid case, 
+! used later for wavespeed kernels calculation, which are presently implemented for inviscid case,
 ! contrary to primary and density-normalized kernels, which are consistent with viscous fluid case.
       gamma1 = H_biot - phil/tortl*C_biot
       gamma2 = C_biot - phil/tortl*M_biot
@@ -5150,7 +5150,7 @@
           adj_sourcearrays(irec_local,NSTEP-it+1,1,i,j)
         enddo
       enddo
-      endif ! if element acoustic 
+      endif ! if element acoustic
 
       endif ! if this processor carries the adjoint source
       enddo ! irec = 1,nrec
@@ -5194,7 +5194,7 @@
                deltatfourth,twelvedeltat,fourdeltatsquare,ibool,kmato,numabs,elastic,codeabs, &
                accel_elastic,veloc_elastic,displ_elastic,b_accel_elastic,b_displ_elastic, &
                density,poroelastcoef,xix,xiz,gammax,gammaz, &
-               jacobian,vpext,vsext,rhoext,c11ext,c13ext,c15ext,c33ext,c35ext,c55ext,anisotropic,anisotropy, & 
+               jacobian,vpext,vsext,rhoext,c11ext,c13ext,c15ext,c33ext,c35ext,c55ext,anisotropic,anisotropy, &
                source_time_function,sourcearray,adj_sourcearrays, &
                e1,e11,e13,dux_dxl_n,duz_dzl_n,duz_dxl_n,dux_dzl_n, &
                dux_dxl_np1,duz_dzl_np1,duz_dxl_np1,dux_dzl_np1,hprime_xx,hprimewgll_xx, &
@@ -5211,7 +5211,7 @@
 !--- left absorbing boundary
       if(nspec_xmin >0) then
       do ispec = 1,nspec_xmin
-      
+
       if(p_sv)then!P-SV waves
          do i=1,NGLLZ
      write(35) b_absorb_elastic_left(1,i,ispec,it)
@@ -7145,7 +7145,7 @@
         zz = coord(2,iglob)
          write(97,'(5e11.3)')xx,zz,rho_kl(i,j,ispec),kappa_kl(i,j,ispec),mu_kl(i,j,ispec)
          write(98,'(5e11.3)')rhorho_el_hessian_final1(i,j,ispec), rhorho_el_hessian_final2(i,j,ispec),&
-                             rhop_kl(i,j,ispec),alpha_kl(i,j,ispec),beta_kl(i,j,ispec)     
+                             rhop_kl(i,j,ispec),alpha_kl(i,j,ispec),beta_kl(i,j,ispec)
           enddo
       enddo
     enddo
@@ -7350,7 +7350,7 @@
     call compute_pressure_whole_medium(potential_dot_dot_acoustic,displ_elastic,&
          displs_poroelastic,displw_poroelastic,elastic,poroelastic,vector_field_display, &
          xix,xiz,gammax,gammaz,ibool,hprime_xx,hprime_zz,nspec,npoin,assign_external_model, &
-         numat,kmato,density,porosity,tortuosity,poroelastcoef,vpext,vsext,rhoext, & 
+         numat,kmato,density,porosity,tortuosity,poroelastcoef,vpext,vsext,rhoext, &
          c11ext,c13ext,c15ext,c33ext,c35ext,c55ext,e1,e11, &
          TURN_ATTENUATION_ON,Mu_nu1,Mu_nu2,N_SLS)
 
@@ -7572,7 +7572,7 @@
     write(IENERGY,*) 'plot "energy.gnu" us 1:4 t ''Total Energy'' w l 1, "energy.gnu" us 1:3 t ''Potential Energy'' w l 2'
     close(IENERGY)
   endif
- 
+
    if (.not. any_poroelastic) then
 open(unit=1001,file='DATA/model_velocity.dat_output',status='unknown')
    if ( .NOT. assign_external_model) then
@@ -7580,7 +7580,7 @@
 allocate(rho_local(ngllx,ngllz,nspec)); rho_local=0.
 allocate(vp_local(ngllx,ngllz,nspec)); vp_local=0.
 allocate(vs_local(ngllx,ngllz,nspec)); vs_local=0.
-!!      write(1001,*) npoin 
+!!      write(1001,*) npoin
 !!      do iglob = 1,npoin
 !!         write(1001,*) coord(1,iglob),coord(2,iglob),rho_global(iglob),vp_global(iglob),vs_global(iglob)
 !!      end do
@@ -7598,7 +7598,7 @@
     end do
    else
      print *, 'writing model_output as external_model == .true.!!!!!!!!!!!!!!!!!!!!!!!!'
-!!     write(1001,*) npoin 
+!!     write(1001,*) npoin
 !!  do iglob = 1,npoin
 !!     write(1001,*) coord(1,iglob),coord(2,iglob),rhoext_global(iglob),vpext_global(iglob),vsext_global(iglob)
 !!  end do

Modified: seismo/2D/SPECFEM2D/trunk/spline_routines.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/spline_routines.f90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/spline_routines.f90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr

Modified: seismo/2D/SPECFEM2D/trunk/write_seismograms.F90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/write_seismograms.F90	2010-03-13 13:18:46 UTC (rev 16414)
+++ seismo/2D/SPECFEM2D/trunk/write_seismograms.F90	2010-03-13 13:23:19 UTC (rev 16415)
@@ -1,11 +1,11 @@
 
 !========================================================================
 !
-!                   S P E C F E M 2 D  Version 6.0
+!                   S P E C F E M 2 D  Version 6.1
 !                   ------------------------------
 !
-! Copyright Universite de Pau et des Pays de l'Adour, CNRS and INRIA, France,
-! and Princeton University, USA.
+! Copyright Universite de Pau, CNRS and INRIA, France,
+! and Princeton University / California Institute of Technology, USA.
 ! Contributors: Dimitri Komatitsch, dimitri DOT komatitsch aT univ-pau DOT fr
 !               Nicolas Le Goff, nicolas DOT legoff aT univ-pau DOT fr
 !               Roland Martin, roland DOT martin aT univ-pau DOT fr



More information about the CIG-COMMITS mailing list