[cig-commits] r21727 - in seismo/2D/SPECFEM2D/trunk/EXAMPLES: . LuoYang_fluid_soild_kernel

xie.zhinan at geodynamics.org xie.zhinan at geodynamics.org
Fri Apr 5 01:49:39 PDT 2013


Author: xie.zhinan
Date: 2013-04-05 01:49:39 -0700 (Fri, 05 Apr 2013)
New Revision: 21727

Added:
   seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/
   seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/Par_file
   seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/README
   seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/SOURCE
   seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/adj_source.f90
   seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/interfaces.dat
   seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/plot_kernel
   seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/process.sh
   seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/process_kernel.sh
   seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/rho_kappa kernel.png
Log:
commit one example fluid_solid kernel example provided by Luo Yang


Added: seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/Par_file
===================================================================
--- seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/Par_file	                        (rev 0)
+++ seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/Par_file	2013-04-05 08:49:39 UTC (rev 21727)
@@ -0,0 +1,170 @@
+# title of job
+title                           = Test
+
+# forward or adjoint simulation
+SIMULATION_TYPE                 = 1   # 1 = forward, 2 = adjoint + kernels
+NOISE_TOMOGRAPHY                = 0   # 0 = earthquake simulation, 1/2/3 = noise simulation
+SAVE_FORWARD                    = .true.  # save the last frame, needed for adjoint simulation
+
+# parameters concerning partitioning
+nproc                           = 1              # number of processes
+partitioning_method             = 3              # SCOTCH = 3, ascending order (very bad idea) = 1
+PERFORM_CUTHILL_MCKEE           = .false.        # perform inverse Cuthill-McKee (1969) optimization/permutation for mesh numbering (can be very costly and not very useful)
+
+ngnod                           = 9              # number of control nodes per element (4 or 9)
+initialfield                    = .false.        # use a plane wave as source or not
+add_Bielak_conditions           = .false.        # add Bielak conditions or not if initial plane wave
+assign_external_model           = .false.        # define external earth model or not
+READ_EXTERNAL_SEP_FILE          = .false.        # Read external model from DATA/model_velocity.dat_input, or use routine
+ATTENUATION_VISCOELASTIC_SOLID  = .false.        # turn attenuation (viscoelasticity) on or off for non-poroelastic solid parts of the model
+ATTENUATION_PORO_FLUID_PART     = .false.        # turn viscous attenuation on or off for the fluid part of poroelastic parts of the model
+Q0                              =  1             # quality factor for viscous attenuation
+freq0                           =  10            # frequency for viscous attenuation
+p_sv                            = .true.         # set the type of calculation (P-SV or SH/membrane waves)
+
+# time step parameters
+nt                              = 1600           # total number of time steps
+deltat                          = 1.1d-3         # duration of a time step (see section "How to choose the time step" of the manual for how to do this)
+USER_T0                         = 0.0d0          # use this t0 as earliest starting time rather than the automatically calculated one
+time_stepping_scheme            = 1              # 1 = Newmark (2nd order), 2 = LDDRK4-6 (4th-order 6-stage low storage Runge-Kutta), 3 = classical RK4 4th-order 4-stage Runge-Kutta
+
+# source parameters
+NSOURCES                        = 1              # number of sources (source info read from DATA/CMTSOLUTION file)
+force_normal_to_surface         = .false.        # angleforce normal to surface (external mesh and curve file needed)
+
+# constants for attenuation
+N_SLS                           = 2                      # number of standard linear solids for attenuation
+f0_attenuation                  = 5.196152422706633      # (Hz) relevant only if source is a Dirac or a Heaviside, otherwise it is f0 the dominant frequency of the source in the CMTSOLUTION file
+
+# receiver set parameters for seismograms
+seismotype                      = 6              # record 1=displ 2=veloc 3=accel 4=pressure 5=curl of displ 6=the fluid potential
+NSTEP_BETWEEN_OUTPUT_SEISMOS    = 5000000        # every how many time steps we save the seismograms (costly, do not use a very small value; if you use a very large value that is larger than the total number of time steps of the run, the seismograms will automatically be saved once at the end of the run anyway)
+save_ASCII_seismograms          = .true.         # save seismograms in ASCII format or not
+save_binary_seismograms_single  = .true.         # save seismograms in single precision binary format or not (can be used jointly with ASCII above to save both)
+save_binary_seismograms_double  = .false.        # save seismograms in double precision binary format or not (can be used jointly with both flags above to save all)
+SU_FORMAT                       = .false.        # output single precision binary seismograms in Seismic Unix format (adjoint traces will be read in the same format)
+subsamp_seismos                 = 1              # subsampling of the seismograms to create smaller files (but less accurately sampled in time)
+use_existing_STATIONS           = .false.        # use an existing STATION file found in ./DATA or create a new one from the receiver positions below in this Par_file
+nreceiversets                   = 1              # number of receiver sets
+anglerec                        = 0.d0           # angle to rotate components at receivers
+rec_normal_to_surface           = .false.        # base anglerec normal to surface (external mesh and curve file needed)
+
+# first receiver set (repeat these 6 lines and adjust nreceiversets accordingly)
+nrec                            = 1              # number of receivers
+xdeb                            = 1000.           # first receiver x in meters
+zdeb                            = 1500.          # first receiver z in meters
+xfin                            = 1000.          # last receiver x in meters (ignored if onlyone receiver)
+zfin                            = 1500.          # last receiver z in meters (ignored if onlyone receiver)
+enreg_surf_same_vertical        = .false.         # receivers inside the medium or at the surface
+
+# display parameters
+NSTEP_BETWEEN_OUTPUT_INFO       = 100            # every how many time steps we display information about the simulation (costly, do not use a very small value)
+####
+NSTEP_BETWEEN_OUTPUT_IMAGES     = 100            # every how many time steps we draw JPEG or PostScript pictures of the simulation (costly, do not use a very small value)
+cutsnaps                        = 1.             # minimum amplitude kept in % for the JPEG and PostScript snapshots; amplitudes below that are muted
+#### for JPEG color images ####
+output_color_image              = .true.         # output JPEG color image of the results every NSTEP_BETWEEN_OUTPUT_IMAGES time steps or not
+imagetype_JPEG                  = 10              # display 1=displ_Ux 2=displ_Uz 3=displ_norm 4=veloc_Vx 5=veloc_Vz 6=veloc_norm 7=accel_Ax 8=accel_Az 9=accel_norm 10=pressure
+factor_subsample_image          = 1.0              # (double precision) factor to subsample color images output by the code (useful for very large models)
+POWER_DISPLAY_COLOR             = 0.30d0         # non linear display to enhance small amplitudes in JPEG color images
+DRAW_SOURCES_AND_RECEIVERS      = .true.         # display sources as orange crosses and receivers as green squares in JPEG images or not
+DRAW_WATER_IN_BLUE              = .true.         # display acoustic layers as constant blue in JPEG images, because they likely correspond to water in the case of ocean acoustics or in the case of offshore oil industry experiments (if off, display them as greyscale, as for elastic or poroelastic elements, for instance for acoustic-only oil industry models of solid media)
+USE_SNAPSHOT_NUMBER_IN_FILENAME = .false.        # use snapshot number in the file name of JPEG color snapshots instead of the time step (for instance to create movies in an easier way later)
+#### for PostScript snapshots ####
+output_postscript_snapshot      = .false.         # output Postscript snapshot of the results every NSTEP_BETWEEN_OUTPUT_IMAGES time steps or not
+imagetype_postscript            = 1              # display 1=displ vector 2=veloc vector 3=accel vector; small arrows are displayed for the vectors
+meshvect                        = .true.         # display mesh on PostScript plots or not
+modelvect                       = .false.        # display velocity model on PostScript plots or not
+boundvect                       = .true.         # display boundary conditions on PostScript plots or not
+interpol                        = .true.         # interpolation of the PostScript display on a regular grid inside each spectral element, or use the non-evenly spaced GLL points
+pointsdisp                      = 6              # number of points in each direction for interpolation of PostScript snapshots (set to 1 for lower-left corner only)
+subsamp_postscript              = 1              # subsampling of background velocity model in PostScript snapshots
+sizemax_arrows                  = 1.d0           # maximum size of arrows on PostScript plots in centimeters
+US_LETTER                       = .false.        # use US letter or European A4 paper for PostScript plots
+####
+NSTEP_BETWEEN_OUTPUT_WAVE_DUMPS = 100            # every how many time steps we dump results of the simulation as ASCII or binary files (costly, do not use a very small value)
+output_wavefield_dumps          = .false.        # output wave field to a text file every NSTEP_BETWEEN_OUTPUT_TEXT_DUMPS time steps (creates very big files)
+imagetype_wavefield_dumps       = 1              # display 1=displ vector 2=veloc vector 3=accel vector 4=pressure
+use_binary_for_wavefield_dumps  = .false.        # use ASCII or single-precision binary format for the wave field dumps
+####
+output_grid_Gnuplot             = .false.        # generate a GNUPLOT file containing the grid, and a script to plot it
+output_grid_ASCII               = .false.        # dump the grid in an ASCII text file consisting of a set of X,Y,Z points or not
+output_energy                   = .false.        # compute and output total acoustic and elastic energy curves (slows down the code significantly)
+
+# velocity and density models
+nbmodels                        = 4              # nb of different models
+# define models as
+# I:   (model_number 1 rho Vp Vs 0 0 QKappa Qmu 0 0 0 0 0 0) or
+# II:  (model_number 2 rho c11 c13 c15 c33 c35 c55 0 0 0 0 0 0) or
+# III: (model_number 3 rhos rhof phi c kxx kxz kzz Ks Kf Kfr etaf mufr Qmu).
+#
+# For istropic elastic/acoustic material use I and set Vs to zero to make a given model acoustic, for anisotropic elastic use II,
+# and for isotropic poroelastic material use III. The mesh can contain acoustic, elastic, and poroelastic models simultaneously.
+#
+# For anisotropic media in the most general 2D case we have the following convention for the stress-strain relationship:
+# ! implement anisotropy in 2D
+# sigma_xx = c11*dux_dx + c15*(duz_dx + dux_dz) + c13*duz_dz
+# sigma_zz = c13*dux_dx + c35*(duz_dx + dux_dz) + c33*duz_dz
+# sigma_xz = c15*dux_dx + c55*(duz_dx + dux_dz) + c35*duz_dz
+# where the notations are for instance duz_dx = d(Uz) / dx.
+#
+1 1 2700.d0 3000.d0 1732.051d0 0 0 9999 9999 0 0 0 0 0 0
+2 1 2500.d0 2700.d0 0 0 0 9999 9999 0 0 0 0 0 0
+3 1 2200.d0 2500.d0 1443.375d0 0 0 9999 9999 0 0 0 0 0 0
+4 1 2200.d0 2200.d0 1343.375d0 0 0 9999 9999 0 0 0 0 0 0
+
+# external mesh or not
+read_external_mesh              = .false.
+
+# absorbing boundary active or not
+PML_BOUNDARY_CONDITIONS         = .false.
+NELEM_PML_THICKNESS             = 3
+ROTATE_PML_ACTIVATE             = .false.
+ROTATE_PML_ANGLE                = 30.
+STACEY_ABSORBING_CONDITIONS     = .false.
+ADD_SPRING_TO_STACEY            = .false.
+
+# for horizontal periodic conditions: detect common points between left and right edges
+ADD_PERIODIC_CONDITIONS         = .false.
+
+# horizontal periodicity distance for periodic conditions
+PERIODIC_horiz_dist             = 0.3597d0
+
+# grid point detection tolerance for periodic conditions
+PERIODIC_DETECT_TOL             = 3.3334d-6
+
+#-----------------------------------------------------------------------------
+# PARAMETERS FOR EXTERNAL MESHING
+
+# data concerning mesh, when generated using third-party app (more info in README)
+# (see also absorbing_conditions above)
+mesh_file                       = ./DATA/Mesh_canyon/canyon_mesh_file   # file containing the mesh
+nodes_coords_file               = ./DATA/Mesh_canyon/canyon_nodes_coords_file   # file containing the nodes coordinates
+materials_file                  = ./DATA/Mesh_canyon/canyon_materials_file   # file containing the material number for each element
+free_surface_file               = ./DATA/Mesh_canyon/canyon_free_surface_file   # file containing the free surface
+absorbing_surface_file          = ./DATA/Mesh_canyon/canyon_absorbing_surface_file   # file containing the absorbing surface
+CPML_element_file               = Elements_CPML_list  # file containing the CPML element numbers
+tangential_detection_curve_file = ./DATA/courbe_eros_nodes # file containing the curve delimiting the velocity model
+
+#-----------------------------------------------------------------------------
+# PARAMETERS FOR INTERNAL MESHING
+
+# file containing interfaces for internal mesh
+interfacesfile                  = ./interfaces.dat
+
+# geometry of the model (origin lower-left corner = 0,0) and mesh description
+xmin                            = 0.d0           # abscissa of left side of the model
+xmax                            = 5000.d0        # abscissa of right side of the model
+nx                              = 100             # number of elements along X
+
+# absorbing boundary parameters (see absorbing_conditions above)
+absorbbottom                    = .false.
+absorbright                     = .false.
+absorbtop                       = .false.
+absorbleft                      = .false.
+
+# define the different regions of the model in the (nx,nz) spectral element mesh
+nbregions                       = 3              # nb of regions and model number for each
+ 1  40  1 60 2
+41  60  1 60 1
+61 100  1 60 2

Added: seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/README
===================================================================
--- seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/README	                        (rev 0)
+++ seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/README	2013-04-05 08:49:39 UTC (rev 21727)
@@ -0,0 +1,31 @@
+----------------------------------------------------------------------
+README
+----------------------------------------------------------------------
+
+Kernel example provided by LuoYang
+
+TO RUN:
+
+0. Read the user manual in SPECFEM2D/doc/manual_SPECFEM2D.pdf
+
+1. in SPECFEM2D root directory, configure, e.g., 
+   > ./configure FC=gfortran
+   make, e.g. make all
+
+2. run mesher and solver for forward wavefield:
+   > cd EXAMPLES/LuoYang_fluid_soild_kernel/
+   > ./process.sh
+
+3. compute adjoint source:
+   > rm -rf xadj_source ; gfortran adj_source.f90 -o xadj_source
+   > xadj_source
+
+4. change Par_file with save_forward = .false. and SIMULATION_TYPE = 3
+
+5. run adjoint simulation:
+   > ./process_kernel.sh
+
+   optional: try plotting the kernels using the script
+                plot_kernel with command gnuplot plot_kernel
+
+---------------------------

Added: seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/SOURCE
===================================================================
--- seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/SOURCE	                        (rev 0)
+++ seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/SOURCE	2013-04-05 08:49:39 UTC (rev 21727)
@@ -0,0 +1,17 @@
+# The components of a moment tensor source must be given in N.m, not in dyne.cm as in the DATA/CMTSOLUTION source file of the 3D version of the code.
+# source 1
+source_surf                     = .false.        # source inside the medium or at the surface
+xs                              = 4000.             # source location x in meters
+zs                              = 1500.          # source location z in meters
+# source type: elastic force or acoustic pressure = 1 or moment tensor = 2;
+# for a plane wave including converted and reflected waves at the free surface, P wave = 1, S wave = 2, Rayleigh wave = 3
+# for a plane wave without converted nor reflected waves at the free surface, i.e. with the incident wave only, P wave = 4, S wave = 5
+source_type                     = 1
+time_function_type              = 1              # Ricker = 1, first derivative = 2, Gaussian = 3, Dirac = 4, Heaviside = 5
+f0                              = 10.0           # dominant source frequency (Hz) if not Dirac or Heaviside
+tshift                          = 0.0            # time shift when multi sources (if one source, must be zero)
+anglesource                     = 0.0            # angle of the source (for a force only); for a plane wave, this is the incidence angle; for moment tensor sources this is unused
+Mxx                             = 1.             # Mxx component (for a moment tensor source only)
+Mzz                             = 1.             # Mzz component (for a moment tensor source only)
+Mxz                             = 0.             # Mxz component (for a moment tensor source only)
+factor                          = 1.d10          # amplification factor

Added: seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/adj_source.f90
===================================================================
--- seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/adj_source.f90	                        (rev 0)
+++ seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/adj_source.f90	2013-04-05 08:49:39 UTC (rev 21727)
@@ -0,0 +1,25 @@
+implicit none
+
+double precision :: time,pressure
+integer,parameter :: NSTEP = 1600
+integer :: i
+
+open(1,file="OUTPUT_FILES/S0001.AA.PRE.semp",status="old")
+
+open(10,file="SEM/S0001.AA.BXX.adj",status="unknown")
+
+open(20,file="SEM/S0001.AA.BXY.adj",status="unknown")
+
+open(30,file="SEM/S0001.AA.BXZ.adj",status="unknown")
+
+do i=1,NSTEP
+
+  read(1,*)time,pressure
+  if(time>1.274)pressure=0.d0
+  write(10,*)time,pressure
+  write(20,*)time,pressure
+  write(30,*)time,pressure
+
+enddo
+
+end

Added: seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/interfaces.dat
===================================================================
--- seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/interfaces.dat	                        (rev 0)
+++ seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/interfaces.dat	2013-04-05 08:49:39 UTC (rev 21727)
@@ -0,0 +1,46 @@
+#
+# number of interfaces
+#
+ 4
+#
+# for each interface below, we give the number of points and then x,z for each point
+#
+#
+# interface number 1 (bottom of the mesh)
+#
+ 2
+ 0 0
+ 5000 0
+#
+# interface number 2
+#
+ 2
+    0 1000
+ 5000 1000
+#
+# interface number 3
+#
+ 2
+    0 2000
+ 5000 2000
+#
+# interface number 4 (topography, top of the mesh)
+#
+ 2
+    0 3000
+ 5000 3000
+#
+# for each layer, we give the number of spectral elements in the vertical direction
+#
+#
+# layer number 1 (bottom layer)
+#
+ 20
+#
+# layer number 2
+#
+ 20
+#
+# layer number 3 (top layer)
+#
+ 20

Added: seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/plot_kernel
===================================================================
--- seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/plot_kernel	                        (rev 0)
+++ seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/plot_kernel	2013-04-05 08:49:39 UTC (rev 21727)
@@ -0,0 +1,41 @@
+set term png
+set output "rho_kappa kernel.png"
+
+set palette defined ( -8e+16 "red", 0 "yellow", 8e+16 "blue")
+set pm3d map
+unset xtics
+unset ytics
+unset key
+unset grid
+set samples 2
+set cbrange [-8e+16:8e+16]
+set isosamples 2
+
+set multiplot
+set size 0.5,0.5
+set origin 0,0
+set title "rho kernel_acoustic only"
+splot "OUTPUT_FILES/proc000000_rho_kappa_kernel.dat" using 1:2:(($1>=2000.0 && $1<=3000.0)? 1/0 : $3) w points palette ps 0.02 pt 5
+
+set cbrange [-8e+16:8e+16]
+unset cbtics
+set size 0.5,0.5
+set origin 0.5,0
+set title "kappa kernel_acoustic only"
+splot "OUTPUT_FILES/proc000000_rho_kappa_kernel.dat" using 1:2:(($1>=2000.0 &&$1<=3000.0)? 1/0 : $4)   w points palette ps 0.02 pt 5
+
+set size 0.5,0.5
+set origin 0,0.5
+set title "rho kernel_acoustic and elastic"
+splot "OUTPUT_FILES/proc000000_rho_kappa_kernel.dat" using 1:2:(($1>=2000.0 && $1<=3000.0)? 1/0 : $3) w points palette ps 0.02 pt 5,"OUTPUT_FILES/proc000000_rho_kappa_mu_kernel.dat" using 1:2:(($1>=2000.0 && $1<=3000.0)? $3 : 1/0) w points palette ps 0.02 pt 5
+
+set cbrange [-8e+16:8e+16]
+
+set size 0.5,0.5
+set origin 0.5,0.5
+set title "kappa kernel_acoustic and elastic"
+splot "OUTPUT_FILES/proc000000_rho_kappa_kernel.dat" using 1:2:(($1>=2000.0 &&$1<=3000.0)? 1/0 : $4)   w points palette ps 0.02 pt 5,"OUTPUT_FILES/proc000000_rho_kappa_mu_kernel.dat" using 1:2:(($1>=2000.0 && $1<=3000.0)? $4 : 1/0) w points palette ps 0.02 pt 5
+
+unset multiplot
+
+

Added: seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/process.sh
===================================================================
--- seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/process.sh	                        (rev 0)
+++ seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/process.sh	2013-04-05 08:49:39 UTC (rev 21727)
@@ -0,0 +1,66 @@
+#!/bin/bash
+#
+# script runs mesher and solver (in serial)
+# using this example setup
+#
+
+echo "running example: `date`"
+currentdir=`pwd`
+
+echo
+echo "(will take about 1 minute)"
+echo
+
+# sets up directory structure in current example directoy
+echo
+echo "   setting up example..."
+echo
+
+mkdir -p OUTPUT_FILES
+mkdir -p DATA
+mkdir -p SEM
+
+# sets up local DATA/ directory
+cd DATA/
+ln -s ../Par_file Par_file
+ln -s ../SOURCE SOURCE
+cp ../interfaces.dat interfaces.dat
+cd ../
+
+# cleans output files
+rm -rf OUTPUT_FILES/*
+
+# compiles executables in root directory
+cd ../../
+make > tmp.log
+cd $currentdir
+
+# links executables
+rm -f xmeshfem2D xspecfem2D
+ln -s ../../bin/xmeshfem2D
+ln -s ../../bin/xspecfem2D
+
+# stores setup
+cp DATA/Par_file OUTPUT_FILES/
+cp DATA/SOURCE OUTPUT_FILES/
+
+# runs database generation
+echo
+echo "  running mesher..."
+echo
+./xmeshfem2D > OUTPUT_FILES/output_mesher.txt
+
+# runs simulation
+echo
+echo "  running solver..."
+echo
+./xspecfem2D > OUTPUT_FILES/output_solver.txt
+
+# stores output
+cp DATA/*SOURCE* DATA/*STATIONS* OUTPUT_FILES
+
+echo
+echo "see results in directory: OUTPUT_FILES/"
+echo
+echo "done"
+echo `date`


Property changes on: seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/process.sh
___________________________________________________________________
Name: svn:executable
   + *

Added: seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/process_kernel.sh
===================================================================
--- seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/process_kernel.sh	                        (rev 0)
+++ seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/process_kernel.sh	2013-04-05 08:49:39 UTC (rev 21727)
@@ -0,0 +1,24 @@
+#!/bin/bash
+#
+# script runs solver in serial
+#
+
+echo "running example: `date`"
+currentdir=`pwd`
+
+echo
+echo "(will take about 1 minute)"
+echo
+
+# runs simulation
+echo
+echo "  running mesher and solver..."
+echo
+./xmeshfem2D > OUTPUT_FILES/output_mesher_kernel.txt
+./xspecfem2D > OUTPUT_FILES/output_solver_kernel.txt
+
+echo
+echo "see results in directory: OUTPUT_FILES/"
+echo
+echo "done"
+echo `date`


Property changes on: seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/process_kernel.sh
___________________________________________________________________
Name: svn:executable
   + *

Added: seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/rho_kappa kernel.png
===================================================================
(Binary files differ)


Property changes on: seismo/2D/SPECFEM2D/trunk/EXAMPLES/LuoYang_fluid_soild_kernel/rho_kappa kernel.png
___________________________________________________________________
Name: svn:mime-type
   + application/octet-stream



More information about the CIG-COMMITS mailing list