https://github.com/geodynamics/citcoms
Raw File
Tip revision: b5721c162b1b01c9fdbfb544f8d60bf3742dd916 authored by Eric Heien on 02 August 2011, 16:52:33 UTC
Further work in converting tracer code to C++
Tip revision: b5721c1
Tracer_setup.c
/*
 *~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
 *
 *<LicenseText>
 *
 * CitcomS by Louis Moresi, Shijie Zhong, Lijie Han, Eh Tan,
 * Clint Conrad, Michael Gurnis, and Eun-seo Choi.
 * Copyright (C) 1994-2005, California Institute of Technology.
 *
 * This program is free software; you can redistribute it and/or modify
 * it under the terms of the GNU General Public License as published by
 * the Free Software Foundation; either version 2 of the License, or
 * (at your option) any later version.
 *
 * This program is distributed in the hope that it will be useful,
 * but WITHOUT ANY WARRANTY; without even the implied warranty of
 * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
 * GNU General Public License for more details.
 *
 * You should have received a copy of the GNU General Public License
 * along with this program; if not, write to the Free Software
 * Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA  02111-1307  USA
 *
 *</LicenseText>
 *
 *~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
 */
/*
  Tracer_setup.c

      A program which initiates the distribution of tracers
      and advects those tracers in a time evolving velocity field.
      Called and used from the CitCOM finite element code.
      Written 2/96 M. Gurnis for Citcom in cartesian geometry
      Modified by Lijie in 1998 and by Vlad and Eh in 2005 for the
      regional version of CitcomS. In 2003, Allen McNamara wrote the
      tracer module for the global version of CitcomS. In 2007, Eh Tan
      merged the two versions of tracer codes together.
*/

#include <math.h>
#include "global_defs.h"
#include "parsing.h"
#include "parallel_related.h"
#include "composition_related.h"

#ifdef USE_GGRD
#include "ggrd_handling.h"
#endif

#ifdef USE_GZDIR
int open_file_zipped(char *, FILE **,struct All_variables *);
void gzip_file(char *);
#endif

static void write_trace_instructions(struct All_variables *E);

int icheck_that_processor_shell(struct All_variables *E,
                                       int j, int nprocessor, double rad);
void tracer_post_processing(struct All_variables *E);
void allocate_tracer_arrays(struct All_variables *E,
                            int j, int number_of_tracers);
void count_tracers_of_flavors(struct All_variables *E);

int full_icheck_cap(struct All_variables *E, int icap,
                    CartesianCoord cc, double rad);
int regional_icheck_cap(struct All_variables *E, int icap,
                        SphericalCoord sc, double rad);

static void find_tracers(struct All_variables *E);
static void predict_tracers(struct All_variables *E);
static void correct_tracers(struct All_variables *E);
static void make_tracer_array(struct All_variables *E);
static void generate_random_tracers(struct All_variables *E,
                                    int tracers_cap, int j);
static void read_tracer_file(struct All_variables *E);
static void read_old_tracer_file(struct All_variables *E);
static void check_sum(struct All_variables *E);
static int isum_tracers(struct All_variables *E);
static void init_tracer_flavors(struct All_variables *E);
int read_double_vector(FILE *, int , double *);
int icheck_processor_shell(struct All_variables *,
                           int , double );

// Write coordinate values to memory
double *SphericalCoord::writeToMem(double *mem) const {
	mem[0] = _theta;
	mem[1] = _phi;
	mem[2] = _rad;
	return &mem[3];
}

// Read coordinate values from memory
double *SphericalCoord::readFromMem(double *mem) {
	double	*tmp = mem;
	_theta = mem[0];
	_phi = mem[1];
	_rad = mem[2];
	return &tmp[3];
}

// Write coordiante values to memory
double *CartesianCoord::writeToMem(double *mem) const {
	mem[0] = _x;
	mem[1] = _y;
	mem[2] = _z;
	return &mem[3];
}

// Read coordinate values from memory
double *CartesianCoord::readFromMem(double *mem) {
	_x = mem[0];
	_y = mem[1];
	_z = mem[2];
	return &mem[3];
}

// Return the size of storage required for this tracer in doubles
size_t Tracer::size(void) {
	return _sc.size()	// spherical coords
	+ _cc.size()		// Cartesian coords
	+ _cc0.size()		// Original coords
	+ _Vc.size()		// Velocity
	+ 1					// flavor
	+ 1;				// ielement
}

// Write all relevant tracer data to memory and return
// an updated pointer to the end of the written data
double *Tracer::writeToMem(double *mem) const {
	double	*tmp = mem;
	tmp = _sc.writeToMem(tmp);
	tmp = _cc.writeToMem(tmp);
	tmp = _cc0.writeToMem(tmp);
	tmp = _Vc.writeToMem(tmp);
	tmp[0] = _flavor;
	tmp[1] = _ielement;
	return &tmp[2];
}

// Read tracer data from memory and return an updated pointer
// to the end of the read data
double *Tracer::readFromMem(double *mem) {
	double	*tmp = mem;
	tmp = _sc.readFromMem(tmp);
	tmp = _cc.readFromMem(tmp);
	tmp = _cc0.readFromMem(tmp);
	tmp = _Vc.readFromMem(tmp);
	_flavor = tmp[0];
	_ielement = tmp[1];
	return &tmp[2];
}

// Convert Cartesian system coordinates to spherical
SphericalCoord CartesianCoord::toSpherical(void) const
{
	double temp, theta, phi, rad;
	
	temp=_x*_x+_y*_y;
	
	theta=atan2(sqrt(temp),_z);
	phi=myatan(_y,_x);
	rad=sqrt(temp+_z*_z);
	
	return SphericalCoord(theta, phi, rad);
}

// Convert spherical system coordinates to Cartesian
CartesianCoord SphericalCoord::toCartesian(void) const
{
	double sint,cost,sinf,cosf;
	double x, y, z;
	
	sint=sin(_theta);
	cost=cos(_theta);
	sinf=sin(_phi);
	cosf=cos(_phi);
	
	x=_rad*sint*cosf;
	y=_rad*sint*sinf;
	z=_rad*cost;
	
	return CartesianCoord(x,y,z);
}

// Add a coordinate to this one by summing the components
CartesianCoord & CartesianCoord::operator+=(const CartesianCoord &other) {
	this->_x += other._x;
	this->_y += other._y;
	this->_z += other._z;
	return *this;
}

// Get the difference of a coordinate from this one as vectors by subtracting components
CartesianCoord & CartesianCoord::operator-=(const CartesianCoord &other) {
	this->_x -= other._x;
	this->_y -= other._y;
	this->_z -= other._z;
	return *this;
}

// Multiply each component by a constant factor
CartesianCoord & CartesianCoord::operator*=(const double &val) {
	this->_x *= val;
	this->_y *= val;
	this->_z *= val;
	return *this;
}

// Divide each element by a constant factor
CartesianCoord & CartesianCoord::operator/=(const double &val) {
	this->_x /= val;
	this->_y /= val;
	this->_z /= val;
	return *this;
}

// Add two coordinates together as vectors by summing each of their components
const CartesianCoord CartesianCoord::operator+(const CartesianCoord &other) const {
	CartesianCoord	new_coord = *this;
	new_coord += other;
	return new_coord;
}

// Get the difference of two coordinates as vectors by subtracting each of their components
const CartesianCoord CartesianCoord::operator-(const CartesianCoord &other) const {
	CartesianCoord	new_coord = *this;
	new_coord -= other;
	return new_coord;
}

// Multiply each component by a constant factor
const CartesianCoord CartesianCoord::operator*(const double &val) const {
	CartesianCoord	new_coord = *this;
	new_coord *= val;
	return new_coord;
}

// Divide each element by a constant factor
const CartesianCoord CartesianCoord::operator/(const double &val) const {
	CartesianCoord	new_coord = *this;
	new_coord /= val;
	return new_coord;
}

// Return the cross product of this vector with another vector (b)
CartesianCoord CartesianCoord::crossProduct(const CartesianCoord &b) const {
	return CartesianCoord(this->_y*b._z - this->_z*b._y,
						  this->_z*b._x - this->_x*b._z,
						  this->_x*b._y - this->_y*b._x);
}

// Returns a constrained angle between 0 and 2 PI
double SphericalCoord::constrainAngle(const double angle) const {
    const double two_pi = 2.0*M_PI;
	
	return angle - two_pi * floor(angle/two_pi);
}

// Constrains theta to be between 0 and PI while simultaneously constraining phi between 0 and 2 PI
void SphericalCoord::constrainThetaPhi(void) {
	_theta = constrainAngle(_theta);
	if (_theta > M_PI) {
		_theta = 2*M_PI - _theta;
		_phi += M_PI;
	}
	_phi = constrainAngle(_phi);
}

// Set the boundaries of a cap specified by spherical coordinates
void CapBoundary::setBoundary(unsigned int bnum, SphericalCoord sc) {
	assert(bnum < 4);
	bounds[bnum] = BoundaryPoint(sc.toCartesian(),
								 sc,
								 cos(sc._theta),
								 sin(sc._theta),
								 cos(sc._phi),
								 sin(sc._phi));
}

// TODO: compute spherical coordinate?
void CapBoundary::setCartTrigBounds(unsigned int bnum, CartesianCoord cc, double cost, double sint, double cosf, double sinf) {
	assert(bnum < 4);
	bounds[bnum] = BoundaryPoint(cc,
								 SphericalCoord(),	// empty spherical bounds
								 cost,
								 sint,
								 cosf,
								 sinf);
}


TriElemLinearShapeFunc::TriElemLinearShapeFunc(CoordUV xy1, CoordUV xy2, CoordUV xy3) {
    double delta, a0, a1, a2;
	
	/* shape function 1 */
	delta = (xy3.u-xy2.u)*(xy1.v-xy2.v)-(xy2.v-xy3.v)*(xy2.u-xy1.u);
	a0 = (xy2.u*xy3.v-xy3.u*xy2.v)/delta;
	a1 = (xy2.v-xy3.v)/delta;
	a2 = (xy3.u-xy2.u)/delta;
	
	sf[0][0] = a0;
	sf[0][1] = a1;
	sf[0][2] = a2;
	
	/* shape function 2 */
	delta = (xy3.u-xy1.u)*(xy2.v-xy1.v)-(xy1.v-xy3.v)*(xy1.u-xy2.u);
	a0 = (xy1.u*xy3.v-xy3.u*xy1.v)/delta;
	a1 = (xy1.v-xy3.v)/delta;
	a2 = (xy3.u-xy1.u)/delta;
	
	sf[1][0] = a0;
	sf[1][1] = a1;
	sf[1][2] = a2;
	
	/* shape function 3 */
	
	delta = (xy1.u-xy2.u)*(xy3.v-xy2.v)-(xy2.v-xy1.v)*(xy2.u-xy3.u);
	a0 = (xy2.u*xy1.v-xy1.u*xy2.v)/delta;
	a1 = (xy2.v-xy1.v)/delta;
	a2 = (xy1.u-xy2.u)/delta;
	
	sf[2][0] = a0;
	sf[2][1] = a1;
	sf[2][2] = a2;
}

double TriElemLinearShapeFunc::applyShapeFunc(const unsigned int i, const CoordUV uv) const {
	assert(i < 3);
	return sf[i][0]+sf[i][1]*uv.u+sf[i][2]*uv.v;
}

void tracer_input(struct All_variables *E)
{
    char message[100];
    int m=E->parallel.me;
    int i;
	
    input_boolean("tracer",&(E->control.tracer),"off",m);
    input_boolean("tracer_enriched",
				  &(E->control.tracer_enriched),"off",m);
    if(E->control.tracer_enriched){
		if(!E->control.tracer)	/* check here so that we can get away
								 with only one if statement in
								 Advection_diffusion */
			myerror(E,"need to switch on tracers for tracer_enriched");
		
		input_float("Q0_enriched",&(E->control.Q0ER),"0.0",m);
		snprintf(message,100,"using compositionally enriched heating: C = 0: %g C = 1: %g (only one composition!)",
				 E->control.Q0,E->control.Q0ER);
		report(E,message);
		//
		// this check doesn't work at this point in the code, and we didn't want to put it into every call to
		// Advection diffusion
		//
		//if(E->composition.ncomp != 1)
		//myerror(E,"enriched tracers cannot deal with more than one composition yet");
		
    }
    if(E->control.tracer) {
		
        /* tracer_ic_method=0 (random generated array) */
        /* tracer_ic_method=1 (all proc read the same file) */
        /* tracer_ic_method=2 (each proc reads its restart file) */
        input_int("tracer_ic_method",&(E->trace.ic_method),"0,0,nomax",m);
		
        if (E->trace.ic_method==0){
            input_int("tracers_per_element",&(E->trace.itperel),"10,0,nomax",m);
		}
        else if (E->trace.ic_method==1)
            input_string("tracer_file",E->trace.tracer_file,"tracer.dat",m);
        else if (E->trace.ic_method==2) {
            /* Use 'datadir_old', 'datafile_old', and 'solution_cycles_init' */
            /* to form the filename */
        }
        else {
            fprintf(stderr,"Sorry, tracer_ic_method only 0, 1 and 2 available\n");
            parallel_process_termination();
        }
		
		
        /* How many flavors of tracers */
        /* If tracer_flavors > 0, each element will report the number of
         * tracers of each flavor inside it. This information can be used
         * later for many purposes. One of it is to compute composition,
         * either using absolute method or ratio method. */
        input_int("tracer_flavors",&(E->trace.nflavors),"0,0,nomax",m);
		
		/* 0: default from layers 
		 1: from netcdf grds
		 
		 
		 99: from grds, overriding checkpoints during restart
		 (1 and 99 require ggrd)
		 */
		
        input_int("ic_method_for_flavors",
				  &(E->trace.ic_method_for_flavors),"0,0,nomax",m);
		
		
        if (E->trace.nflavors > 1) {
            switch(E->trace.ic_method_for_flavors){
					/* default method */
				case 0:			
					/* flavors initialized from layers */
					E->trace.z_interface = (double*) malloc((E->trace.nflavors-1)
															*sizeof(double));
					for(i=0; i<E->trace.nflavors-1; i++)
						E->trace.z_interface[i] = 0.7;
					
					input_double_vector("z_interface", E->trace.nflavors-1,
										E->trace.z_interface, m);
					break;
					/* 
					 two grd init method, second will override restart
					 */
#ifdef USE_GGRD
				case 1:
				case 99:		/* will override restart */
					/* from grid in top n materials, this will override
					 the checkpoint input */
					input_string("ictracer_grd_file",E->trace.ggrd_file,"",m); /* file from which to read */
					input_int("ictracer_grd_layers",&(E->trace.ggrd_layers),"2",m); /* 
																					 
																					 >0 : which top layers to use, layer <= ictracer_grd_layers
																					 <0 : only use one layer layer == -ictracer_grd_layers
																					 
																					 */
					break;
					
#endif
				default:
					fprintf(stderr,"ic_method_for_flavors %i undefined (1 and 99 only for ggrd mode)\n",E->trace.ic_method_for_flavors);
					parallel_process_termination();
					break;
            }
        }
		
        /* Warning level */
        input_boolean("itracer_warnings",&(E->trace.itracer_warnings),"on",m);
		
        if(E->parallel.nprocxy == 12)
            full_tracer_input(E);
		
        composition_input(E);
    }
}

// Set up the tracer computation based on whether this is
// a regional or full mantle simulation
void tracer_initial_settings(struct All_variables *E)
{
	// Initialize CPU time counters
	E->trace.advection_time = 0;
	E->trace.find_tracers_time = 0;
	E->trace.lost_souls_time = 0;
	
	// If we have more than 1 processor, we are in full mantle tracer mode
	E->trace.full_tracers = (E->parallel.nprocxy != 1);
	
	// Set up function pointers depending on which mode we are in
	if(E->trace.full_tracers) {
		E->trace.get_velocity = full_get_velocity;
		E->trace.iget_element = full_iget_element;
	} else {
		E->trace.get_velocity = regional_get_velocity;
		E->trace.iget_element = regional_iget_element;
	}
}



void tracer_setup(struct All_variables *E)
{
    char output_file[255];
    double begin_time;
	
	begin_time = CPU_time0();
	
    /* Some error control */
    if (E->sphere.caps_per_proc>1) {
		fprintf(stderr,"This code does not work for multiple caps per processor!\n");
		parallel_process_termination();
    }
	
    /* open tracing output file */
    sprintf(output_file,"%s.tracer_log.%d",E->control.data_file,E->parallel.me);
    E->trace.fpt=fopen(output_file,"w");
	
	
    /* reset statistical counters */
    E->trace.istat_isend=0;
    E->trace.istat_iempty=0;
    E->trace.istat_elements_checked=0;
    E->trace.istat1=0;
	
	
    /* some obscure initial parameters */
    /* This parameter specifies how close a tracer can get to the boundary */
    E->trace.box_cushion=0.00001;
	
    write_trace_instructions(E);
	
	if (E->trace.full_tracers) {
		// Initialize gnomonic node->coordinate mapping
		E->trace.gnomonic = new std::map<int, CoordUV>;
		
		/* Gnometric projection for velocity interpolation */
		define_uv_space(E);
		determine_shape_coefficients(E);
		
		/* The bounding box of neiboring processors */
		get_neighboring_caps(E);
		
		/* Fine-grained regular grid to search tracers */
		make_regular_grid(E);
		
		if (E->trace.ianalytical_tracer_test==1) {
			//TODO: walk into this code...
			analytical_test(E);
			parallel_process_termination();
		}
	} else {
		/* The bounding box of neighboring processors */
		get_neighboring_caps(E);
		
		make_mesh_ijk(E);
	}
	
    if (E->composition.on)
        composition_setup(E);
	
    fprintf(E->trace.fpt, "Tracer intiailization takes %f seconds.\n",
            CPU_time0() - begin_time);
}


/**** WRITE TRACE INSTRUCTIONS ***************/
static void write_trace_instructions(struct All_variables *E)
{
    int i;
	
    fprintf(E->trace.fpt,"\nTracing Activated! (proc: %d)\n",E->parallel.me);
    fprintf(E->trace.fpt,"   Allen K. McNamara 12-2003\n\n");
	
	switch (E->trace.ic_method) {
		case 0:
			fprintf(E->trace.fpt,"Generating New Tracer Array\n");
			fprintf(E->trace.fpt,"Tracers per element: %d\n",E->trace.itperel);
			break;
		case 1:
			fprintf(E->trace.fpt,"Reading tracer file %s\n",E->trace.tracer_file);
			break;
		case 2:
			fprintf(E->trace.fpt,"Reading individual tracer files\n");
			break;
	}
	
    fprintf(E->trace.fpt,"Number of tracer flavors: %d\n", E->trace.nflavors);
	
    if (E->trace.nflavors && E->trace.ic_method==0) {
        fprintf(E->trace.fpt,"Initialized tracer flavors by: %d\n", E->trace.ic_method_for_flavors);
        if (E->trace.ic_method_for_flavors == 0) {
            fprintf(E->trace.fpt,"Layered tracer flavors\n");
            for (i=0; i<E->trace.nflavors-1; i++)
                fprintf(E->trace.fpt,"Interface Height: %d %f\n",i,E->trace.z_interface[i]);
        }
#ifdef USE_GGRD
		else if((E->trace.ic_method_for_flavors == 1)||(E->trace.ic_method_for_flavors == 99)) {
			if (E->trace.full_tracers) {
				/* ggrd modes 1 and 99 (99  is override for restart) */
				fprintf(E->trace.fpt,"netcdf grd assigned tracer flavors\n");
				if( E->trace.ggrd_layers > 0)
					fprintf(E->trace.fpt,"file: %s top %i layers\n",E->trace.ggrd_file,
							E->trace.ggrd_layers);
				else
					fprintf(E->trace.fpt,"file: %s only layer %i\n",E->trace.ggrd_file,
							-E->trace.ggrd_layers);
			} else {
				/* ggrd modes 1 and 99 (99 is override for restart) */
				fprintf(stderr,"ggrd regional flavors not implemented\n");
				fprintf(E->trace.fpt,"ggrd not implemented et for regional, flavor method= %d\n",
						E->trace.ic_method_for_flavors);
				fflush(E->trace.fpt);
				parallel_process_termination();
			}
		}
#endif
        else {
            fprintf(E->trace.fpt,"Sorry-This IC methods for Flavors are Unavailable %d\n",E->trace.ic_method_for_flavors);
            fflush(E->trace.fpt);
            parallel_process_termination();
        }
    }
	
    for (i=0; i<E->trace.nflavors-2; i++) {
        if (E->trace.z_interface[i] < E->trace.z_interface[i+1]) {
            fprintf(E->trace.fpt,"Sorry - The %d-th z_interface is smaller than the next one.\n", i);
            fflush(E->trace.fpt);
            parallel_process_termination();
        }
    }
	
	if (E->trace.full_tracers) {
		/* regular grid stuff */
		
		fprintf(E->trace.fpt,"Regular Grid-> deltheta: %f delphi: %f\n",
				E->trace.deltheta[0],E->trace.delphi[0]);
	}
	
    /* more obscure stuff */
	
    fprintf(E->trace.fpt,"Box Cushion: %f\n",E->trace.box_cushion);
    fprintf(E->trace.fpt,"Number of Basic Quantities: %d\n", 12);
    fprintf(E->trace.fpt,"Number of Extra Quantities: %d\n", 1);
    fprintf(E->trace.fpt,"Total Number of Tracer Quantities: %d\n", 13);
	
	if (E->trace.full_tracers) {
		/* analytical test */
		
		if (E->trace.ianalytical_tracer_test==1)
		{
			fprintf(E->trace.fpt,"\n\n ! Analytical Test Being Performed ! \n");
			fprintf(E->trace.fpt,"(some of the above parameters may not be used or applied\n");
			fprintf(E->trace.fpt,"Velocity functions given in main code\n");
			fflush(E->trace.fpt);
		}
	}
	
    if (E->trace.itracer_warnings==0) {
        fprintf(E->trace.fpt,"\n WARNING EXITS ARE TURNED OFF! TURN THEM ON!\n");
        fprintf(stderr,"\n WARNING EXITS ARE TURNED OFF! TURN THEM ON!\n");
        fflush(E->trace.fpt);
    }
	
    write_composition_instructions(E);
}



/*****************************************************************************/
/* This function is the primary tracing routine called from Citcom.c         */
/* In this code, unlike the original 3D cartesian code, force is filled      */
/* during Stokes solution. No need to call thermal_buoyancy() after tracing. */

void tracer_advection(struct All_variables *E)
{
    double begin_time = CPU_time0();

    // Advect tracers
    predict_tracers(E);
    correct_tracers(E);

    // Check that the number of tracers is conserved
    check_sum(E);

    // Count # of tracers of each flavor
    if (E->trace.nflavors > 0)
        count_tracers_of_flavors(E);

    // Update the composition field
    if (E->composition.on)
        fill_composition(E);

    E->trace.advection_time += CPU_time0() - begin_time;

    tracer_post_processing(E);
}


/********* TRACER POST PROCESSING ****************************************/

void tracer_post_processing(struct All_variables *E)
{
    int i;
	
    /* reset statistical counters */
    E->trace.istat_isend=0;
    E->trace.istat_elements_checked=0;
    E->trace.istat1=0;
	
    /* write timing information every 20 steps */
    if ((E->monitor.solution_cycles % 20) == 0) {
        fprintf(E->trace.fpt, "STEP %d\n", E->monitor.solution_cycles);
		
        fprintf(E->trace.fpt, "Advecting tracers takes %f seconds.\n",
                E->trace.advection_time - E->trace.find_tracers_time);
        fprintf(E->trace.fpt, "Finding element takes %f seconds.\n",
                E->trace.find_tracers_time - E->trace.lost_souls_time);
        fprintf(E->trace.fpt, "Exchanging lost tracers takes %f seconds.\n",
                E->trace.lost_souls_time);
    }
	
    if(E->control.verbose){
		fprintf(E->trace.fpt,"Number of times for all element search  %d\n",E->trace.istat1);
		
		fprintf(E->trace.fpt,"Number of tracers sent to other processors: %d\n",E->trace.istat_isend);
		
		fprintf(E->trace.fpt,"Number of times element columns are checked: %d \n",E->trace.istat_elements_checked);
		
		/* compositional and error fraction data files */
		if (E->composition.on) {
			fprintf(E->trace.fpt,"Empty elements filled with old compositional "
					"values: %d (%f percent)\n", E->trace.istat_iempty,
					(100.0*E->trace.istat_iempty)/E->lmesh.nel);
			E->trace.istat_iempty=0;
			
			
			get_bulk_composition(E);
			
			if (E->parallel.me==0) {
				
				fprintf(E->fp,"composition: %e",E->monitor.elapsed_time);
				for (i=0; i<E->composition.ncomp; i++)
					fprintf(E->fp," %e", E->composition.bulk_composition[i]);
				fprintf(E->fp,"\n");
				
				fprintf(E->fp,"composition_error_fraction: %e",E->monitor.elapsed_time);
				for (i=0; i<E->composition.ncomp; i++)
					fprintf(E->fp," %e", E->composition.error_fraction[i]);
				fprintf(E->fp,"\n");
				
			}
		}
		fflush(E->trace.fpt);
    }
}


/*********** KEEP WITHIN BOUNDS *****************************************/
/*                                                                      */
/* This function makes sure the particle is within the sphere, and      */
/* phi and theta are within the proper degree range.                    */

void keep_within_bounds(struct All_variables *E,
                             CartesianCoord &cc,
                             SphericalCoord &sc)
{
    double max_theta, min_theta;
    double max_fi, min_fi;
    double max_radius, min_radius;
    double sint,cost,sinf,cosf;
	int changed = 0;
	
	// TODO: simplify and unify (if possible) the logic here
	// If we're in full tracer mode, constrain phi and theta
	if (E->trace.full_tracers) {
		sc.constrainThetaPhi();
	} else {	// otherwise use the min/max values
		max_theta = E->control.theta_max - E->trace.box_cushion;
		min_theta = E->control.theta_min + E->trace.box_cushion;
		
		max_fi = E->control.fi_max - E->trace.box_cushion;
		min_fi = E->control.fi_min + E->trace.box_cushion;
		
		if (sc._theta > max_theta) {
			sc._theta = max_theta;
			changed = 1;
		}
		
		if (sc._theta < min_theta) {
			sc._theta = min_theta;
			changed = 1;
		}
		
		if (sc._phi > max_fi) {
			sc._phi = max_fi;
			changed = 1;
		}
		
		if (sc._phi < min_fi) {
			sc._phi = min_fi;
			changed = 1;
		}
	}
	
	// In all modes we are constrained by radius
    max_radius = E->sphere.ro - E->trace.box_cushion;
    min_radius = E->sphere.ri + E->trace.box_cushion;
	
    if (sc._rad > max_radius) {
		changed = 1;
        sc._rad=max_radius;
    }
    if (sc._rad < min_radius) {
		changed = 1;
        sc._rad=min_radius;
    }
	
	// If the particle was moved, recalculate the Cartesian position
	if (changed) {
		if (E->trace.full_tracers) {
			cost=cos(sc._theta);
			sint=sqrt(1.0-cost*cost);
			cosf=cos(sc._phi);
			sinf=sin(sc._phi);
			cc._x=sc._rad*sint*cosf;
			cc._y=sc._rad*sint*sinf;
			cc._z=sc._rad*cost;
		} else {
			cc = sc.toCartesian();
		}
	}
}


/*********** PREDICT TRACERS **********************************************/
/*                                                                        */
/* This function predicts tracers performing an euler step                */
/*                                                                        */

static void predict_tracers(struct All_variables *E)
{
    int						j;
	ElementID				nelem;
    double					dt;
	SphericalCoord			sc0, sc_pred;
	CartesianCoord			cc0, cc_pred, velocity_vector;
	TracerList::iterator	tr;
	
    dt=E->advection.timestep;
	
	// Go through each simulation cap
    for (j=1;j<=E->sphere.caps_per_proc;j++) {
		
        for (tr=E->trace.tracers[j].begin();tr!=E->trace.tracers[j].end();++tr) {
			// Get initial tracer position
			sc0 = tr->getSphericalPos();
			cc0 = tr->getCartesianPos();
			
			// Interpolate the velocity of the tracer from element it is in
            nelem = tr->ielement();
            velocity_vector = (E->trace.get_velocity)(E,j,nelem,sc0);
			
			// Advance the tracer location in an Euler step
			cc_pred = cc0 + velocity_vector * dt;
			
            // Ensure tracer remains in the boundaries
			sc_pred = cc_pred.toSpherical();
            keep_within_bounds(E, cc_pred, sc_pred);
			
			// Set new tracer coordinates
            tr->setCoords(sc_pred, cc_pred);
			
            // Save original coords and velocities for later correction
			
			tr->setOrigVals(cc0, velocity_vector);
			
        }
    }
	
    // Find new tracer elements and caps
    find_tracers(E);
}

/*********** CORRECT TRACERS **********************************************/
/*                                                                        */
/* This function corrects tracers using both initial and                  */
/* predicted velocities                                                   */
/*                                                                        */

static void correct_tracers(struct All_variables *E)
{
    int						j;
	ElementID				nelem;
    double					dt;
	TracerList::iterator	tr;
	CartesianCoord			orig_pos, orig_vel, pred_vel, new_coord;
	SphericalCoord			new_coord_sph;
	
    dt=E->advection.timestep;
	
    for (j=1;j<=E->sphere.caps_per_proc;j++) {
        for (tr=E->trace.tracers[j].begin();tr!=E->trace.tracers[j].end();++tr) {
			
			// Get the original tracer position and velocity
            orig_pos = tr->getOrigCartesianPos();
            orig_vel = tr->getCartesianVel();
			
			// Get the predicted velocity by interpolating in the current element
            nelem = tr->ielement();
            pred_vel = (E->trace.get_velocity)(E, j, nelem, tr->getSphericalPos());
			
			// Correct the tracer position based on the original and new velocities
			new_coord = orig_pos + (orig_vel+pred_vel) * (dt*0.5);
			new_coord_sph = new_coord.toSpherical();
			
			// Ensure tracer remains in boundaries
            keep_within_bounds(E, new_coord, new_coord_sph);
			
            // Fill in current positions (original values are no longer important)
			tr->setCoords(new_coord_sph, new_coord);
			
        } /* end correcting tracers */
    } /* end caps */
	
    /* find new tracer elements and caps */
    find_tracers(E);
}


/************ FIND TRACERS *************************************/
/*                                                             */
/* This function finds tracer elements and moves tracers to    */
/* other processor domains if necessary.                       */
/* Array ielement is filled with elemental values.             */

static void find_tracers(struct All_variables *E)
{
    int						j;
	ElementID				iel, iprevious_element;
	TracerList::iterator	tr;
    double					begin_time;
	CartesianCoord			cc;
	SphericalCoord			sc;
	
	begin_time = CPU_time0();
	
    for (j=1;j<=E->sphere.caps_per_proc;j++) {

        /* initialize arrays and statistical counters */

        E->trace.istat1=0;
        for (int kk=0;kk<=4;kk++) {
            E->trace.istat_ichoice[j][kk]=0;
        }

        for (tr=E->trace.tracers[j].begin();tr!=E->trace.tracers[j].end();) {
			
			sc = tr->getSphericalPos();
			cc = tr->getCartesianPos();

            iprevious_element = tr->ielement();

            iel=(E->trace.iget_element)(E,j,iprevious_element,cc,sc);
            ///* debug *
            fprintf(E->trace.fpt,"BB. kk %d %d %d %f %f %f %f %f %f\n",
					j,iprevious_element,iel,cc._x,cc._y,cc._z,sc._theta,sc._phi,sc._rad);
            fflush(E->trace.fpt);
            /**/

            tr->set_ielement(iel);

            if (iel == UNDEFINED_ELEMENT) {
                /* tracer is inside other processors */
				E->trace.escaped_tracers[j].push_back(*tr);
				tr=E->trace.tracers[j].erase(tr);
            } else if (iel == -1) {
                /* tracer is inside this processor,
                 * but cannot find its element.
                 * Throw away the tracer. */

                if (E->trace.itracer_warnings) exit(10);

				tr = E->trace.tracers[j].erase(tr);
            } else {
				tr++;
			}

        } /* end tracers */

    } /* end j */

    /* Now take care of tracers that exited cap */

    if (E->parallel.nprocxy == 12)
        full_lost_souls(E);
    else
        regional_lost_souls(E);

    E->trace.find_tracers_time += CPU_time0() - begin_time;
}


/***********************************************************************/
/* This function computes the number of tracers in each element.       */
/* Each tracer can be of different "flavors", which is the 0th index   */
/* of extraq. How to interprete "flavor" is left for the application.  */

void count_tracers_of_flavors(struct All_variables *E)
{
    int						j, flavor, kk;
	ElementID				e;
	TracerList::iterator	tr;

    for (j=1; j<=E->sphere.caps_per_proc; j++) {

        /* first zero arrays */
        for (flavor=0; flavor<E->trace.nflavors; flavor++)
            for (e=1; e<=E->lmesh.nel; e++)
                E->trace.ntracer_flavor[j][flavor][e] = 0;

        /* Fill arrays */
        for (tr=E->trace.tracers[j].begin();tr!=E->trace.tracers[j].end();++tr) {
            e = tr->ielement();
            flavor = tr->flavor();
            E->trace.ntracer_flavor[j][flavor][e]++;
        }
    }

    /* debug */
    /**
    for (j=1; j<=E->sphere.caps_per_proc; j++) {
        for (e=1; e<=E->lmesh.nel; e++) {
            fprintf(E->trace.fpt, "element=%d ntracer_flaver =", e);
            for (flavor=0; flavor<E->trace.nflavors; flavor++) {
                fprintf(E->trace.fpt, " %d",
                        E->trace.ntracer_flavor[j][flavor][e]);
            }
            fprintf(E->trace.fpt, "\n");
        }
    }
    fflush(E->trace.fpt);
    /**/
}


void initialize_tracers(struct All_variables *E)
{
	// Initialize per-cap arrays for tracers and escaped tracers
	E->trace.tracers = new TracerList[13];
	E->trace.escaped_tracers = new TracerList[13];
	
	// Call the appropriate function depending on the tracer input method
	switch (E->trace.ic_method) {
		case 0:
			make_tracer_array(E);
			break;
		case 1:
			read_tracer_file(E);
			break;
		case 2:
			read_old_tracer_file(E);
			break;
		default:
			fprintf(E->trace.fpt,"Not ready for other inputs yet\n");
			fflush(E->trace.fpt);
			parallel_process_termination();
			break;
	}

    /* total number of tracers  */

    E->trace.ilast_tracer_count = isum_tracers(E);
    fprintf(E->trace.fpt, "Sum of Tracers: %d\n", E->trace.ilast_tracer_count);
    if(E->parallel.me==0)
        fprintf(stderr, "Sum of Tracers: %d\n", E->trace.ilast_tracer_count);

    // Find elements
    find_tracers(E);

    /* count # of tracers of each flavor */

    if (E->trace.nflavors > 0)
        count_tracers_of_flavors(E);
}


/************** MAKE TRACER ARRAY ********************************/
/* Here, each processor will generate tracers somewhere          */
/* in the sphere - check if its in this cap  - then check radial */

static void make_tracer_array(struct All_variables *E)
{
    int tracers_cap, j;
    double processor_fraction;

    if (E->parallel.me==0) fprintf(stderr,"Making Tracer Array\n");

    for (j=1;j<=E->sphere.caps_per_proc;j++) {

        processor_fraction=E->lmesh.volume/E->mesh.volume;
        tracers_cap=E->mesh.nel*E->trace.itperel*processor_fraction;
        /*
          fprintf(stderr,"AA: proc frac: %f (%d) %d %d %f %f\n",processor_fraction,tracers_cap,E->lmesh.nel,E->parallel.nprocz, E->sx[j][3][E->lmesh.noz],E->sx[j][3][1]);
        */

        fprintf(E->trace.fpt,"\nGenerating %d Tracers\n",tracers_cap);

        generate_random_tracers(E, tracers_cap, j);

    }/* end j */

    /* Initialize tracer flavors */
    if (E->trace.nflavors) init_tracer_flavors(E);
}

static void generate_random_tracers(struct All_variables *E,
                                    int tracers_cap, int j)
{
    int kk;
    int ival;
    int number_of_tries=0;
    int max_tries;

    double xmin,xmax,ymin,ymax,zmin,zmax;
    double random1,random2,random3;

    allocate_tracer_arrays(E,j,tracers_cap);

    /* Finding the min/max of the cartesian coordinates. */
    /* One must loop over E->X to find the min/max, since the 8 corner */
    /* nodes may not be the min/max. */
    xmin = ymin = zmin = E->sphere.ro;
    xmax = ymax = zmax = -E->sphere.ro;
    for (kk=1; kk<=E->lmesh.nno; kk++) {
		double x,y,z;
        x = E->x[j][1][kk];
        y = E->x[j][2][kk];
        z = E->x[j][3][kk];

        xmin = ((xmin < x) ? xmin : x);
        xmax = ((xmax > x) ? xmax : x);
        ymin = ((ymin < y) ? ymin : y);
        ymax = ((ymax > y) ? ymax : y);
        zmin = ((zmin < z) ? zmin : z);
        zmax = ((zmax > z) ? zmax : z);
    }

    /* Tracers are placed randomly in cap */
    /* (intentionally using rand() instead of srand() )*/
    while (E->trace.tracers[j].size()<tracers_cap) {

        number_of_tries++;
        max_tries=100*tracers_cap;

        if (number_of_tries>max_tries) {
            fprintf(E->trace.fpt,"Error(make_tracer_array)-too many tries?\n");
            fprintf(E->trace.fpt,"%d %d %d\n",max_tries,number_of_tries,RAND_MAX);
            fflush(E->trace.fpt);
            exit(10);
        }

#if 1
        random1=drand48();
        random2=drand48();
        random3=drand48();
#else  /* never called */
        random1=(1.0*rand())/(1.0*RAND_MAX);
        random2=(1.0*rand())/(1.0*RAND_MAX);
        random3=(1.0*rand())/(1.0*RAND_MAX);
#endif

		CartesianCoord	new_cc;
		SphericalCoord	new_sc;
		
        new_cc = CartesianCoord(xmin+random1*(xmax-xmin),
								ymin+random2*(ymax-ymin),
								zmin+random3*(zmax-zmin));

        /* first check if within shell */

		new_sc = new_cc.toSpherical();

        if (new_sc._rad>=E->sx[j][3][E->lmesh.noz]) continue;
        if (new_sc._rad<E->sx[j][3][1]) continue;

        /* check if in current cap */
        if (E->trace.full_tracers)
            ival=full_icheck_cap(E,0,new_cc,new_sc._rad);
        else
            ival=regional_icheck_cap(E,0,new_sc,new_sc._rad);

        if (ival!=1) continue;

        /* Made it, so record tracer information */

        keep_within_bounds(E, new_cc, new_sc);

		Tracer	new_tracer;
		
		new_tracer.setCoords(new_sc, new_cc);
		E->trace.tracers[j].push_back(new_tracer);
    } /* end while */

    return;
}


/******** READ TRACER ARRAY *********************************************/
/*                                                                      */
/* This function reads tracers from input file.                         */
/* All processors read the same input file, then sort out which ones    */
/* belong.                                                              */

static void read_tracer_file(struct All_variables *E)
{
    char input_s[1000];

    int number_of_tracers, ncolumns;
    int kk;
    int icheck;
    int iestimate;
    int icushion;
    int i, j;

    double buffer[100];

    FILE *fptracer;

    fptracer=fopen(E->trace.tracer_file,"r");

    fgets(input_s,200,fptracer);
    if(sscanf(input_s,"%d %d",&number_of_tracers,&ncolumns) != 2) {
        fprintf(stderr,"Error while reading file '%s'\n", E->trace.tracer_file);
        exit(8);
    }
    fprintf(E->trace.fpt,"%d Tracers, %d columns in file \n",
            number_of_tracers, ncolumns);

    /* some error control */
    if (1+3 != ncolumns) {
        fprintf(E->trace.fpt,"ERROR(read tracer file)-wrong # of columns\n");
        fflush(E->trace.fpt);
        exit(10);
    }

    /* initially size tracer arrays to number of tracers divided by processors */

    icushion=100;

    /* for absolute tracer method */
    E->trace.number_of_tracers = number_of_tracers;

    iestimate=number_of_tracers/E->parallel.nproc + icushion;

    for (j=1;j<=E->sphere.caps_per_proc;j++) {

        allocate_tracer_arrays(E,j,iestimate);

        for (kk=0;kk<number_of_tracers;kk++) {
			SphericalCoord		in_coord_sph;
			CartesianCoord		in_coord_cc;
            int					len, ncol;
			
            ncol = 3 + 1;	// ERIC: E->trace.number_of_extra_quantities;

            len = read_double_vector(fptracer, ncol, buffer);
            if (len != ncol) {
                fprintf(E->trace.fpt,"ERROR(read tracer file) - wrong input file format: %s\n", E->trace.tracer_file);
                fflush(E->trace.fpt);
                exit(10);
            }

			in_coord_sph.readFromMem(buffer);
			in_coord_cc = in_coord_sph.toCartesian();

            /* make sure theta, phi is in range, and radius is within bounds */

            keep_within_bounds(E,in_coord_cc,in_coord_sph);

            /* check whether tracer is within processor domain */

            icheck=1;
            if (E->parallel.nprocz>1) icheck=icheck_processor_shell(E,j,in_coord_sph._rad);
            if (icheck!=1) continue;

            if (E->trace.full_tracers)
                icheck=full_icheck_cap(E,0,in_coord_cc,in_coord_sph._rad);
            else
                icheck=regional_icheck_cap(E,0,in_coord_sph,in_coord_sph._rad);

            if (icheck==0) continue;

            /* if still here, tracer is in processor domain */

			Tracer new_tracer;
			
			new_tracer.setCoords(in_coord_sph, in_coord_cc);
			new_tracer.set_flavor(buffer[3]);
			E->trace.tracers[j].push_back(new_tracer);

        } /* end number of tracers */

        fprintf(E->trace.fpt,"Number of tracers in this cap is: %d\n",
                E->trace.tracers[j].size());

        /** debug **
        for (kk=1; kk<=E->trace.ntracers[j]; kk++) {
            fprintf(E->trace.fpt, "tracer#=%d sph_coord=(%g,%g,%g)", kk,
                    E->trace.basicq[j][0][kk],
                    E->trace.basicq[j][1][kk],
                    E->trace.basicq[j][2][kk]);
            fprintf(E->trace.fpt, "   extraq=");
            for (i=0; i<E->trace.number_of_extra_quantities; i++)
                fprintf(E->trace.fpt, " %g", E->trace.extraq[j][i][kk]);
            fprintf(E->trace.fpt, "\n");
        }
        fflush(E->trace.fpt);
        /**/

    } /* end j */

    fclose(fptracer);

    icheck=isum_tracers(E);

    if (icheck!=number_of_tracers) {
        fprintf(E->trace.fpt,"ERROR(read_tracer_file) - tracers != number in file\n");
        fprintf(E->trace.fpt,"Tracers in system: %d\n", icheck);
        fprintf(E->trace.fpt,"Tracers in file: %d\n", number_of_tracers);
        fflush(E->trace.fpt);
        exit(10);
    }

    return;
}


/************** READ OLD TRACER FILE *************************************/
/*                                                                       */
/* This function read tracers written from previous calculation          */
/* and the tracers are read as seperate files for each processor domain. */

static void read_old_tracer_file(struct All_variables *E)
{

    char output_file[200];
    char input_s[1000];

    int i,j,kk,rezip;
    int idum1,ncolumns;
    int numtracers;

    double rdum1;
    double theta,phi,rad;
    double x,y,z;
    double buffer[100];

    FILE *fp1;

    /* deal with different output formats */
#ifdef USE_GZDIR
    if(strcmp(E->output.format, "ascii-gz") == 0){
      sprintf(output_file,"%s/%d/tracer.%d.%d",
	      E->control.data_dir_old,E->monitor.solution_cycles_init,E->parallel.me,E->monitor.solution_cycles_init);
      rezip = open_file_zipped(output_file,&fp1,E);
    }else{
      sprintf(output_file,"%s.tracer.%d.%d",E->control.old_P_file,E->parallel.me,E->monitor.solution_cycles_init);
      if ( (fp1=fopen(output_file,"r"))==NULL) {
        fprintf(E->trace.fpt,"ERROR(read_old_tracer_file)-gziped file not found %s\n",output_file);
        fflush(E->trace.fpt);
        exit(10);
      }
    }
#else
    sprintf(output_file,"%s.tracer.%d.%d",E->control.old_P_file,E->parallel.me,E->monitor.solution_cycles_init);
    if ( (fp1=fopen(output_file,"r"))==NULL) {
        fprintf(E->trace.fpt,"ERROR(read_old_tracer_file)-file not found %s\n",output_file);
        fflush(E->trace.fpt);
        exit(10);
    }
#endif

    fprintf(stderr,"Read old tracers from %s\n",output_file);


    for(j=1;j<=E->sphere.caps_per_proc;j++) {
        fgets(input_s,200,fp1);
        if(sscanf(input_s,"%d %d %d %lf",
                  &idum1, &numtracers, &ncolumns, &rdum1) != 4) {
            fprintf(stderr,"Error while reading file '%s'\n", output_file);
            exit(8);
        }


        /* some error control */
        // ERIC: if (E->trace.number_of_extra_quantities+3 != ncolumns) {
        if (1+3 != ncolumns) {
            fprintf(E->trace.fpt,"ERROR(read_old_tracer_file)-wrong # of columns\n");
            fflush(E->trace.fpt);
            exit(10);
        }

        /* allocate memory for tracer arrays */

        allocate_tracer_arrays(E,j,numtracers);

        for (kk=1;kk<=numtracers;kk++) {
            int len, ncol;
			SphericalCoord	sc;
			CartesianCoord	cc;
			
            ncol = 3 + 1;

            len = read_double_vector(fp1, ncol, buffer);
            if (len != ncol) {
                fprintf(E->trace.fpt,"ERROR(read_old_tracer_file) - wrong input file format: %s\n", output_file);
                fflush(E->trace.fpt);
                exit(10);
            }

			sc.readFromMem(buffer);
			cc = sc.toCartesian();

            /* it is possible that if on phi=0 boundary, significant digits can push phi over 2pi */

            keep_within_bounds(E,cc,sc);

			Tracer	new_tracer;
			
            new_tracer.setCoords(sc, cc);
			new_tracer.set_flavor(buffer[3]);
			E->trace.tracers[j].push_back(new_tracer);

        }

        /** debug **
        for (kk=1; kk<=E->trace.ntracers[j]; kk++) {
            fprintf(E->trace.fpt, "tracer#=%d sph_coord=(%g,%g,%g)", kk,
                    E->trace.basicq[j][0][kk],
                    E->trace.basicq[j][1][kk],
                    E->trace.basicq[j][2][kk]);
            fprintf(E->trace.fpt, "   extraq=");
            for (i=0; i<E->trace.number_of_extra_quantities; i++)
                fprintf(E->trace.fpt, " %g", E->trace.extraq[j][i][kk]);
            fprintf(E->trace.fpt, "\n");
        }
        fflush(E->trace.fpt);
        /**/

        fprintf(E->trace.fpt,"Read %d tracers from file %s\n",numtracers,output_file);
        fflush(E->trace.fpt);

    }
    fclose(fp1);
#ifdef USE_GZDIR
    if(strcmp(E->output.format, "ascii-gz") == 0)
      if(rezip)			/* rezip */
	gzip_file(output_file);
#endif

    return;
}


/*********** CHECK SUM **************************************************/
/*                                                                      */
/* This functions checks to make sure number of tracers is preserved    */

static void check_sum(struct All_variables *E)
{
    int number, iold_number;

    number = isum_tracers(E);

    iold_number = E->trace.ilast_tracer_count;

    if (number != iold_number) {
        fprintf(E->trace.fpt,"ERROR(check_sum)-break in conservation %d %d\n",
                number,iold_number);
        fflush(E->trace.fpt);
        if (E->trace.itracer_warnings)
            parallel_process_termination();
    }

    E->trace.ilast_tracer_count = number;
}


/************* ISUM TRACERS **********************************************/
/*                                                                       */
/* This function uses MPI to sum all tracers and returns number of them. */

static int isum_tracers(struct All_variables *E)
{
    int j, imycount, iallcount;

    iallcount = imycount = 0;
	
    for (j=1; j<=E->sphere.caps_per_proc; j++)
        imycount += E->trace.tracers[j].size();

    MPI_Allreduce(&imycount,&iallcount,1,MPI_INT,MPI_SUM,E->parallel.world);

    return iallcount;
}



static void init_tracer_flavors(struct All_variables *E)
{
    int						j, kk, i;
    double					flavor, rad;
	TracerList::iterator	tr;
	
    switch(E->trace.ic_method_for_flavors){
		case 0:
			/* ic_method_for_flavors == 0 (layered structure) */
			/* any tracer above z_interface[i] is of flavor i */
			/* any tracer below z_interface is of flavor (nflavors-1) */
			for (j=1;j<=E->sphere.caps_per_proc;j++) {
				
				for (tr=E->trace.tracers[j].begin();tr!=E->trace.tracers[j].end();++tr) {
					rad = tr->rad();
					
					flavor = E->trace.nflavors - 1;
					for (i=0; i<E->trace.nflavors-1; i++) {
						if (rad > E->trace.z_interface[i]) {
							flavor = i;
							break;
						}
					}
					tr->set_flavor(flavor);
				}
			}
			break;
			
		case 1:			/* from grd in top n layers */
		case 99:			/* (will override restart) */
#ifndef USE_GGRD
			fprintf(stderr,"ic_method_for_flavors %i requires the ggrd routines from hc, -DUSE_GGRD\n",
					E->trace.ic_method_for_flavors);
			parallel_process_termination();
#else
			ggrd_init_tracer_flavors(E);
#endif
			break;
			
			
		default:
			
			fprintf(stderr,"ic_method_for_flavors %i undefined\n",E->trace.ic_method_for_flavors);
			parallel_process_termination();
			break;
    }
	
    return;
}


/******************* get_neighboring_caps ************************************/
/*                                                                           */
/* Communicate with neighboring processors to get their cap boundaries,      */
/* which is later used by (E->trace.icheck_cap)()                            */
/*                                                                           */

void get_neighboring_caps(struct All_variables *E)
{
    const int ncorners = 4; /* # of top corner nodes */
    int i, j, n, d, kk, lev, idb;
    int num_ngb, neighbor_proc, tag;
    MPI_Status status[200];
    MPI_Request request[200];

    int node[ncorners];
    double xx[ncorners*2], rr[12][ncorners*2];
    int nox,noy,noz;
    double x,y,z;
    double theta,phi,rad;

    nox=E->lmesh.nox;
    noy=E->lmesh.noy;
    noz=E->lmesh.noz;

    node[0]=nox*noz*(noy-1)+noz;
    node[1]=noz;
    node[2]=noz*nox;
    node[3]=noz*nox*noy;

    lev = E->mesh.levmax;
    tag = 45;

    for (j=1; j<=E->sphere.caps_per_proc; j++) {

        /* loop over top corners to get their coordinates */
        n = 0;
        for (i=0; i<ncorners; i++) {
            for (d=0; d<2; d++) {
                xx[n] = E->sx[j][d+1][node[i]];
                n++;
            }
        }

        idb = 0;
        num_ngb = E->parallel.TNUM_PASS[lev][j];
        for (kk=1; kk<=num_ngb; kk++) {
            neighbor_proc = E->parallel.PROCESSOR[lev][j].pass[kk];

            MPI_Isend(xx, n, MPI_DOUBLE, neighbor_proc,
                      tag, E->parallel.world, &request[idb]);
            idb++;

            MPI_Irecv(rr[kk], n, MPI_DOUBLE, neighbor_proc,
                      tag, E->parallel.world, &request[idb]);
            idb++;
        }

        /* Storing the current cap information */
        for (i=0; i<n; i++)
            rr[0][i] = xx[i];

        /* Wait for non-blocking calls to complete */

        MPI_Waitall(idb, request, status);

        /* Storing the received cap information
         * XXX: this part assumes:
         *      1) E->sphere.caps_per_proc==1
         *      2) E->mesh.nsd==3
         */
        for (kk=0; kk<=num_ngb; kk++) {
            n = 0;
            for (i=0; i<ncorners; i++) {
				SphericalCoord	sc;
				
                theta = rr[kk][n++];
                phi = rr[kk][n++];
                rad = E->sphere.ro;
				
				sc = SphericalCoord(theta, phi, rad);
				
				E->trace.boundaries[kk].setBoundary(i, sc);
            }
        } /* end kk, number of neighbors */

        /* debugging output *
        for (kk=0; kk<=num_ngb; kk++) {
            if (kk==0)
                neighbor_proc = E->parallel.me;
            else
                neighbor_proc = E->parallel.PROCESSOR[lev][1].pass[kk];

            for (i=1; i<=ncorners; i++) {
                fprintf(E->trace.fpt, "pass=%d rank=%d corner=%d "
                        "sx=(%g, %g, %g)\n",
                        kk, neighbor_proc, i,
                        E->trace.theta_cap[kk][i],
                        E->trace.phi_cap[kk][i],
                        E->trace.rad_cap[kk][i]);
            }
        }
        fflush(E->trace.fpt);
        /**/
    }

    return;
}


/**************** INITIALIZE TRACER ARRAYS ************************************/
/*                                                                            */
/* This function allocates memories to tracer arrays.                         */

void allocate_tracer_arrays(struct All_variables *E,
                            int j, int number_of_tracers)
{
    int kk;

    if (E->trace.nflavors > 0) {
        E->trace.ntracer_flavor[j]=(int **)malloc(E->trace.nflavors*sizeof(int*));
        for (kk=0;kk<E->trace.nflavors;kk++) {
            if ((E->trace.ntracer_flavor[j][kk]=(int *)malloc((E->lmesh.nel+1)*sizeof(int)))==NULL) {
                fprintf(E->trace.fpt,"ERROR(initialize tracer arrays)-no memory 1c.%d\n",kk);
                fflush(E->trace.fpt);
                exit(10);
            }
        }
    }

    fflush(E->trace.fpt);
}


/********** ICHECK PROCESSOR SHELL *************/
/* returns UNDEFINED_ELEMENT if rad is below current shell  */
/* returns 0 if rad is above current shell    */
/* returns 1 if rad is within current shell   */
/*                                            */
/* Shell, here, refers to processor shell     */
/*                                            */
/* shell is defined as bottom boundary up to  */
/* and not including the top boundary unless  */
/* the shell in question is the top shell     */

int icheck_processor_shell(struct All_variables *E,
                           int j, double rad)
{

    const int noz = E->lmesh.noz;
    const int nprocz = E->parallel.nprocz;
    double top_r, bottom_r;

    if (nprocz==1) return 1;

    top_r = E->sx[j][3][noz];
    bottom_r = E->sx[j][3][1];

    // First check bottom
    if (rad<bottom_r) return UNDEFINED_ELEMENT;

    // Check top
    if (rad<top_r) return 1;

    // top processor
    if ( (rad<=top_r) && (E->parallel.me_loc[3]==nprocz-1) ) return 1;

    // If here, means point is above processor
    return 0;
}

/********* ICHECK THAT PROCESSOR SHELL ********/
/*                                            */
/* Checks whether a given radius is within    */
/* a given processors radial domain.          */
/* Returns 0 if not, 1 if so.                 */
/* The domain is defined as including the bottom */
/* radius, but excluding the top radius unless   */
/* we the processor domain is the one that       */
/* is at the surface (then both boundaries are   */
/* included).                                    */

int icheck_that_processor_shell(struct All_variables *E,
                                int j, int nprocessor, double rad)
{
    int me = E->parallel.me;

    /* nprocessor is right on top of me */
    if (nprocessor == me+1) {
        if (icheck_processor_shell(E, j, rad) == 0) return 1;
        else return 0;
    }

    /* nprocessor is right on bottom of me */
    if (nprocessor == me-1) {
        if (icheck_processor_shell(E, j, rad) == UNDEFINED_ELEMENT) return 1;
        else return 0;
    }

    /* Shouldn't be here */
    fprintf(E->trace.fpt, "Should not be here\n");
    fprintf(E->trace.fpt, "Error(check_shell) nprocessor: %d, radius: %f\n",
            nprocessor, rad);
    fflush(E->trace.fpt);
    exit(10);

    return 0;
}
back to top