Ejemplo n.º 1
0
/*
 * Store parameter from parameter block par onto
 * packed-parameter-block xpar.
 * idir is the direction corresponding to the par record
 * if create is true, a new xpar record is created, that is,
 * a record with all the new parameters on it
 */
void psnd_parstt(float *xpar, int idir, PBLOCK *par, int create)
{
    int i,ioff,dim,par_size,header_size;
    float *xp;
    PARDEF_HEADER *ph;
    PARDEF *pd;

    ph = (PARDEF_HEADER *) xpar;
    if (ph->type == FILE_TYPE_OLD3D) {
        old123d_parstt(xpar,idir,par);
        return;
    }
    dim         = ph->iaqdir;
    par_size    = ph->ntnpar;
    header_size = ph->nt0par;
    if (ph->swapit) {
        swap4(&dim);
        swap4(&par_size);
        swap4(&header_size);
    }
    if (idir > dim)
        return;
    ioff   = (idir-1) * par_size + header_size;
    xp     = xpar + ioff/sizeof(float);
    init_par_offsets(par);
    /*
     * Create a new xpar
     */
    if (create) {
        for (i=0;old123d_par[i].type;i++) 
            xp = (float*) setpar((PARDEF*) xp, 
                             old123d_par[i].type, 
                             old123d_par[i].name, 
                             old123d_par[i].offset,
                             par,
                             ph->swapit);
        return;
    }
    /*
     * Update xpar
     */
    pd = (PARDEF*) xp;
    while (pd->type) {
        for (i=0;old123d_par[i].type;i++) {
            if (!old123d_par[i].offset)
                continue;
            if (strcmp(pd->name, old123d_par[i].name) == 0) {
                xp = (float*) pd;
                setpar((PARDEF*) xp, 
                             old123d_par[i].type, 
                             old123d_par[i].name, 
                             old123d_par[i].offset,
                             par,
                             ph->swapit);
                break;
            }
        }
        pd += 1;
    }
}
Ejemplo n.º 2
0
main(int ac,char **av)
{
FILE *fopfile(), *fpr, *fpw;
float dip, dtop, flen, fwid, msum, dwid;
int i, nseg, nlen, nwid;

char *rchar, infile[512], str[1024], velfile[512];
struct velmodel vmod;

float moment = -1.0;
float mag = -1.0;

sprintf(infile,"stdin");
sprintf(velfile,"NOT_PROVIDED");

setpar(ac, av);
getpar("infile","s",infile);
getpar("velfile","s",velfile);
getpar("moment","f",&moment);
if(moment < 0.0)
   mstpar("mag","f",&mag);
endpar();

if(mag > 0.0)
   moment = exp(1.5*(mag+10.7)*log(10.0));

read_Fvelmodel(velfile,&vmod);

if(strcmp(infile,"stdin") == 0)
   fpr = stdin;
else
   fpr = fopfile(infile,"r");

fgets(str,1024,fpr);
while(strncmp(str,"#",1) == 0)
   {
   rchar = fgets(str,1024,fpr);
   if(rchar == NULL)
      {
      fprintf(stderr,"Unexpected EOF in %s, exiting...\n",infile);
      exit(-99);
      }
   }

sscanf(str,"%d",&nseg);

msum = 0.0;
for(i=0;i<nseg;i++)
   {
   fgets(str,1024,fpr);
   sscanf(str,"%f %f %f %f %d %d",&dtop,&dip,&flen,&fwid,&nlen,&nwid);

   dwid = fwid/nwid;
   moment_sum(&vmod,&dtop,&dip,&flen,&dwid,nwid,&msum);
   }
fclose(fpr);

fprintf(stdout,"average_slip= %.2f moment= %13.5e msum= %13.5e\n",moment/msum,moment,msum);
}
Ejemplo n.º 3
0
int main(int ac,char **av)
{
struct statdata shead1, shead2, shead3;
float *s1, *s2, *p;

float f1 = 1.0;
float f2 = 1.0;

float t1 = 0.0;
float t2 = 0.0;

char infile1[256];
char infile2[256];
char outfile[256];

int inbin1 = 0;
int inbin2 = 0;
int outbin = 0;

int it;
float add_rand = 0.0;

setpar(ac,av);
getpar("f1","f",&f1);
getpar("t1","f",&t1);
mstpar("infile1","s",infile1);
getpar("f2","f",&f2);
getpar("t2","f",&t2);
mstpar("infile2","s",infile2);
mstpar("outfile","s",outfile);
getpar("inbin1","d",&inbin1);
getpar("inbin2","d",&inbin2);
getpar("outbin","d",&outbin);
getpar("add_rand","f",&add_rand);
endpar();

s1 = NULL;
s1 = read_wccseis(infile1,&shead1,s1,inbin1);
s2 = NULL;
s2 = read_wccseis(infile2,&shead2,s2,inbin2);

p = (float *) check_malloc ((shead1.nt+shead2.nt)*size_float);

sum(s1,&shead1,&f1,&t1,s2,&shead2,&f2,&t2,p,&shead3);

strcpy(shead3.stat,shead1.stat);
strcpy(shead3.comp,shead1.comp);
sprintf(shead3.stitle,"summed output");

if(add_rand > (float)(0.0))
   {
   for(it=0;it<shead3.nt;it++)
      p[it] = p[it] + add_rand*frand();
   }

write_wccseis(outfile,&shead3,p,outbin);
}
Ejemplo n.º 4
0
main(int ac,char **av)
{
char infile[256], outfile[256], new_version[256];

struct standrupformat srf1;
struct srf_prectsegments *prseg_ptr1;
struct srf_apointvalues *apval_ptr1;

int inbin = 0;
int outbin = 0;

int i, ioff;

sprintf(infile,"stdin");
sprintf(outfile,"stdout");
sprintf(new_version,"1.0");

setpar(ac,av);
getpar("infile","s",infile);
getpar("inbin","d",&inbin);
getpar("outfile","s",outfile);
getpar("outbin","d",&outbin);
getpar("new_version","s",new_version);
endpar();

read_srf(&srf1,infile,inbin);

strcpy(srf1.version,new_version);

/*
sprintf(srf1.srf_hcmnt.cbuf,"#\n");
sprintf((srf1.srf_hcmnt.cbuf)+MAXLINE,"# ");
sprintf((srf1.srf_hcmnt.cbuf)+2*MAXLINE,"#\n");

ioff = 2;
for(i=0;i<ac;i++)
   {
   sprintf((srf1.srf_hcmnt.cbuf)+ioff+MAXLINE,"%s ",av[i]);
   while(srf1.srf_hcmnt.cbuf[ioff+MAXLINE] != '\0' && ioff < MAXLINE-2)
      ioff++;
   }
sprintf((srf1.srf_hcmnt.cbuf)+ioff+MAXLINE,"\n");
*/

write_srf(&srf1,outfile,outbin);
}
Ejemplo n.º 5
0
main(int ac,char **av)
{
char infile1[1024], infile2[1024], outfile[1024];
struct standrupformat srf1, srf2, srf3;

int inbin = 0;
int outbin = 0;

sprintf(outfile,"stdout");

setpar(ac,av);
mstpar("infile1","s",infile1);
mstpar("infile2","s",infile2);
getpar("outfile","s",outfile);
endpar();

read_srf(&srf1,infile1,inbin);
read_srf(&srf2,infile2,inbin);

join_segs(&srf1,&srf2,&srf3);

write_srf(&srf3,outfile,outbin);
}
Ejemplo n.º 6
0
main(int ac,char **av)
{
int nseg;
char infile[256], type[64], outfile[256];

struct standrupformat srf;

int vmax2slip = 0;
int inbin = 0;
float maxslip = 0.0;
int kp = -1;

sprintf(infile,"stdin");
sprintf(outfile,"stdout");
sprintf(type,"slip");
nseg = 0;

setpar(ac,av);
getpar("infile","s",infile);
getpar("outfile","s",outfile);
getpar("type","s",type);
getpar("nseg","d",&nseg);
getpar("inbin","d",&inbin);
getpar("vmax2slip","d",&vmax2slip);
getpar("maxslip","f",&maxslip);
getpar("kp","d",&kp);
endpar();

read_srf(&srf,infile,inbin);
if(vmax2slip == 1)
   get_vmax2slip(outfile,&srf,type,nseg);
else
   {
   write_maxsvf(outfile,&srf,type,nseg,&maxslip,kp);
   fprintf(stderr,"maxslip= %f\n",maxslip);
   }
}
Ejemplo n.º 7
0
main(int ac,char **av)
{
float *stf1, *stf2;
int it, i, ip, ig, ix, iy, ixp, iyp;
int ncoarsestk, ncoarsedip;
int ntot1, ntot2, *new_nstk, *new_ndip, *old_nstk, *old_ndip;
char infile[256], outfile[256];

struct standrupformat srf1, srf2;
struct srf_prectsegments *prseg_ptr1, *prseg_ptr2;
struct srf_apointvalues *apval_ptr1, *apval_ptr2;

int inbin = 0;
int outbin = 0;

sprintf(infile,"stdin");
sprintf(outfile,"stdout");

setpar(ac,av);
getpar("infile","s",infile);
getpar("inbin","d",&inbin);
getpar("outfile","s",outfile);
getpar("outbin","d",&outbin);
mstpar("ncoarsestk","d",&ncoarsestk);
mstpar("ncoarsedip","d",&ncoarsedip);
endpar();

read_srf(&srf1,infile,inbin);

strcpy(srf2.version,srf1.version);
copy_hcmnt(&srf2,&srf1);

if(strncmp(srf1.type,"PLANE",5) == 0)
   {
   strcpy(srf2.type,srf1.type);
   srf2.srf_prect.nseg = srf1.srf_prect.nseg;

   srf2.srf_prect.prectseg = (struct srf_prectsegments *)check_malloc(srf2.srf_prect.nseg*sizeof(struct srf_prectsegments));

   prseg_ptr1 = srf1.srf_prect.prectseg;
   prseg_ptr2 = srf2.srf_prect.prectseg;

   old_nstk = (int *)check_malloc((srf1.srf_prect.nseg)*sizeof(int));
   old_ndip = (int *)check_malloc((srf1.srf_prect.nseg)*sizeof(int));
   new_nstk = (int *)check_malloc((srf2.srf_prect.nseg)*sizeof(int));
   new_ndip = (int *)check_malloc((srf2.srf_prect.nseg)*sizeof(int));

   for(ig=0;ig<srf2.srf_prect.nseg;ig++)
      {
      prseg_ptr2[ig].elon = prseg_ptr1[ig].elon;
      prseg_ptr2[ig].elat = prseg_ptr1[ig].elat;
      prseg_ptr2[ig].nstk = (int)((1.0*prseg_ptr1[ig].nstk/ncoarsestk + 0.5));
      prseg_ptr2[ig].ndip = (int)((1.0*prseg_ptr1[ig].ndip/ncoarsedip + 0.5));
      prseg_ptr2[ig].flen = prseg_ptr2[ig].nstk*ncoarsestk*(prseg_ptr1[ig].flen/prseg_ptr1[ig].nstk);
      prseg_ptr2[ig].fwid = prseg_ptr2[ig].ndip*ncoarsedip*(prseg_ptr1[ig].fwid/prseg_ptr1[ig].ndip);
      prseg_ptr2[ig].stk  = prseg_ptr1[ig].stk;
      prseg_ptr2[ig].dip  = prseg_ptr1[ig].dip;
      prseg_ptr2[ig].dtop = prseg_ptr1[ig].dtop;
      prseg_ptr2[ig].shyp = prseg_ptr1[ig].shyp;
      prseg_ptr2[ig].dhyp = prseg_ptr1[ig].dhyp;

      old_nstk[ig] = prseg_ptr1[ig].nstk;
      old_ndip[ig] = prseg_ptr1[ig].ndip;
      new_nstk[ig] = prseg_ptr2[ig].nstk;
      new_ndip[ig] = prseg_ptr2[ig].ndip;
      }
   }

srf2.nseg = srf1.nseg;
srf2.np_seg = (int *)check_malloc((srf2.nseg)*sizeof(int));

if(atof(srf2.version) < 2.0)
   {
   for(ig=1;ig<srf2.nseg;ig++)
      {
      old_nstk[0] = old_nstk[0] + old_nstk[ig];
      new_nstk[0] = new_nstk[0] + new_nstk[ig];
      }

   srf2.np_seg[0] = new_nstk[0]*new_ndip[0];
   srf2.srf_apnts.np = new_nstk[0]*new_ndip[0];
   }

else if(atof(srf2.version) >= 2.0)
   {
   srf2.srf_apnts.np = 0;
   for(ig=0;ig<srf2.nseg;ig++)
      {
      srf2.np_seg[ig] = new_nstk[ig]*new_ndip[ig];
      srf2.srf_apnts.np = srf2.srf_apnts.np + srf2.np_seg[ig];
      }
   }

srf2.srf_apnts.apntvals = (struct srf_apointvalues *)check_malloc((srf2.srf_apnts.np)*sizeof(struct srf_apointvalues));

apval_ptr1 = srf1.srf_apnts.apntvals;
apval_ptr2 = srf2.srf_apnts.apntvals;

ntot1 = 0;
ntot2 = 0;
for(ig=0;ig<srf2.nseg;ig++)
   {
   for(iy=0;iy<new_ndip[ig];iy++)
      {
      iyp = (int)((float)(iy + 0.5)*ncoarsedip);
      for(ix=0;ix<new_nstk[ig];ix++)
         {
         ixp = (int)((float)(ix + 0.5)*ncoarsestk);

         i = ix + iy*new_nstk[ig] + ntot2;
         ip = ixp + iyp*old_nstk[ig] + ntot1;

         apval_ptr2[i].lon   = apval_ptr1[ip].lon;
         apval_ptr2[i].lat   = apval_ptr1[ip].lat;
         apval_ptr2[i].dep   = apval_ptr1[ip].dep;
         apval_ptr2[i].stk   = apval_ptr1[ip].stk;
         apval_ptr2[i].dip   = apval_ptr1[ip].dip;
         apval_ptr2[i].area  = apval_ptr1[ip].area*(ncoarsestk*ncoarsedip);
         apval_ptr2[i].tinit = apval_ptr1[ip].tinit;
         apval_ptr2[i].dt    = apval_ptr1[ip].dt;
         apval_ptr2[i].vs    = apval_ptr1[ip].vs;
         apval_ptr2[i].den    = apval_ptr1[ip].den;

         apval_ptr2[i].rake  = apval_ptr1[ip].rake;
         apval_ptr2[i].slip1 = apval_ptr1[ip].slip1;
         apval_ptr2[i].nt1   = apval_ptr1[ip].nt1;
         apval_ptr2[i].slip2 = apval_ptr1[ip].slip2;
         apval_ptr2[i].nt2   = apval_ptr1[ip].nt2;
         apval_ptr2[i].slip3 = apval_ptr1[ip].slip3;
         apval_ptr2[i].nt3   = apval_ptr1[ip].nt3;

         apval_ptr2[i].stf1 = (float *)check_malloc((apval_ptr2[i].nt1)*sizeof(float));
         apval_ptr2[i].stf2 = (float *)check_malloc((apval_ptr2[i].nt2)*sizeof(float));
         apval_ptr2[i].stf3 = (float *)check_malloc((apval_ptr2[i].nt3)*sizeof(float));

         stf1 = apval_ptr1[ip].stf1;
         stf2 = apval_ptr2[i].stf1;
         for(it=0;it<apval_ptr2[i].nt1;it++)
            stf2[it] = stf1[it];

         stf1 = apval_ptr1[ip].stf2;
         stf2 = apval_ptr2[i].stf2;
         for(it=0;it<apval_ptr2[i].nt2;it++)
            stf2[it] = stf1[it];

         stf1 = apval_ptr1[ip].stf3;
         stf2 = apval_ptr2[i].stf3;
         for(it=0;it<apval_ptr2[i].nt3;it++)
            stf2[it] = stf1[it];
         }
      }
   ntot1 = ntot1 + srf1.np_seg[ig];
   ntot2 = ntot2 + srf2.np_seg[ig];
   }

write_srf(&srf2,outfile,outbin);
}
Ejemplo n.º 8
0
main(int ac,char **av)
{
FILE *fpr, *fpw, *fopfile();
float *per, *resid, vs30, cdst, xcos, ycos, tmin, tmax;
float *bias, *sigma, *sigma0, *cl90m, *cl90p;
int nstat, nper, nval, i;

float min_cdst = -1e+15;
float max_cdst =  1e+15;
float min_vs30 = -1e+15;
float max_vs30 =  1e+15;
float min_xcos = -1e+15;
float max_xcos =  1e+15;
float min_ycos = -1e+15;
float max_ycos =  1e+15;

char residfile[256], fileroot[256], comp[16], rdcomp[16];
char *sptr, string[2048];

setpar(ac,av);

mstpar("residfile","s",residfile);
mstpar("fileroot","s",fileroot);
mstpar("comp","s",comp);
mstpar("nstat","d",&nstat);
mstpar("nper","d",&nper);

getpar("min_cdst","f",&min_cdst);
getpar("max_cdst","f",&max_cdst);
getpar("min_vs30","f",&min_vs30);
getpar("max_vs30","f",&max_vs30);
getpar("min_xcos","f",&min_xcos);
getpar("max_xcos","f",&max_xcos);
getpar("min_ycos","f",&min_ycos);
getpar("max_ycos","f",&max_ycos);

endpar();

per = (float *) check_malloc (nper*sizeof(float));
bias = (float *) check_malloc (nper*sizeof(float));
sigma = (float *) check_malloc (nper*sizeof(float));
sigma0 = (float *) check_malloc (nper*sizeof(float));
cl90m = (float *) check_malloc (nper*sizeof(float));
cl90p = (float *) check_malloc (nper*sizeof(float));
resid = (float *) check_malloc (nstat*nper*sizeof(float));

fpr = fopfile(residfile,"r");

fgets(string,2048,fpr);

sptr = skipval(13,string);

for(i=0;i<nper;i++)
   sptr = getflt(&per[i],sptr);

nval = 0;
while(fgets(string,2048,fpr) != NULL)
   {
   sscanf(string,"%*s %*f %*s %*f %*f %*d %f %f %f %f %f %f %s",&vs30,&cdst,&xcos,&ycos,&tmin,&tmax,rdcomp);

   if((vs30 >= min_vs30 && vs30 <= max_vs30) &&
      (cdst >= min_cdst && cdst <= max_cdst) &&
      (xcos >= min_xcos && xcos <= max_xcos) &&
      (ycos >= min_ycos && ycos <= max_ycos) &&
      (strcmp(rdcomp,comp)==0) )
      {
      sptr = skipval(13,string);

      for(i=0;i<nper;i++)
         sptr = getflt(&resid[i+nval*nper],sptr);

      nval++;
      }

   if(nval>nstat)
      {
      fprintf(stderr,"(nval= %d) > (nstat= %d), exiting...\n",nval,nstat);
      exit(-1);
      }
   }

fclose(fpr);

fprintf(stderr,"nval= %d\n",nval);

uncert(nval,nper,resid,bias,sigma,sigma0,cl90m,cl90p);

sprintf(string,"%s.bias",fileroot);
fpw = fopfile(string,"w");

for(i=0;i<nper;i++)
   fprintf(fpw,"%13.5e %13.5e\n",per[i],bias[i]);

fclose(fpw);

sprintf(string,"%s.sigma",fileroot);
fpw = fopfile(string,"w");

for(i=0;i<nper;i++)
   fprintf(fpw,"%13.5e %13.5e\n",per[i],sigma[i]);

fclose(fpw);

sprintf(string,"%s.sigma0",fileroot);
fpw = fopfile(string,"w");

for(i=0;i<nper;i++)
   fprintf(fpw,"%13.5e %13.5e\n",per[i],sigma0[i]);

fclose(fpw);

sprintf(string,"%s.m90",fileroot);
fpw = fopfile(string,"w");

for(i=0;i<nper;i++)
   fprintf(fpw,"%13.5e %13.5e\n",per[i],cl90m[i]);

fclose(fpw);

sprintf(string,"%s.p90",fileroot);
fpw = fopfile(string,"w");

for(i=0;i<nper;i++)
   fprintf(fpw,"%13.5e %13.5e\n",per[i],cl90p[i]);

fclose(fpw);
}
Ejemplo n.º 9
0
main(int ac, char **av)
{
struct tsheader tsh;
float s1[10];
int i, it, ixp, iyp;
int np1_byte, off1, off2, off3;
int fdr, fdw1, fdw2, fdw3;
char in_tsfile[128], out_tsfile[128];
off_t off;

int swap_bytes = 0;
int inbin = 0;
int zero_tsfile = 0;
int nt = -1;

it = -1;

setpar(ac, av);
mstpar("in_tsfile","s",in_tsfile);
getpar("it","d",&it);
endpar();

fdr = opfile_ro(in_tsfile);
reed(fdr,&tsh,sizeof(struct tsheader));

if(swap_bytes)
   {
   swap_in_place(1,(char *)(&tsh.ix0));
   swap_in_place(1,(char *)(&tsh.iy0));
   swap_in_place(1,(char *)(&tsh.iz0));
   swap_in_place(1,(char *)(&tsh.it0));
   swap_in_place(1,(char *)(&tsh.nx));
   swap_in_place(1,(char *)(&tsh.ny));
   swap_in_place(1,(char *)(&tsh.nz));
   swap_in_place(1,(char *)(&tsh.nt));
   swap_in_place(1,(char *)(&tsh.dx));
   swap_in_place(1,(char *)(&tsh.dy));
   swap_in_place(1,(char *)(&tsh.dz));
   swap_in_place(1,(char *)(&tsh.dt));
   swap_in_place(1,(char *)(&tsh.modelrot));
   swap_in_place(1,(char *)(&tsh.modellat));
   swap_in_place(1,(char *)(&tsh.modellon));
   }

fprintf(stderr,"ix= %d iy= %d iz= %d it= %d\n",tsh.ix0,tsh.iy0,tsh.iz0,tsh.it0);
fprintf(stderr,"nx= %d ny= %d nz= %d nt= %d\n",tsh.nx,tsh.ny,tsh.nz,tsh.nt);
fprintf(stderr,"dx= %12.4e dy= %12.4e dz= %12.4e dt= %12.4e\n",tsh.dx,tsh.dy,tsh.dz,tsh.dt);
fprintf(stderr,"lon= %10.4f lat= %10.4f rot= %10.4f\n",tsh.modellon,tsh.modellat,tsh.modelrot);

if(it<0)
   off = (3*tsh.nx*tsh.ny*tsh.nt-5)*sizeof(float);
else
   off = it*sizeof(float);

fprintf(stderr,"off= %20.0f\n",1.0*off);
fprintf(stderr,"off= %lld\n",off);
/*
split_bytes((char *)(&off),(char *)(&off1),(char *)(&off2));
*/
fprintf(stderr,"off2= %d off1= %d\n",off2,off1);
fprintf(stderr,"size= %d\n",sizeof(off_t));
fprintf(stderr,"size= %d\n",sizeof(off));

lseek(fdr,off,SEEK_CUR);

reed(fdr,s1,10*sizeof(float));
close(fdr);

for(i=0;i<10;i++)
   fprintf(stderr,"s1[%d]= %13.5e\n",i,s1[i]);
}
Ejemplo n.º 10
0
main(int ac,char **av)
{
FILE *fopfile(), *fpr, *fpwsv, *fpwrt, *fpwtr;
struct gfheader gfhead[4];
float maxgft;
struct gfparam gfpar;
float *gf, *gfmech;
int kg, ig;

float kperd_n, kperd_e;
float elat, elon, slat, slon, snorth, seast;
double e2, den, g2, lat0;

float len, wid, strike, dip, rake, dtop;
int i, j, k, l, ip, ip0;

int tshift_timedomain = 0;

struct beroza brm;
struct okumura orm;
struct gene grm;
struct rob rrm;
struct standrupformat srf;
struct srf_planerectangle *prect_ptr;
struct srf_prectsegments *prseg_ptr;
struct srf_allpoints *apnts_ptr;
struct srf_apointvalues *apval_ptr;

struct mechparam mechpar;
int maxmech;

int nstf;
float vslip;

int apv_off;
int nseg = 0;
int inbin = 0;

float tsfac = 0.0;
float tmom = 0.0;

float rupvel = -1.0;
float shal_vrup = 1.0;
float htol = 0.1;
double rayp, rupt_rad;
float rvfrac, rt, *randt;
struct velmodel vmod, rvmod;

int seed = 1;
int randtime = 0;
float perc_randtime = 0.0;
float delt = 0.0;
int smooth_randt = 2;
int gaus_randt = 0;
int randmech = 0;
float deg_randstk = 0.0;
float deg_randdip = 0.0;
float deg_randrak = 0.0;
float zap = 0.0;
int nn;

int kp;
float *rwt, sum;
float randslip = 0.0;

float len2, ds0, dd0, dsf, ddf, s2;
int ntsum, maxnt, it, ntp2;
float mindt;
float x0, y0, z0, dd;
float x0c, ddc, avgvrup;
float shypo, dhypo;
int nsubstk, nsubdip;
int nfinestk = 1;
int nfinedip = 1;
int ntout = -99;

float *stf, *seis, *subseis, *se, *sn, *sv;
float cosS, sinS, cosA, sinA;
float scale, arg, cosD, sinD;
float xstr, xdip, xrak;
float area, sfac;
float trise;

float azi, rng, deast, dnorth;
int ncomp = 3;

float *space;
float dtout = -1.0;

int fdw;
char gfpath[128], gfname[64];
char rtimesfile[128], modfile[128], outfile[128];
char slipfile[128], rupmodfile[128], outdir[128], stat[64], sname[8];
char rupmodtype[128], trisefile[128];
char string[256];

int write_ruptimes = 0;
int write_slipvals = 0;
int write_risetime = 0;

double rperd = 0.017453293;
float normf = 1.0e+10;  /* km^2 -> cm^2 */

float targetslip = 1.0;  /* slip in cm on each subfault */
float slip_conv = 1.0;  /* input slip in cm on each subfault */

float half = 0.5;
float two = 2.0;

int latloncoords = 0;

float tstart = 0.0;

rtimesfile[0] = '\0';
slipfile[0] = '\0';
trisefile[0] = '\0';
sname[0] = '\0';
sprintf(rupmodtype,"NULL");

sprintf(gfpar.gftype,"fk");

setpar(ac, av);
getpar("latloncoords","d",&latloncoords);

if(latloncoords == 1)
   {
   mstpar("elat","f",&elat);
   mstpar("elon","f",&elon);
   mstpar("slat","f",&slat);
   mstpar("slon","f",&slon);
   }
else
   {
   mstpar("snorth","f",&snorth);
   mstpar("seast","f",&seast);
   }

mstpar("dtop","f",&dtop);
mstpar("strike","f",&strike);
mstpar("dip","f",&dip);
mstpar("rake","f",&rake);

getpar("rupmodtype","s",rupmodtype);

if(strcmp(rupmodtype,"BEROZA") == 0)
   {
   brm.inc_stk = 1;
   brm.inc_dip = 1;
   brm.generic_risetime = -1.0;
   brm.robstf = 0;

   mstpar("rupmodfile","s",rupmodfile);
   mstpar("npstk","d",&brm.npstk);
   mstpar("npdip","d",&brm.npdip);
   mstpar("inc_stk","d",&brm.inc_stk);
   mstpar("inc_dip","d",&brm.inc_dip);

   mstpar("len","f",&len);
   mstpar("wid","f",&wid);

   getpar("robstf","d",&brm.robstf);
   getpar("generic_risetime","f",&brm.generic_risetime);
   if(brm.robstf == 0 && brm.generic_risetime > 0.0)
      {
      mstpar("generic_pulsedur","f",&brm.generic_pulsedur);
      mstpar("generic_t2","f",&brm.generic_t2);
      }

   getpar("slip_conv","f",&slip_conv);

   mstpar("outdir","s",outdir);
   mstpar("stat","s",stat);
   }
else if(strcmp(rupmodtype,"OKUMURA") == 0)
   {
   mstpar("rupmodfile","s",rupmodfile);

   getpar("slip_conv","f",&slip_conv);

   mstpar("outdir","s",outdir);
   mstpar("stat","s",stat);
   }
else if(strcmp(rupmodtype,"GENE") == 0)
   {
   mstpar("rupmodfile","s",rupmodfile);

   getpar("slip_conv","f",&slip_conv);

   mstpar("outdir","s",outdir);
   mstpar("stat","s",stat);
   }
else if(strcmp(rupmodtype,"ROB") == 0)
   {
   mstpar("rupmodfile","s",rupmodfile);

   getpar("slip_conv","f",&slip_conv);

   mstpar("outdir","s",outdir);
   mstpar("stat","s",stat);

   mstpar("shypo","f",&shypo);
   mstpar("dhypo","f",&dhypo);

   getpar("tsfac","f",&tsfac);

   getpar("rupvel","f",&rupvel);
   if(rupvel < 0.0)
      {
      mstpar("modfile","s",modfile);
      mstpar("rvfrac","f",&rvfrac);
      getpar("shal_vrup","f",&shal_vrup);
      }
   }
else if(strcmp(rupmodtype,"SRF") == 0)
   {
   mstpar("rupmodfile","s",rupmodfile);

   getpar("slip_conv","f",&slip_conv);
   getpar("nseg","d",&nseg);
   getpar("inbin","d",&inbin);

   mstpar("outdir","s",outdir);
   mstpar("stat","s",stat);
   }
else
   {
   mstpar("shypo","f",&shypo);
   mstpar("dhypo","f",&dhypo);

   mstpar("nsubstk","d",&nsubstk);
   mstpar("nsubdip","d",&nsubdip);

   mstpar("len","f",&len);
   mstpar("wid","f",&wid);

   getpar("rupvel","f",&rupvel);
   if(rupvel < 0.0)
      {
      mstpar("modfile","s",modfile);
      mstpar("rvfrac","f",&rvfrac);
      getpar("shal_vrup","f",&shal_vrup);
      }

   getpar("targetslip","f",&targetslip);

   mstpar("outfile","s",outfile);
   }

getpar("nfinestk","d",&nfinestk);
getpar("nfinedip","d",&nfinedip);

mstpar("gftype","s",gfpar.gftype);

if((strncmp(gfpar.gftype,"fk",2) == 0) || (strncmp(gfpar.gftype,"FK",2) == 0))
   {
   gfpar.flag3d = 0;
   gfpar.nc = 8;
   mstpar("gflocs","s",gfpar.gflocs);
   mstpar("gftimes","s",gfpar.gftimes);

   gfpar.swap_flag = 0;
   getpar("gf_swap_bytes","d",&gfpar.swap_flag);
   }
else if((strncmp(gfpar.gftype,"3d",2) == 0) || (strncmp(gfpar.gftype,"3D",2) == 0))
   {
   gfpar.flag3d = 1;
   gfpar.nc = 18;
   mstpar("gflocs","s",gfpar.gflocs);
   mstpar("gfrange_tolerance","f",&gfpar.rtol);
   }
else
   {
   fprintf(stderr,"gftype= %s invalid option, exiting...\n",gfpar.gftype);
   exit(-1);
   }

mstpar("gfpath","s",gfpath);
mstpar("gfname","s",gfname);

mstpar("maxnt","d",&maxnt);
mstpar("mindt","f",&mindt);
getpar("ntout","d",&ntout);
getpar("dtout","f",&dtout);

getpar("tstart","f",&tstart);
getpar("rtimesfile","s",rtimesfile);
getpar("slipfile","s",slipfile);
getpar("trisefile","s",trisefile);

getpar("seed","d",&seed);
getpar("randtime","d",&randtime);
if(randtime >= 1)
   mstpar("perc_randtime","f",&perc_randtime);
if(randtime >= 2)
   getpar("delt","f",&delt);
getpar("smooth_randt","d",&smooth_randt);
getpar("gaus_randt","d",&gaus_randt);

getpar("randslip","f",&randslip);

getpar("randmech","d",&randmech);
if(randmech)
   {
   mstpar("deg_randstk","f",&deg_randstk);
   mstpar("deg_randdip","f",&deg_randdip);
   mstpar("deg_randrak","f",&deg_randrak);
   }

getpar("tshift_timedomain","d",&tshift_timedomain);

getpar("sname","s",sname);

endpar();

fprintf(stderr,"type= %s\n",rupmodtype);

maxmech = 1;
mechpar.nmech = 1;
mechpar.flag[0] = U1FLAG;
mechpar.flag[1] = 0;
mechpar.flag[2] = 0;

if(strcmp(rupmodtype,"BEROZA") == 0)
   {
   len2 = 0.5*len;

   read_beroza(&brm,rupmodfile,&len2);

   nsubstk = (brm.npstk) - 1;
   nsubdip = (brm.npdip) - 1;

   targetslip = slip_conv;
   }
else if(strcmp(rupmodtype,"OKUMURA") == 0)
   {
   read_okumura(&orm,rupmodfile,&len2);

   nsubstk = orm.nstk;
   nsubdip = orm.ndip;

   len = orm.flen;
   wid = orm.fwid;

   targetslip = slip_conv;
   }
else if(strcmp(rupmodtype,"GENE") == 0)
   {
   read_gene(&grm,rupmodfile,&len2);

   nsubstk = grm.nstk;
   nsubdip = grm.ndip;

   len = grm.flen;
   wid = grm.fwid;

   targetslip = slip_conv;
   }
else if(strcmp(rupmodtype,"ROB") == 0)
   {
   read_rob(&rrm,rupmodfile,&tsfac);

/*   07/15/04
     For now, just use the getpar values, eventually we should modify
     in order to use the values read in from the slipmodel
*/

   rrm.elon = elon;
   rrm.elat = elat;
   rrm.stk = strike;
   rrm.dip = dip;
   rrm.dtop = dtop;
   rrm.shyp = shypo;
   rrm.dhyp = dhypo;

   nsubstk = rrm.nstk;
   nsubdip = rrm.ndip;

   len = rrm.flen;
   wid = rrm.fwid;

   len2 = 0.5*len;

   if(rupvel < 0.0)
      {
      read_velmodel(modfile,&vmod);
      conv2vrup(&vmod,&rvmod,&dip,&dtop,&wid,&rvfrac,&shal_vrup);
      }

   targetslip = slip_conv;
   }
else if(strcmp(rupmodtype,"SRF") == 0)
   {
   maxmech = 3;

   read_srf(&srf,rupmodfile,inbin);
   prect_ptr = &srf.srf_prect;
   prseg_ptr = prect_ptr->prectseg;
   apnts_ptr = &srf.srf_apnts;
   apval_ptr = apnts_ptr->apntvals;

/*   05/19/05
     For now, only use one segment from standard rupture model format;
     specified with 'nseg'.
*/

   elon = prseg_ptr[nseg].elon;
   elat = prseg_ptr[nseg].elat;
   strike = prseg_ptr[nseg].stk;
   dip = prseg_ptr[nseg].dip;
   dtop = prseg_ptr[nseg].dtop;
   shypo = prseg_ptr[nseg].shyp;
   dhypo = prseg_ptr[nseg].dhyp;

   nsubstk = prseg_ptr[nseg].nstk;
   nsubdip = prseg_ptr[nseg].ndip;

   len = prseg_ptr[nseg].flen;
   wid = prseg_ptr[nseg].fwid;

   /* reset POINTS pointer to appropriate segment */

   apv_off = 0;
   for(i=0;i<nseg;i++)
      apv_off = apv_off + prseg_ptr[i].nstk*prseg_ptr[i].ndip;

   apval_ptr = apval_ptr + apv_off;

   len2 = 0.5*len;
   targetslip = slip_conv;
   }
else
   {
   len2 = 0.5*len;

   if(rupvel < 0.0)
      {
      read_velmodel(modfile,&vmod);
      conv2vrup(&vmod,&rvmod,&dip,&dtop,&wid,&rvfrac,&shal_vrup);
      }
   }

if(randtime)
   {
   fprintf(stderr,"**** Initiation time randomized\n");
   fprintf(stderr,"          slow variation= +/-%.0f percent\n",100*perc_randtime);
   fprintf(stderr,"          fast variation= +/-%g sec\n",delt);
   }
else
   {
   perc_randtime = 0.0;
   delt = 0.0;
   }

if(randmech)
   {
   fprintf(stderr,"**** strike randomized by +/-%.0f degrees\n",deg_randstk);
   fprintf(stderr,"        dip randomized by +/-%.0f degrees\n",deg_randdip);
   fprintf(stderr,"       rake randomized by +/-%.0f degrees\n",deg_randrak);
   }
else
   {
   deg_randstk = 0.0;
   deg_randdip = 0.0;
   deg_randrak = 0.0;
   }

arg = strike*rperd;
cosS = cos(arg);
sinS = sin(arg);

arg = dip*rperd;
cosD = cos(arg);
sinD = sin(arg);

get_gfpars(&gfpar);

if(latloncoords) /* calculate lat,lon to km conversions */
   set_ne(&elon,&elat,&slon,&slat,&snorth,&seast);

if(dtout < 0.0)
   dtout = mindt;

if(dtout < mindt)
   maxnt = (maxnt*mindt/dtout);

ntsum = 2;
while(ntsum < 4*maxnt)
   ntsum = ntsum*2;

if(ntout < 0)
   ntout = ntsum;

gf = (float *) check_malloc (4*gfpar.nc*ntsum*sizeof(float));
gfmech = (float *) check_malloc (maxmech*12*ntsum*sizeof(float));
space = (float *) check_malloc (2*ntsum*sizeof(float));

seis = (float *) check_malloc (3*ntout*sizeof(float));
subseis = (float *) check_malloc (maxmech*3*ntout*sizeof(float));
stf = (float *) check_malloc (ntout*sizeof(float));

/* Calculate subfault responses */

ds0 = len/nsubstk;
dd0 = wid/nsubdip;

dsf = ds0/nfinestk;
ddf = dd0/nfinedip;

area = (len*wid)/(nsubstk*nsubdip);
sfac = targetslip*normf*area/(nfinestk*nfinedip);
if(gfpar.flag3d == 0)  /* add addtnl factor to convert mu for 1d GFs */
   sfac = sfac*normf;

rwt = (float *) check_malloc (nfinestk*nfinedip*sizeof(float));

if(randtime)
   {
   nn = nsubstk*nsubdip*nfinestk*nfinedip;
   randt = (float *) check_malloc (nn*sizeof(float));

   rand_init(randt,&perc_randtime,&seed,nsubstk,nsubdip,nfinestk,nfinedip,smooth_randt,gaus_randt);
   }

/* open output file */
if(strcmp(rupmodtype,"NULL") == 0)
   fdw = croptrfile(outfile);

if(rtimesfile[0] != '\0')
   {
   write_ruptimes = 1;
   fpwrt = fopfile(rtimesfile,"w");
   }

if(slipfile[0] != '\0')
   {
   write_slipvals = 1;
   fpwsv = fopfile(slipfile,"w");
   }

if(trisefile[0] != '\0')
   {
   write_risetime = 1;
   fpwtr = fopfile(trisefile,"w");
   }

zapit(seis,3*ntout);

for(i=0;i<4;i++)
   {
   gfhead[i].id = -1;  /* initialize: -1 means none read yet */
   gfhead[i].ir = -1;  /* initialize: -1 means none read yet */
   }

tmom = 0.0;
for(i=0;i<nsubstk;i++)
   {
   for(j=0;j<nsubdip;j++)
      {
      sum = 0.0;
      for(l=0;l<nfinedip*nfinestk;l++)
	 {
	 rwt[l] = randslip*sfrand(&seed);
	 sum = sum + rwt[l];
         }

      sum = sum/(float)(nfinedip*nfinestk);
      for(l=0;l<nfinedip*nfinestk;l++)
	 rwt[l] = rwt[l] - sum;

      zapit(subseis,maxmech*3*ntout);

      ip0 = i + j*nsubstk;

      for(k=0;k<nfinestk;k++)
	 {
	 x0 = i*ds0 + (k+0.5)*dsf - len2;

	 for(l=0;l<nfinedip;l++)
	    {
	    dd = j*dd0 + (l+0.5)*ddf;
	    y0 = dd*cosD;
	    z0 = dtop + dd*sinD;

	    kp = l + k*nfinedip;
	    ip = kp + (j + i*nsubdip)*nfinestk*nfinedip;

            if(strcmp(rupmodtype,"BEROZA") == 0)
	       {
               get_brmpars(&brm,i,j,&x0,&dd,&rt,&vslip);
	       trise = brm.tdur[ip0];
	       }
            else if(strcmp(rupmodtype,"OKUMURA") == 0)
	       {
               get_ormpars(&orm,i,j,&x0,&dd,&rt,&vslip);
	       trise = orm.rist[ip0];
	       }
            else if(strcmp(rupmodtype,"GENE") == 0)
	       {
               get_grmpars(&grm,i,j,&x0,&dd,&rt,&vslip,&rake);
	       trise = (grm.nt[ip0]-1)*grm.tdel + grm.trise;
	       }
            else if(strcmp(rupmodtype,"ROB") == 0)
	       {
               get_rrmpars(&rrm,i,j,&x0,&dd,&rt,&vslip,&rake,&tsfac);
	       trise = rrm.trise[ip0];

	       if(rt < 0.0)
		  {
	          if(rupvel < 0.0)
	             get_rupt(&rvmod,&htol,&dhypo,&dd,&shypo,&x0,&rayp,&rupt_rad,&rt);
	          else
	             rt = sqrt((shypo-x0)*(shypo-x0)+(dhypo-dd)*(dhypo-dd))/rupvel;
		  rt = rt + tsfac;
		  }

               if(rt < 0.0)
                  rt = 0.0;
	       }
            else if(strcmp(rupmodtype,"SRF") == 0)
	       {
               get_srfpars(&srf,apv_off,ip0,&rt,&vslip,&strike,&dip,&rake,&mechpar);
	       trise = apval_ptr[ip0].dt*apval_ptr[ip0].nt1;

/*
   For case when nfinestk,nfinedip > 1 =>
   calculate avg. Vr based on subfault center, then re-estimate Tinit 
   when nfinestk = nfinedip = 1, x0c=x0, ddc=dd.
*/
	       x0c = (i+0.5)*ds0 - len2;
	       ddc = (j+0.5)*dd0;
	       avgvrup = sqrt((shypo-x0c)*(shypo-x0c)+(dhypo-ddc)*(dhypo-ddc))/rt;
	       rt = sqrt((shypo-x0)*(shypo-x0)+(dhypo-dd)*(dhypo-dd))/avgvrup;
	       }
            else
               {
               vslip = 1.0;

	       if(rupvel < 0.0)
	          get_rupt(&rvmod,&htol,&dhypo,&dd,&shypo,&x0,&rayp,&rupt_rad,&rt);
	       else
	          rt = sqrt((shypo-x0)*(shypo-x0)+(dhypo-dd)*(dhypo-dd))/rupvel;
               }

	    if(randtime)
	       rt = rt*(1.0 + randt[ip]);
	    if(randtime == 2)
	       {
	       rt = rt + delt*sfrand(&seed);
	       if(rt < 0.0)
		  rt = 0.0;
               }

	    if(write_ruptimes == 1)
	       fprintf(fpwrt,"%13.5e %13.5e %13.5e\n",x0+len2,dd,rt);

            vslip = (1.0 + rwt[kp])*vslip;

            if(write_slipvals == 1)
               fprintf(fpwsv,"%13.5e %13.5e %13.5e\n",x0+len2,dd,slip_conv*vslip);

	    if(write_risetime == 1)
	       fprintf(fpwtr,"%13.5e %13.5e %13.5e\n",x0+len2,dd,trise);

	    get_radazi(&azi,&rng,&deast,&dnorth,&x0,&y0,&cosS,&sinS,&seast,&snorth);
	    find_4gf(gfpar,gfhead,&rng,&z0,&deast,&dnorth);

	    fprintf(stderr,"i=%3d j=%3d k=%3d l=%3d ",i,j,k,l);
	    fprintf(stderr," s=%7.2f d=%7.2f",x0,dd);
	    fprintf(stderr," dn=%10.5f de=%10.5f",dnorth,deast);
	    fprintf(stderr," a=%7.2f r=%7.2f\n",azi,rng);

            read_4gf(gfpath,gfname,gf,ntsum,gfhead,gfpar,&maxgft,&maxnt,&dtout,space);

	    if(randmech)
	       {
	       mechpar.stk = strike + deg_randstk*sfrand(&seed);
	       mechpar.dip = dip + deg_randdip*sfrand(&seed);
	       mechpar.rak = rake + deg_randrak*sfrand(&seed);
	       }
	    else
	       {
	       mechpar.stk = strike;
	       mechpar.dip = dip;
	       mechpar.rak = rake;
	       }

	    scale = sfac;
	    mech_4gf(gfmech,gf,gfhead,gfpar,ntsum,mechpar,&azi,&scale);

/* scale now contains the moment released by this point source */
	    tmom = tmom + vslip*scale;

	    sum_4gf(subseis,ntout,gfmech,gfhead,ntsum,maxnt,&rt,&maxgft,&tstart,tshift_timedomain,mechpar);
	    }
         }

      z0 = dtop + (j+0.5)*dd0*sinD;

      if(strcmp(rupmodtype,"BEROZA") == 0)
	 beroza_stf(&brm,i,j,seis,subseis,stf,ntout,&dtout,&z0);
      else if(strcmp(rupmodtype,"OKUMURA") == 0)
	 okumura_stf(&orm,i,j,seis,subseis,stf,ntout,&dtout);
      else if(strcmp(rupmodtype,"GENE") == 0)
	 gene_stf(&grm,i,j,seis,subseis,stf,ntout,&dtout);
      else if(strcmp(rupmodtype,"ROB") == 0)
	 rob_stf(&rrm,i,j,seis,subseis,stf,ntout,&dtout,&z0);
      else if(strcmp(rupmodtype,"SRF") == 0)
	 srf_stf(&srf,apv_off,ip0,seis,subseis,stf,ntout,&dtout,mechpar);
      else
         {
         sv = subseis;
         sn = subseis + ntout;
         se = subseis + 2*ntout;

         fortran_rite(fdw,1,&ncomp,sizeof(int));

         fortran_rite(fdw,2,&rng,sizeof(float),&tstart,sizeof(float));
         fortran_rite(fdw,2,&ntout,sizeof(int),&dtout,sizeof(float));
         fortran_rite(fdw,1,sn,ntout*sizeof(float));

         fortran_rite(fdw,2,&rng,sizeof(float),&tstart,sizeof(float));
         fortran_rite(fdw,2,&ntout,sizeof(int),&dtout,sizeof(float));
         fortran_rite(fdw,1,se,ntout*sizeof(float));

         fortran_rite(fdw,2,&rng,sizeof(float),&tstart,sizeof(float));
         fortran_rite(fdw,2,&ntout,sizeof(int),&dtout,sizeof(float));
         fortran_rite(fdw,1,sv,ntout*sizeof(float));
         }
      }
   }

if(strcmp(rupmodtype,"NULL") == 0)
   close(fdw);
else
   {
   sv = seis;
   sn = seis + ntout;
   se = seis + 2*ntout;

   if(sname[0] == '\0')
      {
      strncpy(sname,stat,7);
      sname[7] = '\0';
      }

   write_seis(outdir,stat,sname,"000",sn,&dtout,ntout,&tstart);
   write_seis(outdir,stat,sname,"090",se,&dtout,ntout,&tstart);
   write_seis(outdir,stat,sname,"ver",sv,&dtout,ntout,&tstart);

   fprintf(stderr,"Total moment= %13.5e\n",tmom);
   }

if(write_ruptimes == 1)
   {
   fflush(fpwrt);
   fclose(fpwrt);
   }

if(write_slipvals == 1)
   {
   fflush(fpwsv);
   fclose(fpwsv);
   }

if(write_risetime == 1)
   {
   fflush(fpwtr);
   fclose(fpwtr);
   }
}
Ejemplo n.º 11
0
main(int ac, char **av)
{
struct statdata gfh;
float *gf;
int k, isub, j, nc, nt;
int nbyte;
float dt, rng, tst;

int fdr;
char infile[128];
char name[128];
char outfile[128];

int outbin = 0;

static char *comp[] = {"000","090","ver"};

gfh.stitle[0] = '\0';
gfh.hr = 0;
gfh.min = 0;
gfh.sec = 0.0;
gfh.edist = 0.0;
gfh.az = 0.0;
gfh.baz = 0.0;

setpar(ac, av);
mstpar("infile","s",infile);
mstpar("isub","d",&isub);
getpar("outbin","d",&outbin);
endpar();

sprintf(gfh.stat,"%d",isub);

fdr = opfile_ro(infile);

for(k=0;k<isub;k++)
   {
   reed(fdr,&nbyte,sizeof(int));
   reed(fdr,&nc,sizeof(int));
   reed(fdr,&nbyte,sizeof(int));

   for(j=0;j<nc;j++)
      {
      reed(fdr,&nbyte,sizeof(int));
      reed(fdr,&rng,sizeof(float));
      reed(fdr,&tst,sizeof(float));
      reed(fdr,&nbyte,sizeof(int));

      reed(fdr,&nbyte,sizeof(int));
      reed(fdr,&nt,sizeof(int));
      reed(fdr,&dt,sizeof(float));
      reed(fdr,&nbyte,sizeof(int));

      gf = (float *) check_realloc(gf,nt*sizeof(float));

      reed(fdr,&nbyte,sizeof(int));
      reed(fdr,gf,nt*sizeof(float));
      reed(fdr,&nbyte,sizeof(int));
      }
   }

reed(fdr,&nbyte,sizeof(int));
reed(fdr,&nc,sizeof(int));
reed(fdr,&nbyte,sizeof(int));

for(j=0;j<nc;j++)
   {
   reed(fdr,&nbyte,sizeof(int));
   reed(fdr,&rng,sizeof(float));
   reed(fdr,&tst,sizeof(float));
   reed(fdr,&nbyte,sizeof(int));

   reed(fdr,&nbyte,sizeof(int));
   reed(fdr,&nt,sizeof(int));
   reed(fdr,&dt,sizeof(float));
   reed(fdr,&nbyte,sizeof(int));

   gf = (float *) check_realloc(gf,nt*sizeof(float));

   reed(fdr,&nbyte,sizeof(int));
   reed(fdr,gf,nt*sizeof(float));
   reed(fdr,&nbyte,sizeof(int));

   gfh.nt = nt;
   gfh.dt = dt;
   gfh.edist = rng;

   gfh.hr = (int)(tst/3600.0);
   gfh.min = (int)((tst - 3600.0*gfh.hr)/60.0);
   gfh.sec = (float)(tst - 60.0*gfh.min - 3600.0*gfh.hr);

   strcpy(gfh.comp,comp[j]);
   sprintf(outfile,"%s.%s",gfh.stat,gfh.comp);

   write_wccseis(outfile,&gfh,gf,outbin);
   }
close(fdr);
}
Ejemplo n.º 12
0
int main(int ac,char **av)
{
struct statdata head1;
float *s1;
float *p;
int nt1, i, j;

int order = 4;
float nyq_perc = 1.0;
float tap_perc = TAP_PERC;

int resamp = 0;
int ntpad, ntrsmp;
float fnt, dtout, *space;
int gnt;
float newdt = -1.0;
int ntout = -1;

float tol = 1.0e-02;

char infile[256];
char outfile[256];

int inbin = 0;
int outbin = 0;

int pow2 = 0;

sprintf(infile,"stdin");
sprintf(outfile,"stdout");

setpar(ac,av);
getpar("infile","s",infile);
getpar("outfile","s",outfile);
mstpar("newdt","f",&newdt);
getpar("nyq_perc","f",&nyq_perc);
getpar("tap_perc","f",&tap_perc);
getpar("order","d",&order);
getpar("ntout","d",&ntout);
getpar("inbin","d",&inbin);
getpar("outbin","d",&outbin);
getpar("pow2","d",&pow2);
endpar();

s1 = NULL;
s1 = read_wccseis(infile,&head1,s1,inbin);

if(newdt < 0.0 || newdt == head1.dt)
   {
   resamp = 0;

   if(ntout < 0)
      ntout = head1.nt;
   if(ntout > head1.nt)
      ntout = head1.nt;
   dtout = head1.dt;
   }
else                /* need to resample time history */
   {
   ntpad = 2*head1.nt;
   fnt = ntpad*head1.dt/newdt;
   gnt = (int)(fnt + 0.5);

   //force power of 2
   /*if (pow2==1) {
	printf("Forcing to power of 2.\n");
	int tot_t = head1.dt*head1.nt;
	//continue...
	ntrsmp = (int)fnt;
	while(nt_tol(fnt,gnt)>tol || ( (ntrsmp & (ntrsmp-1))!=0) ){
		ntpad++;
		fnt = ntpad*head1.dt/newdt;
		gnt = (int)(fnt + 0.5);
		ntrsmp = (int)fnt;
	}
   } else {*/
   	while(nt_tol(fnt,gnt) > tol)
   	   {
   	   ntpad++;
   	   fnt = ntpad*head1.dt/newdt;
   	   gnt = (int)(fnt + 0.5);
   	   }
   //}

   ntrsmp = (int)(fnt);

   if(ntout < 0)
      ntout = (int)(head1.nt*head1.dt/newdt);
   dtout = newdt;

   fprintf(stderr,"*** ntpad=%d ntrsmp=%d\n",ntpad,ntrsmp);

   if(newdt < head1.dt)
      {
      resamp = 1;

      if(ntout > ntrsmp)
         ntout = ntrsmp;

      space = (float *) check_malloc (2*ntrsmp*sizeof(float));
      s1 = (float *) check_realloc(s1,2*ntrsmp*sizeof(float));
      }
   else
      {
      resamp = -1;

      if(ntout > ntpad)
         ntout = ntpad;

      space = (float *) check_malloc (2*ntpad*sizeof(float));
      s1 = (float *) check_realloc(s1,2*ntpad*sizeof(float));
      }
   }

fprintf(stderr,"***nt=%d dt=%f\n",head1.nt,head1.dt);

if(resamp != 0)
   resample(s1,head1.nt,&head1.dt,resamp,ntpad,ntrsmp,&newdt,space,order,&nyq_perc,&tap_perc);

head1.nt = ntout;
head1.dt = dtout;

fprintf(stderr,"***nt=%d dt=%f\n",head1.nt,head1.dt);

write_wccseis(outfile,&head1,s1,outbin);
}
Ejemplo n.º 13
0
int set_new_value(KscServerBase* Server, Dienst_param* Params,
                  PltString& out)
/*****************************************************************************/
{
    KsSetVarParams          setpar(1);
    KsSetVarResult          erg(1);
    KscAvSimpleModule       *AV = GetClientAV();

    SetInstVarItems         *pset;
    PltString               log;
    int                     error;
    int                     fehler = 0;
    size_t                  siz;        // Merker : Anzahl zu setzenden Variablen
    size_t                  i;          // Lauf-Variable
    KsString                VarName;    // Merker : NAme der zu setzender Variable
    //char                    help[256];
    int                     isVendor = 0;

    if( !Params->Set_Inst_Var) {
        return 0;
    }
    if( !Params->Set_Inst_Var->Inst_var) {
        return 0;
    }

    pset = Params->Set_Inst_Var;

    // Sonderfall: "Vendor"
    VarName = pset->Inst_name;
    if(VarName == "/vendor") {
        isVendor = 1;
    }
    
    while(pset) {
        error = GetCreateObjectVar( pset->Inst_var, setpar.items);
        if(!error) {
            siz = setpar.items.size();
            for(i = 0; i < siz; i++) {
                VarName = setpar.items[i].path_and_name;
                setpar.items[i].path_and_name = pset->Inst_name;
                if(isVendor) {
                    // Trenner ist '/'. Der Variable wurde '.' hinzugefuegt
                    setpar.items[i].path_and_name += "/";
                    setpar.items[i].path_and_name += VarName.substr(1);
                } else {
                    // Part-Variable. Trenner '.' bereits in Name
                    setpar.items[i].path_and_name += VarName;
                }
            }
            bool ok = Server->requestByOpcode ( KS_SETVAR, AV, setpar, erg);
            if(!ok) {
                error = Server->getLastResult();
                if(error == KS_ERR_OK) error = KS_ERR_GENERIC;
            } else if(erg.result) {
                error = erg.result;
            } else {
                siz = erg.results.size();
                for(i = 0; i < siz; i++) {
                    if( erg.results[i].result) {
                        error = erg.results[i].result;
                        break;
                    }
                }
            }
        }
        if(error) {
            // Letzte Fehler-Kode merken
            fehler = error;
            out += log_getErrMsg(error, "Instance",pset->Inst_name,"couldn't be updated.");
        
            log  = "\"%s\"  \"";
            log += pset->Inst_name;
            log += "\"";
            iFBS_SetLastError(1, error, log);

        } else {
            out += log_getOkMsg("Instance",pset->Inst_name,"updated");
        }

        pset = pset->next;
    } /* while pset */ 

    return fehler;

} /* set_new_value() */
Ejemplo n.º 14
0
int main(int ac,char **av)
{
struct statdata head1;
float *s1, vref, vsite, vpga;
float *ampf;
int nt_p2;

float tap_per = TAP_PERC;
float pga = -1.0;

float fmin = 0.1;
float fmax = 15.0;

float flowcap = 0.0;   /* ampf for f<flowcap set equal to ampf[f=flowcap], (caps low-freq amplification level) */

char infile[128];
char outfile[128];
char model[128];

int inbin = 0;
int outbin = 0;

float fmidbot = 0.2;     /* bottom-end of middle frequency range */
float fmid = 1.0;        /* center of middle frequency range */
float fhigh = 3.333;     /* center of high frequency range */
float fhightop = 10.0;   /* top-end of high frequency range */

/*
sprintf(model,"borcherdt");
*/
sprintf(model,"cb2014");

setpar(ac,av);

mstpar("infile","s",infile);
mstpar("outfile","s",outfile);
mstpar("vref","f",&vref);
mstpar("vsite","f",&vsite);

getpar("model","s",model);
getpar("pga","f",&pga);
vpga = vref;
getpar("vpga","f",&vpga);
getpar("flowcap","f",&flowcap);

getpar("tap_per","f",&tap_per);
getpar("fmin","f",&fmin);
getpar("fmidbot","f",&fmidbot);
getpar("fmid","f",&fmid);
getpar("fhigh","f",&fhigh);
getpar("fhightop","f",&fhightop);
getpar("fmax","f",&fmax);
getpar("inbin","d",&inbin);
getpar("outbin","d",&outbin);

endpar();

if(strncmp(model,"borcherdt",9) != 0 && strncmp(model,"cb2008",6) != 0 && strncmp(model,"bssa2014",6) != 0)
   sprintf(model,"cb2014");

s1 = NULL;
s1 = read_wccseis(infile,&head1,s1,inbin);

nt_p2 = getnt_p2(head1.nt);
s1 = (float *) check_realloc (s1,nt_p2*size_float);

ampf = (float *) check_malloc ((nt_p2/2)*size_float);

if(pga < 0.0)
   getpeak(s1,head1.nt,&pga);
else
   fprintf(stderr,"*** External PGA used: ");

fprintf(stderr,"pga= %13.5e\n",pga);

taper_norm(s1,&head1.dt,head1.nt,&tap_per);
zero(s1+head1.nt,(nt_p2)-head1.nt);
forfft((struct complex *)s1,nt_p2,-1);

if(strncmp(model,"cb2014",6) == 0)
   cb2014_ampf(ampf,&head1.dt,nt_p2,&vref,&vsite,&vpga,&pga,&fmin,&fmidbot,&fmid,&fhigh,&fhightop,&fmax,&flowcap);
else if(strncmp(model,"bssa2014",8) == 0)
   bssa2014_ampf(ampf,&head1.dt,nt_p2,&vref,&vsite,&vpga,&pga,&fmin,&fmidbot,&fmid,&fhigh,&fhightop,&fmax,&flowcap);
else if(strncmp(model,"cb2008",6) == 0)
   cb2008_ampf(ampf,&head1.dt,nt_p2,&vref,&vsite,&vpga,&pga,&fmin,&fmidbot,&fmid,&fhigh,&fhightop,&fmax,&flowcap);
else
   borch_ampf(ampf,&head1.dt,nt_p2,&vref,&vsite,&pga,&fmin,&fmidbot,&fmid,&fhigh,&fhightop,&fmax);

ampfac((struct complex *)s1,ampf,nt_p2);

invfft((struct complex *)s1,nt_p2,1);
norm(s1,&head1.dt,nt_p2);

write_wccseis(outfile,&head1,s1,outbin);
}