Skip to content

Commit

Permalink
Merge pull request #15 from daniel-koehn/develop
Browse files Browse the repository at this point in the history
Merge shot parallelization into Master branch
  • Loading branch information
daniel-koehn authored Mar 14, 2019
2 parents 74b57f2 + aa93641 commit cd140b5
Show file tree
Hide file tree
Showing 78 changed files with 3,006 additions and 2,779 deletions.
17 changes: 17 additions & 0 deletions .gitignore
Original file line number Diff line number Diff line change
Expand Up @@ -2,6 +2,12 @@
Thumbs.db
ehthumbs.db

# compilation and execution outputs
*.o
*.err
*.out
*.su.shot*

# Folder config file
Desktop.ini

Expand Down Expand Up @@ -41,3 +47,14 @@ $RECYCLE.BIN/
Network Trash Folder
Temporary Items
.apdisk



# OUR EDITS
*.o
*.bin*
*.su*
*.d*
model*/*
DENISE-Benchmark
model_*
19 changes: 19 additions & 0 deletions Github_update.txt
Original file line number Diff line number Diff line change
Expand Up @@ -17,6 +17,25 @@ git clone -b branch_name https://github.com/daniel-koehn/DENISE-Black-Edition.gi
Update of Github DENISE-Black-Edition repository
------------------------------------------------

Before you update the repository:

Be sure that all compiled code in /src and /libcseife is removed by

make clean

Furthermore, all model files, log files, snap shot files, FA-pick files,
STF files and seismograms from

par/jacobian
par/log
par/model
par/picked_times
par/start
par/wavelet

are removed. The /par directory should only contain the Marmousi-II example
input, workflow, source and receiver files.

1. Move to DENISE-Black-Edition directory
2. git add -A
3. git commit -m "Comment on the latest update"
Expand Down
36 changes: 17 additions & 19 deletions include/fd.h
Original file line number Diff line number Diff line change
Expand Up @@ -75,7 +75,7 @@ struct seisPSVfwi{
float ** sectionvydiff, ** sectionvydata, ** sectionread;
float ** sectionpdata, ** sectionpdiff, ** sectionpdiffold;
float energy;
float L2;
double L2;
} seisPSVfwi;

/* Acquisition geometry */
Expand Down Expand Up @@ -171,7 +171,7 @@ struct seisSHfwi{
float ** sectionvzdata, ** sectionvzdiff, ** sectionvzdiffold;
float ** sectionread;
float energy;
float L2;
double L2;
} seisSHfwi;

/* SH (visco)-elastic wavefield variables */
Expand Down Expand Up @@ -236,7 +236,7 @@ void FD_PSV();

void FWI_PSV();

float grad_obj_psv(struct wavePSV *wavePSV, struct wavePSV_PML *wavePSV_PML, struct matPSV *matPSV, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
double grad_obj_psv(struct wavePSV *wavePSV, struct wavePSV_PML *wavePSV_PML, struct matPSV *matPSV, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
struct seisPSV *seisPSV, struct seisPSVfwi *seisPSVfwi, struct acq *acq, float *hc, int iter, int nsrc, int ns, int ntr, int ntr_glob, int nsrc_glob,
int nsrc_loc, int ntr_loc, int nstage, float **We, float **Ws, float **Wr, float ** taper_coeff, int hin, int *DTINV_help,
MPI_Request * req_send, MPI_Request * req_rec);
Expand All @@ -254,7 +254,7 @@ void model_freq_out_PSV(float ** ppi, float ** rho, float ** pu, int iter, fl

void model_it_out_PSV(float ** ppi, float ** rho, float ** pu, int nstage, int iter, float freq);

float obj_psv(struct wavePSV *wavePSV, struct wavePSV_PML *wavePSV_PML, struct matPSV *matPSV, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
double obj_psv(struct wavePSV *wavePSV, struct wavePSV_PML *wavePSV_PML, struct matPSV *matPSV, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
struct seisPSV *seisPSV, struct seisPSVfwi *seisPSVfwi, struct acq *acq, float *hc, int nsrc, int nsrc_loc, int nsrc_glob, int ntr, int ntr_glob,
int ns, int itest, int iter, float **Ws, float **Wr, int hin, int *DTINV_help, float eps_scale, MPI_Request * req_send, MPI_Request * req_rec);

Expand Down Expand Up @@ -287,7 +287,7 @@ void RTM_PSV_out_shot(struct fwiPSV *fwiPSV, int ishot);

float step_length_est_psv(struct wavePSV *wavePSV, struct wavePSV_PML *wavePSV_PML, struct matPSV *matPSV, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
struct seisPSV *seisPSV, struct seisPSVfwi *seisPSVfwi, struct acq *acq, float *hc, int iter, int nsrc, int ns, int ntr, int ntr_glob, float * epst1,
float * L2t, int nsrc_glob, int nsrc_loc, int *step1, int *step3, int nxgrav, int nygrav, int ngrav, float **gravpos, float *gz_mod, int NZGRAV, int ntr_loc,
double * L2t, int nsrc_glob, int nsrc_loc, int *step1, int *step3, int nxgrav, int nygrav, int ngrav, float **gravpos, float *gz_mod, int NZGRAV, int ntr_loc,
float **Ws, float **Wr, int hin, int *DTINV_help, MPI_Request * req_send, MPI_Request * req_rec);

void stf_psv(struct wavePSV *wavePSV, struct wavePSV_PML *wavePSV_PML, struct matPSV *matPSV, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV, struct seisPSV *seisPSV,
Expand Down Expand Up @@ -348,7 +348,7 @@ void checkfd_ssg_VTI(FILE *fp, float ** prho, float ** c11, float ** c13, float

void FD_VTI();

float grad_obj_VTI(struct wavePSV *wavePSV, struct wavePSV_PML *wavePSV_PML, struct matVTI *matVTI, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
double grad_obj_VTI(struct wavePSV *wavePSV, struct wavePSV_PML *wavePSV_PML, struct matVTI *matVTI, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
struct seisPSV *seisPSV, struct seisPSVfwi *seisPSVfwi, struct acq *acq, float *hc, int iter, int nsrc, int ns, int ntr, int ntr_glob, int nsrc_glob,
int nsrc_loc, int ntr_loc, int nstage, float **We, float **Ws, float **Wr, float ** taper_coeff, int hin, int *DTINV_help,
MPI_Request * req_send, MPI_Request * req_rec);
Expand Down Expand Up @@ -390,7 +390,7 @@ void checkfd_ssg_TTI(FILE *fp, float ** prho, float ** c11, float ** c13, float

void FD_TTI();

float grad_obj_TTI(struct wavePSV *wavePSV, struct wavePSV_PML *wavePSV_PML, struct matTTI *matTTI, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
double grad_obj_TTI(struct wavePSV *wavePSV, struct wavePSV_PML *wavePSV_PML, struct matTTI *matTTI, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
struct seisPSV *seisPSV, struct seisPSVfwi *seisPSVfwi, struct acq *acq, float *hc, int iter, int nsrc, int ns, int ntr, int ntr_glob, int nsrc_glob,
int nsrc_loc, int ntr_loc, int nstage, float **We, float **Ws, float **Wr, float ** taper_coeff, int hin, int *DTINV_help,
MPI_Request * req_send, MPI_Request * req_rec);
Expand Down Expand Up @@ -453,7 +453,7 @@ void FD_AC();

void FWI_AC();

float grad_obj_ac(struct waveAC *waveAC, struct waveAC_PML *waveAC_PML, struct matAC *matAC, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
double grad_obj_ac(struct waveAC *waveAC, struct waveAC_PML *waveAC_PML, struct matAC *matAC, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
struct seisPSV *seisPSV, struct seisPSVfwi *seisPSVfwi, struct acq *acq, float *hc, int iter, int nsrc, int ns, int ntr, int ntr_glob, int nsrc_glob,
int nsrc_loc, int ntr_loc, int nstage, float **We, float **Ws, float **Wr, float ** taper_coeff, int hin, int *DTINV_help,
MPI_Request * req_send, MPI_Request * req_rec);
Expand All @@ -466,7 +466,7 @@ void model_freq_out_AC(float ** ppi, float ** rho, int iter, float freq);

void model_it_out_AC(float ** ppi, float ** rho, int nstage, int iter, float freq);

float obj_ac(struct waveAC *waveAC, struct waveAC_PML *waveAC_PML, struct matAC *matAC, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
double obj_ac(struct waveAC *waveAC, struct waveAC_PML *waveAC_PML, struct matAC *matAC, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
struct seisPSV *seisPSV, struct seisPSVfwi *seisPSVfwi, struct acq *acq, float *hc, int nsrc, int nsrc_loc, int nsrc_glob, int ntr,
int ntr_glob, int ns, int itest, int iter, float **Ws, float **Wr, int hin, int *DTINV_help, float eps_scale, MPI_Request * req_send, MPI_Request * req_rec);

Expand All @@ -492,7 +492,7 @@ void snap_AC(FILE *fp,int nt, int nsnap, float **vx, float **vy, float **p, floa

float step_length_est_ac(struct waveAC *waveAC, struct waveAC_PML *waveAC_PML, struct matAC *matAC, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV,
struct seisPSV *seisPSV, struct seisPSVfwi *seisPSVfwi, struct acq *acq, float *hc, int iter, int nsrc, int ns, int ntr, int ntr_glob, float * epst1,
float * L2t, int nsrc_glob, int nsrc_loc, int *step1, int *step3, int nxgrav, int nygrav, int ngrav, float **gravpos, float *gz_mod, int NZGRAV, int ntr_loc,
double * L2t, int nsrc_glob, int nsrc_loc, int *step1, int *step3, int nxgrav, int nygrav, int ngrav, float **gravpos, float *gz_mod, int NZGRAV, int ntr_loc,
float **Ws, float **Wr, int hin, int *DTINV_help, MPI_Request * req_send, MPI_Request * req_rec);

void stf_ac(struct waveAC *waveAC, struct waveAC_PML *waveAC_PML, struct matAC *matAC, struct fwiPSV *fwiPSV, struct mpiPSV *mpiPSV, struct seisPSV *seisPSV,
Expand Down Expand Up @@ -582,7 +582,7 @@ void FD_grad_SH();

void FWI_SH();

float grad_obj_sh(struct waveSH *waveSH, struct waveSH_PML *waveSH_PML, struct matSH *matSH, struct fwiSH *fwiSH, struct mpiPSV *mpiPSV,
double grad_obj_sh(struct waveSH *waveSH, struct waveSH_PML *waveSH_PML, struct matSH *matSH, struct fwiSH *fwiSH, struct mpiPSV *mpiPSV,
struct seisSH *seisSH, struct seisSHfwi *seisSHfwi, struct acq *acq, float *hc, int iter, int nsrc, int ns, int ntr, int ntr_glob, int nsrc_glob,
int nsrc_loc, int ntr_loc, int nstage, float **We, float **Ws, float **Wr, float ** taper_coeff, int hin, int *DTINV_help,
MPI_Request * req_send, MPI_Request * req_rec);
Expand All @@ -597,7 +597,7 @@ void model_freq_out_SH(float ** rho, float ** pu, float ** ptaus, int iter, f

void model_it_out_SH(float ** rho, float ** pu, float ** ptaus, int nstage, int iter, float freq);

float obj_sh(struct waveSH *waveSH, struct waveSH_PML *waveSH_PML, struct matSH *matSH, struct fwiSH *fwiSH, struct mpiPSV *mpiPSV,
double obj_sh(struct waveSH *waveSH, struct waveSH_PML *waveSH_PML, struct matSH *matSH, struct fwiSH *fwiSH, struct mpiPSV *mpiPSV,
struct seisSH *seisSH, struct seisSHfwi *seisSHfwi, struct acq *acq, float *hc, int nsrc, int nsrc_loc, int nsrc_glob, int ntr,
int ntr_glob, int ns, int itest, int iter, float **Ws, float **Wr, int hin, int *DTINV_help, float eps_scale, MPI_Request * req_send, MPI_Request * req_rec);

Expand Down Expand Up @@ -627,7 +627,7 @@ void sh(struct waveSH *waveSH, struct waveSH_PML *waveSH_PML, struct matSH *matS

float step_length_est_sh(struct waveSH *waveSH, struct waveSH_PML *waveSH_PML, struct matSH *matSH, struct fwiSH *fwiSH, struct mpiPSV *mpiPSV,
struct seisSH *seisSH, struct seisSHfwi *seisSHfwi, struct acq *acq, float *hc, int iter, int nsrc, int ns, int ntr, int ntr_glob, float * epst1,
float * L2t, int nsrc_glob, int nsrc_loc, int *step1, int *step3, int nxgrav, int nygrav, int ngrav, float **gravpos, float *gz_mod, int NZGRAV, int ntr_loc,
double * L2t, int nsrc_glob, int nsrc_loc, int *step1, int *step3, int nxgrav, int nygrav, int ngrav, float **gravpos, float *gz_mod, int NZGRAV, int ntr_loc,
float **Ws, float **Wr, int hin, int *DTINV_help, MPI_Request * req_send, MPI_Request * req_rec);

void stf_sh(struct waveSH *waveSH, struct waveSH_PML *waveSH_PML, struct matSH *matSH, struct fwiSH *fwiSH, struct mpiPSV *mpiPSV, struct seisSH *seisSH,
Expand Down Expand Up @@ -713,13 +713,11 @@ void calc_envelope(float ** datatrace, float ** envelope, int ns, int ntr);

void calc_hilbert(float ** datatrace, float ** envelope, int ns, int ntr);

double calc_res(float **sectiondata, float **section, float **sectiondiff, float **sectiondiffold, int ntr, int ns, int LNORM, float L2, int itest, int sws, int swstestshot, int ntr_glob, int **recpos, int **recpos_loc, float **srcpos, int nsrc_glob, int ishot, int iter);
double calc_res(float **sectiondata, float **section, float **sectiondiff, float **sectiondiffold, int ntr, int ns, int LNORM, double L2, int itest, int sws, int swstestshot, int ntr_glob, int **recpos, int **recpos_loc, float **srcpos, int nsrc_glob, int ishot, int iter);

double calc_res_grav(int ngrav, float *gz_mod, float *gz_res);

double calc_misfit(float **sectiondiff, int ntr, int ns, int LNORM, float L2, int ntr_glob, int **recpos_loc, int nsrc_glob, int ishot);

float calc_opt_step(float * L2t, float * epst, int sws);
float calc_opt_step(double * L2t, float * epst, int sws);

double calc_energy(float **sectiondata, int ntr, int ns, float energy, int ntr_glob, int **recpos_loc, int nsrc_glob, int ishot);

Expand All @@ -737,12 +735,12 @@ void conv_FD(float * temp_TS, float * temp_TS1, float * temp_conv, int ns);

void copy_mat(float ** A, float ** B);

void count_src();

void descent(float ** grad, float ** gradm);

float dotp(float * vec1, float *vec2, int n1, int n2, int sw);

float exchange_L2(float L2, int sw, int bcast_l2);

void eprecond(float ** W, float ** vx, float ** vy);

void eprecond1(float ** We, float ** Ws, float ** Wr);
Expand Down
37 changes: 20 additions & 17 deletions include/globvar.h
Original file line number Diff line number Diff line change
Expand Up @@ -11,38 +11,41 @@
float XS, YS, DH, TIME, DT, TS, DAMPING;
float TSNAP1, TSNAP2, TSNAPINC, *FL, TAU, ALPHA_VISC;
float ANGLE;
float REFREC[4]={0.0, 0.0, 0.0, 0.0}, FPML;
int SEISMO, NDT, NSRC=1, SEIS_FORMAT, FREE_SURF, READMOD, READREC, SRCREC, FW=0;
int NX, NY, NT, QUELLART, QUELLTYP, SNAP, SNAP_FORMAT, LOG, RUN_MULTIPLE_SHOTS, NTRG;
int L, BOUNDARY, DC, NXG, NYG, IDX, IDY, FDORDER, MAXRELERROR, SNAP_SHOT;
char SNAP_FILE[STRING_SIZE], SOURCE_FILE[STRING_SIZE], SIGNAL_FILE[STRING_SIZE];
char MFILE[STRING_SIZE], REC_FILE[STRING_SIZE];
char SEIS_FILE_VX[STRING_SIZE], SEIS_FILE_VY[STRING_SIZE], LOG_FILE[STRING_SIZE];
char SEIS_FILE_CURL[STRING_SIZE], SEIS_FILE_DIV[STRING_SIZE], SEIS_FILE_P[STRING_SIZE];
char *FILEINP1;
float REFREC[4] = {0.0, 0.0, 0.0, 0.0}, FPML;
int SEISMO, NDT, NSRC = 1, SEIS_FORMAT, FREE_SURF, READMOD, READREC, SRCREC, FW = 0;
int NX, NY, NT, QUELLART, QUELLTYP, SNAP, SNAP_FORMAT, LOG, RUN_MULTIPLE_SHOTS, NTRG;
int L, BOUNDARY, DC, NXG, NYG, IDX, IDY, FDORDER, MAXRELERROR, SNAP_SHOT;
char SNAP_FILE[STRING_SIZE], SOURCE_FILE[STRING_SIZE], SIGNAL_FILE[STRING_SIZE];
char MFILE[STRING_SIZE], REC_FILE[STRING_SIZE];
char SEIS_FILE_VX[STRING_SIZE], SEIS_FILE_VY[STRING_SIZE], LOG_FILE[STRING_SIZE];
char SEIS_FILE_CURL[STRING_SIZE], SEIS_FILE_DIV[STRING_SIZE], SEIS_FILE_P[STRING_SIZE];
char *FILEINP1;
FILE *FP;

/* Mpi-variables */
int NP, NPSP, NPROC, NPROCX, NPROCY, MYID, IENDX, IENDY;
int POS[3], INDEX[5];
const int TAG1=1,TAG2=2, TAG3=3, TAG4=4, TAG5=5,TAG6=6;
int NP, NPSP, NPROC, NPROCX, NPROCY, MYID, IENDX, IENDY;
int POS[3], INDEX[5];
int COLOR, NCOLORS, NSHOT1, NSHOT2, MYID_SHOT;
int NSHOTS; // read only in FD_PSV so far
const int TAG1 = 1, TAG2 = 2, TAG3 = 3, TAG4 = 4, TAG5 = 5, TAG6 = 6;
MPI_Comm DOMAIN_COMM, SHOT_COMM;

/* spatial adaptive Code variables*/
int check_id, cfgt_id, cfgt, jumpid;
int check_id, cfgt_id, cfgt, jumpid;
float DH1;

/* TDFWI Code DENISE_elastic*/
int PHYSICS, MODE, INV_MOD_OUT, ADJ_SIGN;
char JACOBIAN[STRING_SIZE], DATA_DIR[STRING_SIZE];
int TAPER, TAPERLENGTH;
int GRADT1,GRADT2,GRADT3,GRADT4;
int GRADT1, GRADT2, GRADT3, GRADT4;
int ITERMAX, REC1, REC2, INVMAT1, QUELLTYPB;
int HESSIAN, GRAD_METHOD, NLBFGS, PCG_BETA;
float FC_HESS_START, FC_HESS_INC;
int MODEL_FILTER, FILT_SIZE;
float EPSILON, MUN, EPSILON_u, EPSILON_rho, EPSILON_ts;

int TESTSHOT_START, TESTSHOT_END, TESTSHOT_INCR;
int TESTSHOT_START, TESTSHOT_END, TESTSHOT_INCR;
int SWS_TAPER_GRAD_VERT, SWS_TAPER_GRAD_HOR, SWS_TAPER_GRAD_SOURCES, SWS_TAPER_CIRCULAR_PER_SHOT, SRTSHAPE, FILTSIZE;
int SWS_TAPER_FILE;
float SRTRADIUS, EXP_TAPER_GRAD_HOR;
Expand Down Expand Up @@ -79,7 +82,7 @@ char TRKILL_FILE[STRING_SIZE];
int TIMEWIN, NORMALIZE;
float TWLENGTH_PLUS, TWLENGTH_MINUS, GAMMA;
char PICKS_FILE[STRING_SIZE];
char MISFIT_LOG_FILE[STRING_SIZE];
char MISFIT_LOG_FILE[STRING_SIZE];

int GRAD_FILTER, FILT_SIZE_GRAD;

Expand Down Expand Up @@ -108,7 +111,7 @@ int OFFSET_MUTE;
float SCALERHO, SCALEQS;

/* corner frequencies for spike wavelet */
float FC_SPIKE_1, FC_SPIKE_2;
float FC_SPIKE_1, FC_SPIKE_2;
int ORDER_SPIKE;

/* parameter for gravity modelling/inversion */
Expand Down
19 changes: 19 additions & 0 deletions jobs/run.sh
Original file line number Diff line number Diff line change
@@ -0,0 +1,19 @@
#!/bin/bash
#SBATCH --partition=batch
#SBATCH --job-name="DENISE"
# SBATCH --res=HACKATHON_TEAMS
#SBATCH --gres=gpu:p100:1
#SBATCH --nodes=1
#SBATCH --tasks=36
#SBATCH --time=00:01:00
#SBATCH --err=JOB.%j.err
#SBATCH --output=JOB.%j.out
#SBATCH --exclusive

/usr/bin/time mpirun -n 1 ../bin/denise DENISE_marm_OBC.inp FWI_workflow_marmousi.inp

#mpirun -n 1 nvprof -o resultNV.nvprof --cpu-profiling on ../bin/denise DENISE_marm_OBC.inp FWI_workflow_marmousi.inp | tee profiling_CPU.txt

#mpirun -n 1 nvprof --print-summary-per-gpu --profile-from-start on -o resultNVi_%p.nvprof -f --log-file log_%p.txt ../bin/denise DENISE_marm_OBC.inp FWI_workflow_marmousi.inp


6 changes: 3 additions & 3 deletions par/DENISE_marm_OBC.inp
Original file line number Diff line number Diff line change
Expand Up @@ -6,7 +6,7 @@
#
# ------------------ DENISE Mode ---------------------------------
# Operation mode:
(forward_modelling_only=0;FWI=1;RTM=2)_(MODE) = 0
(forward_modelling_only=0;FWI=1;RTM=2)_(MODE) = 0
#
# ---------------- DENISE Physics -----------------------------
(2D-PSV=1;2D-AC=2;2D-VTI=3;2D-TTI=4;2D-SH=5)_(PHYSICS) = 1
Expand All @@ -29,7 +29,7 @@ max_relative_error = 1
#-------------------- 2-D Grid -----------------------------------
number_of_gridpoints_in_x-direction_(NX) = 500
number_of_gridpoints_in_y-direction_(NY) = 174
distance_between_gridpoints(in_m)_(DH) = 20.0
distance_between_gridpoints(in_m)_(DH) = 20.0
#
# Note that y denotes the vertical direction !
#
Expand All @@ -40,7 +40,7 @@ timestep_(in_seconds)_(DT) = 2.0e-3
#--------------------Source---------------------------------------
# Shape_of_source-signal:
(ricker=1;fumue=2;from_SOURCE_FILE=3;SIN**3=4;Gaussian_deriv=5;Spike=6;Klauder=7)_(QUELLART) = 6
SIGNAL_FILE = ./wavelet/wavelet_plexiglas
SIGNAL_FILE = ./wavelet/wavelet_marmousi
duration_of_Klauder_wavelet_(in_seconds)_(TS) = 8.0
read_source_positions_from_SOURCE_FILE_(yes=1)_(SRCREC) = 1
SOURCE_FILE = ./source/source_OBC_VSP.dat
Expand Down
8 changes: 4 additions & 4 deletions par/FWI_workflow_marmousi.inp
Original file line number Diff line number Diff line change
@@ -1,5 +1,5 @@
PRO TIME_FILT FC_low FC_high ORDER TIME_WIN GAMMA TWIN- TWIN+ INV_VP_ITER INV_VS_ITER INV_RHO_ITER INV_QS_ITER SPATFILTER WD_DAMP WD_DAMP1 EPRECOND LNORM STF_INV OFFSETC_STF EPS_STF NORMALIZE OFFSET_MUTE OFFSETC SCALERHO SCALEQS ENV GAMMA_GRAV N_ORDER
0.01 1 0.0 2.0 6 0 20.0 0.0 0.0 0 0 0 0 0 160 160 3 2 0 -4.0 1e-1 0 0 10.0 0.5 1.0 0 0 0
0.01 1 0.0 5.0 6 0 2.5 0.0 0.0 0 0 0 0 0 160 160 3 2 0 -4.0 1e-1 0 0 10.0 0.5 1.0 0 0 0
0.01 1 0.0 10.0 6 0 1.0 0.0 0.0 0 0 0 0 0 160 160 3 2 0 -4.0 1e-1 0 0 10.0 0.5 1.0 0 0 0
0.01 1 0.0 20.0 6 0 0.5 0.0 0.0 0 0 0 0 0 160 160 3 2 0 -4.0 1e-1 0 0 10.0 0.5 1.0 0 0 0
0.01 1 0.0 2.0 6 0 20.0 0.0 0.0 0 0 0 0 0 0.5 0.5 3 2 0 -4.0 1e-1 0 0 10.0 0.5 1.0 0 0 0
0.01 1 0.0 5.0 6 0 2.5 0.0 0.0 0 0 0 0 0 0.5 0.5 3 2 0 -4.0 1e-1 0 0 10.0 0.5 1.0 0 0 0
0.01 1 0.0 10.0 6 0 1.0 0.0 0.0 0 0 0 0 0 0.5 0.5 3 2 0 -4.0 1e-1 0 0 10.0 0.5 1.0 0 0 0
0.01 1 0.0 20.0 6 0 0.5 0.0 0.0 0 0 0 0 0 0.5 0.5 3 2 0 -4.0 1e-1 0 0 10.0 0.5 1.0 0 0 0
3 changes: 0 additions & 3 deletions par/lamhosts

This file was deleted.

4 changes: 0 additions & 4 deletions par/model/.gitignore

This file was deleted.

File renamed without changes.
4 changes: 3 additions & 1 deletion par/compileDENISE.sh → par/shell_scripts/compileDENISE.sh
Original file line number Diff line number Diff line change
@@ -1,4 +1,6 @@
cd ../src
make clean
#make clean
make denise
cd ../par


File renamed without changes.
File renamed without changes.
File renamed without changes.
8 changes: 8 additions & 0 deletions par/shell_scripts/gradDiff.sh
Original file line number Diff line number Diff line change
@@ -0,0 +1,8 @@
#!/bin/bash

suaddhead < jacobian/jacobian_Test_P_image ns=174 > jacobian/jacobian_Test_P_image.su
suaddhead < jacobian/jacobian_Test_P_image_shot_$1 ns=174 > jacobian/jacobian_Test_P_image_shot_.su

sudiff jacobian/jacobian_Test_P_image.su jacobian/jacobian_Test_P_image_shot_.su| suximage


File renamed without changes.
File renamed without changes.
Loading

0 comments on commit cd140b5

Please sign in to comment.