Changeset - d6faa5ffcedf
[Not reviewed]
! ! !
Margreet Nool - 10 years ago 2014-07-04 17:10:21
greta@timor.sen.cwi.nl
install arcos
13 files changed:
0 comments (0 inline, 0 general)
Makefile
Show inline comments
 
new file 100644
 
include 	Makefile.inc
 
include 	Makefile.config
 

	
 
SOURCE_DIR	= src
 
FISH90_DIR	= fish90/src
 
F90_DIR		= arcos_f90/src
 
CONFIG_DIR	= libconfig-1.4.9/lib
 

	
 
SUBDIRS		= $(F90_DIR) $(FISH90_DIR) $(SOURCE_DIR) $(CONFIG_DIR)
 
CLEANDIRS	= $(SUBDIRS:%=clean-%)
 

	
 
.PHONY:		all allclean $(SUBDIRS) $(CLEANDIRS)
 

	
 
# Default Target is to build everything
 
all: $(SUBDIRS)
 
allclean: $(CLEANDIRS) clean
 

	
 
$(SUBDIRS):
 
	$(MAKE) -C $@
 

	
 
$(CLEANDIRS):
 
	$(MAKE) -C $(@:clean-%=%) clean
 

	
 
clean:
 
	$(RM) $(SOURCE_DIR)/*.o ./arcos
 

	
 

	
Makefile.config
Show inline comments
 
new file 100644
 
# This file defines the Makefile variables that are used to compile
 
# the PHARCOS programs and  libraries. Edit this file as needed.
 

	
 
# The C compiler and compiler options.
 

	
 
CC		:= gcc
 
#CC		:= pgcc
 
CFLAGS		= -g -pg -O3
 
# CFLAGS	= -openmp -D_GNU_SOURCE -O3 -ipo -openmp-report0 #-gcc-version=400
 

	
 

	
 
# The Fortran 90 compiler and compiler options. Leave empty to
 
# disable Fortran 90 support.
 

	
 
F90 		:= gfortran -I../lib
 
#F90		:= pgf90 -g -pg -I../lib
 
#F90FLAGS	= -nofor-main -O3 
 
F90FLAGS	= -O3 
 
FFLAGS		= -O3
 
DEBUG_LEVEL	:= 1
 
DFLAGS		= -DCOMPILING_HOSTNAME=\"$(HOSTNAME)\" -DDEBUG_LEVEL=1 
 

	
 
# Search directories for include files and libraries.
 

	
 
INCLUDEDIR1	= ../include 
 
INCLUDEDIR2	= ../fish90/include 
 
INCLUDES	= -I $(INCLUDEDIR1) -I $(INCLUDEDIR2)
 
LIBDIRS		= 
 
INCDIRS		= 
 

	
 
# Command for creating static library.
 

	
 
AR		= ar -rcsv
 

	
 
# Other commands.
 

	
 
MV		= mv -f
 

	
Makefile.inc
Show inline comments
 
new file 100644
 
# This file defines common Makefile variables and rules that are used
 
# to compile the FISHPACK libraries. Normally, this
 
# file does not have to be modified; see the file Makefile.conf.
 

	
 
# The names of the fishpack libraries.
 

	
 
FISHPACK_LIB	= libfishpack.a
 
FISH90_LIB	= libfish90.a
 

	
 
# Commands to compile and link C and Fortran 90 code.
 

	
 
Compile		= $(CC) $(CFLAGS) $(DFLAGS) $(addprefix -I,$(INCDIRS)) \
 
		        -o $@ -c $<
 

	
 
LinkExe		= $(CC) $(addprefix -L,$(LIBDIRS)) -o $@ $^ \
 
		        $(F90FLAGS) $(addprefix -l,$(LIBS))
 

	
 
CompileF90	= $(F90) $(F90FLAGS) $(addprefix -I,$(INCDIRS)) \
 
		         -o $@ -c $<
 

	
 
LinkF90Exe	= $(F90) $(addprefix -L,$(LIBDIRS)) -o $@ $^ \
 
		         $(F90FLAGS) $(addprefix -l,$(LIBS))
 

	
 
CompileF	= $(F90) $(F90FLAGS) $(addprefix -I,$(INCDIRS)) \
 
		         -o $@ -c $<
 

	
 
Compilef	= $(F90) $(FFLAGS) $(addprefix -I,$(INCDIRS)) \
 
		         -o $@ -c $<
 

	
 
# Implicit rules for compiling C and Fortran source files.
 

	
 
%.o:		%.c
 
		$(Compile)
 

	
 
%.o:		%.f90
 
		$(CompileF90)
 

	
 
%.o:		%.F
 
		$(CompileF)
 

	
 
%.o:		%.f
 
		$(Compilef)
 

	
README
Show inline comments
 
new file 100644
 
To create the executable arcos:
 

	
 
- first create library libconfig.
 
  Go to directory libconfig-1.4.9/lib  and give the following command
 
  make all
 

	
 
- next, return to the root directory pharcos and give the following command
 
  make all
 

	
 
Now you have the executable arcos, which needs the input files from
 
directory input. ./arcos also needs an output directory. The name is given in 
 
/input/default.cfg by "output_dir". Here we chose directory output. 
 

	
 
If output does not exist, create this directory:
 
make output
 

	
 
In this directory many files for visualization will be written. For more details see the documentation:
 

	
 
file:///?????
arcos_f90/src/Makefile
Show inline comments
 
new file 100644
 

	
 
TOPDIR	:= ../..
 

	
 
include	$(TOPDIR)/Makefile.config
 
include	$(TOPDIR)/Makefile.inc
 

	
 
.PHONY:	all
 

	
 
all:	lib
 

	
 
SRCF	= cdr_advect_diffu_vec.f90 
 
SRCC	= cdr_advect_diffu_wrap.c
 

	
 
INCDIRS	= ../../include
 

	
 
OBJF	=$(subst .f90,.o,$(SRCF))
 
OBJC	=$(subst .c,.o,$(SRCC))
 
OBJ := $(OBJF) $(OBJC)
 

	
 
LIB	=../lib/libarcos.a
 

	
 
lib : $(LIB)
 

	
 
$(LIB) : $(OBJ)
 
	$(AR) $@ $? 
 

	
 
clean:
 
	rm -f $(LIB) $(OBJ) *~
arcos_f90/src/cdr_advect_diffu_vec.f90
Show inline comments
 
new file 100644
 
!> @file cdr_advect_diffu_vec.f90
 
!! @brief This code replaces the original c code of cdr_advect_diffu in file
 
!!  cdr.c
 
!!
 
!! @author Margreet Nool
 
!!
 
!!     The arrays er_array and ez_array are in C stored as
 
!!     1D arrays. In the wrapper routine cdr_advect_diffu_wrap.c it is
 
!!     checked of their sizes, er_len, ez_len are equal to rmax-by-zmax.
 
!!
 
!!     Note that these are NOT the r0, z0 we received.  The idea here is that
 
!!     RZ(array, r0, z0) will produce the correct result, where the allocated
 
!!     array looks like (in the picture, r0, z0 ARE the received ones).
 
!!     Note: in the picture there is only one buffer cell, while we actually
 
!!     allocate two.
 
!!
 
!!      +--------------+--------------+...+--------------+--------------+
 
!!      |r0 - 1, z0 - 1|              |   |              |              |
 
!!      +--------------+--------------+...+--------------+--------------+
 
!!      |              |   r0, z0     |   |              |              |
 
!!      +--------------+--------------+...+--------------+--------------+
 
!!                    ...             |...|             ...
 
!!      +--------------+--------------+...+--------------+--------------+
 
!!      |              |              |   |r1 - 1, z1 - 1|              |
 
!!      +--------------+--------------+...+--------------+--------------+
 
!!      |              |              |   |              |    r1, z1    |
 
!!      +--------------+--------------+...+--------------+--------------+
 
!!
 
!!     but the rows z0 +/- 1 and the columns r0 +/- 1 do not belong to the
 
!!     physical space and are used only to specify boundary conditions.
 
!!
 
!!     In the C routines r0, and z0 are zero, and the calculations start 
 
!!     at the third element (r0-2, r0-1, r0, ...., r1, r1+1), and
 
!!     (z0-2, z0-1, r0, ...., z1, z1+1), respectively. 
 
!!     rmax = r1 - r0 + 4 and zmax = z1 - z0 + 4.
 
!!-----------------------------------------------
 

	
 
! subroutine cdr_advect_vec
 
! subroutine mat_efield_r
 
! subroutine mat_efield_z
 
! subroutine mat_cdr_f_ad_r
 
! subroutine mat_cdr_f_ad_z
 
! subroutine make_vecs_er
 

	
 
   subroutine cdr_advect_vec(mass,charge,dens_array,d_dens_array, &
 
                         er_array,ez_array,diffusion_coeff,dr,dz, &
 
                         sprite_module,r0,r1,z0,z1)
 
      implicit none
 
!     ..
 
!     .. Parameters ..
 
      double precision,parameter :: ONE  = 1.0D0
 
!     ..
 
!     .. Dummy Variables ..
 
      logical,intent(in)          :: sprite_module
 
      integer,intent(in)          :: r0,r1,z0,z1
 
      double precision,intent(in) :: charge,dr,dz,mass,diffusion_coeff
 
!     ..
 
!     .. Dummy Arrays ..
 
      double precision,dimension(r0-2:r1+1,z0-2:z1+1),intent(in)  :: &
 
                       dens_array,er_array,ez_array
 
      double precision,dimension(r0-2:r1+1,z0-2:z1+1),intent(out) :: &
 
                       d_dens_array
 
!     ..
 
!     .. Local Variables ..
 
      integer          :: ir,ishift
 
      double precision :: cm0,cm,gdz_inv,d_iso0,d_iso
 
!     ..
 
!     .. Local arrays ..
 
      double precision,dimension(r0:r1-1)             :: er_min
 
      double precision,dimension(r0+1:r1)             :: er
 
      double precision,dimension(z1-z0)               :: d_iso_r
 
      double precision,dimension(z1-z0+1)             :: d_iso_z
 
      double precision,dimension(r1-r0+1,z1-z0  )     :: mat_r
 
      double precision,dimension(r1-r0  ,z1-z0+1)     :: mat_z
 
      double precision,dimension(r1-r0+1,z1-z0  )     :: efield_r
 
      double precision,dimension(r0:r1-1,z0-1:z1-1)   :: efield_z
 
!     ..
 
!     .. External subroutines ..
 
      external :: mat_efield_r,mat_efield_z,mat_cdr_f_ad_r,mat_cdr_f_ad_z
 
!     ..
 

	
 
      if (mass <= 0) return
 
  
 
      ! <ISOTROPIC DIFFUSSION>
 
      d_iso0 = diffusion_coeff / mass
 
      ! </ISOTROPIC DIFFUSION>
 

	
 
      gdz_inv = ONE / dz
 
  
 
      cm0 = charge / mass
 
      
 
      if (.not.sprite_module) then
 
        cm = cm0
 
        d_iso = d_iso0
 
      end if
 
  
 
!-----------------------------------------------
 
!     Increase the values r0, r1, z0 and z1 with 3:
 
!     because of 2 buffer cells at the left side and to compensate the C 0
 
!-----------------------------------------------
 
      ishift = 3
 

	
 
      ! Compute the electric field in radial direction
 
      call mat_efield_r(er_array(r0-1:r1-1,z0:z1-1), &
 
                        efield_r,d_iso_r,cm0,d_iso0, &
 
                        r0,r1,dz,z0,z1,ishift,dr,sprite_module)
 
      ! Calculate the radial advection from left and right 
 
      call mat_cdr_f_ad_r(dens_array(r0-2:r1+1,z0:z1-1), &
 
                          efield_r(1:r1-r0+1,1:z1-z0),d_iso_r, &
 
                          mat_r,r0,r1,z0,z1)
 
      ! Add the radial advection 
 
      call  make_vecs_er (er_min,er,r0,r1,dr)
 
      do ir = r0,r1-1
 
         d_dens_array(ir,z0:z1-1) = d_dens_array(ir,z0:z1-1) + &
 
                                    er_min(ir) * mat_r(ir-r0+1,1:z1-z0) - &
 
                                    er(ir+1)   * mat_r(ir-r0+2,1:z1-z0)
 
      end do
 

	
 
      ! Compute the electric field in axial direction
 
      call mat_efield_z(ez_array(r0  :r1-1,z0-1:z1-1), &
 
                        efield_z(r0:r1-1,z0-1:z1-1),d_iso_z,cm0,d_iso0, &
 
                        r0,r1,dz,z0,z1,ishift,dz,sprite_module)
 
      ! Calculate the axial advection from the north and south
 
      call mat_cdr_f_ad_z(dens_array(r0  :r1-1,z0-2:z1+1), &
 
                          efield_z(r0:r1-1,z0-1:z1-1),d_iso_z, &
 
                          mat_z,r0,r1,z0,z1)
 
      ! Add the axial advection 
 
      d_dens_array(r0:r1-1,z0:z1-1) = d_dens_array(r0:r1-1,z0:z1-1) + &
 
                                      gdz_inv * (mat_z(1:,1:z1-z0) - &
 
                                                 mat_z(1:,2:z1-z0+1))
 

	
 
   end subroutine cdr_advect_vec
 

	
 
   subroutine mat_efield_r(er_array,efield,d_iso,cm0,d_iso0, &
 
                           r0,r1,dz,z0,z1,z_shift,dx,sprite_module)
 
!     ..
 
      implicit none
 
!     ..
 
!     .. Parameters ..
 
      double precision,parameter :: HALF = 0.5D0,ONE  = 1.0D0
 
!     ..
 
!     .. Dummy Variables ..
 
      logical,intent(in)          :: sprite_module
 
      integer,intent(in)          :: r0,r1,z0,z1,z_shift
 
      double precision,intent(in) :: cm0,d_iso0,dz,dx
 
!     ..
 
!     .. Dummy Arrays ..
 
      double precision,dimension(r1-r0+1,z1-z0),intent(in)  :: er_array
 
      double precision,dimension(r1-r0+1,z1-z0),intent(out) :: efield
 
      double precision,dimension(z1-z0),intent(out)         :: d_iso
 
!     ..
 
!     .. Local Variables ..
 
      integer                           :: iz
 
!     ..
 
!     .. Local arrays ..
 
      double precision,dimension(z1-z0) :: back_dens_inv,cm
 
!-----------------------------------------------
 

	
 
      ! If the densities are varying...
 
      if (sprite_module) then
 
         do iz = z0,z1
 
            ! spr_density_at(iz) = (iz-z_shift + half) * dz
 
            ! back_dens_inv = ONE / spr_density_at
 
            back_dens_inv(iz-z0+1) = ONE / ((iz-z_shift + half) * dz)
 
         end do
 
         cm    = cm0 * back_dens_inv
 
         d_iso = d_iso0 * back_dens_inv
 
      else
 
         back_dens_inv = ONE
 
         cm            = cm0
 
         d_iso         = d_iso0
 
      end if
 

	
 
      d_iso = d_iso / dx
 

	
 
      ! efield = cm * er_array
 
      do iz = 1,z1-z0
 
         efield(:,iz) = cm(iz) * er_array(:,iz)
 
      end do
 

	
 
   end subroutine mat_efield_r
 

	
 
   subroutine mat_efield_z (ez_array,efield,d_iso,cm0,d_iso0, &
 
                            r0,r1,dz,z0,z1,z_shift,dx,sprite_module)
 
!     ..
 
      implicit none
 
!     ..
 
!     .. Parameters ..
 
      double precision,parameter :: HALF = 0.5D0,ONE  = 1.0D0
 
!     ..
 
!     .. Dummy Variables ..
 
      logical,intent(in)          :: sprite_module
 
      integer,intent(in)          :: r0,r1,z0,z1,z_shift
 
      double precision,intent(in) :: cm0,d_iso0,dz,dx
 
!     ..
 
!     .. Dummy Arrays ..
 
      double precision,dimension(r0:r1-1,z0-1:z1-1),intent(in)  :: ez_array
 
      double precision,dimension(r0:r1-1,z0-1:z1-1),intent(out) :: efield
 
      double precision,dimension(z0-1:z1-1),intent(out)     :: d_iso
 
!     ..
 
!     .. Local Variables ..
 
      integer                               :: iz
 
!     ..
 
!     .. Local arrays ..
 
      double precision,dimension(z0-1:z1-1) :: back_dens_inv,cm
 
!     ..
 
!-----------------------------------------------
 

	
 
      ! If the densities are varying...
 
      if (sprite_module) then
 
         do iz = z0-1,z1+1
 
            ! spr_density_at(iz) = (iz-z_shift + half) * dz
 
            ! back_dens_inv = ONE / spr_density_at
 
            back_dens_inv(iz) = ONE / ((iz-z_shift - half) * dz)
 
         end do
 
         cm    = cm0 * back_dens_inv
 
         d_iso = d_iso0 * back_dens_inv
 
      else
 
         back_dens_inv = ONE
 
         cm            = cm0
 
         d_iso         = d_iso0
 
      end if
 

	
 
      d_iso = d_iso / dx
 

	
 
      ! efield = cm * ez_array
 
      do iz = z0-1,z1-1
 
         efield(:,iz) = cm(iz) * ez_array(:,iz)
 
      end do
 

	
 
   end subroutine mat_efield_z
 

	
 
   subroutine mat_cdr_f_ad_r(data_array,efield,d_iso,mat_r,r0,r1,z0,z1)
 
!     ..
 
      implicit none
 
!     ..
 
!     .. Parameters ..
 
      double precision,parameter :: ZERO = 0.0D0,HALF = 0.5D0, &
 
                                    ONE  = 1.0D0,THREE = 3.0D0, &
 
                                    verysmall = 1.0e-20
 
!     ..
 
!     .. Dummy Variables ..
 
      integer,intent(in) :: r0,r1,z0,z1
 
!     ..
 
!     .. Dummy Arrays ..
 
      double precision,dimension(z1-z0),intent(in)          :: d_iso
 
      double precision,dimension(r1-r0+1,z1-z0),intent(in)  :: efield
 
      double precision,dimension(r1-r0+4,z1-z0),intent(in)  :: data_array
 
      double precision,dimension(r1-r0+1,z1-z0),intent(out) :: mat_r
 
!     ..
 
!     .. Local Variables ..
 
      integer            :: iz,length
 
!     ..
 
!     .. Local arrays ..
 
      double precision,dimension(r1-r0+1,z1-z0) :: aux,psi_p
 
      double precision,dimension(r1-r0+3,z1-z0) :: mat_diff
 
!     ..
 
!-----------------------------------------------
 
      length = r1 - r0 + 1
 
      mat_diff(1:length+2,:) = data_array(2:length+3,:) - &
 
                               data_array(1:length+2,:)
 

	
 
      where (abs(mat_diff(2:length+1,:)) > verysmall)
 
          where (efield>=ZERO)
 
            ! p_min  =data_array(ir-k1,iz-k2)
 
            ! p      =data_array(ir,iz)
 
            ! p_plus =data_array(ir+k1,iz+k2)
 
   
 
             psi_p = mat_diff(1:length,:) / mat_diff(2:length+1,:)
 
         elsewhere (efield<ZERO)
 
            ! p       =data_array(ir,iz)
 
            ! p_plus  =data_array(ir+  k1,iz+  k2)
 
            ! p_2plus =data_array(ir+2*k1,iz+2*k2)
 
   
 
             psi_p = mat_diff(3:length+2,:) / mat_diff(2:length+1,:) 
 
         end where
 
         where (psi_p <= ZERO)
 
            ! psi_p = psi_MN (psi_p)
 
            psi_p = ZERO
 
         elsewhere (psi_p >= 4)
 
            psi_p = ONE
 
         elsewhere (psi_p >= 0.4)
 
            psi_p = (ONE + HALF * psi_p) / THREE
 
         end where
 
      elsewhere  ! abs(mat_diff(2:length+1,:)) < verysmall
 
         psi_p = -ONE
 
      end where
 

	
 
      ! sigmasigma is (sigma_{i+1,j} - sigma_{i,j})*/
 
      ! sigmasigma = p - p_plus 
 
      aux = psi_p * mat_diff(2:length+1,:)
 
      ! aux = p + psi_p * sigmasigma
 
      where (efield>=ZERO)
 
         aux = data_array(2:length+1,:) + aux
 
      elsewhere
 
         aux = data_array(3:length+2,:) - aux
 
      end where
 

	
 
      ! aux = efield * (p + psi_p * sigmasigma)
 
      aux = aux * efield
 
      do iz = 1,z1-z0
 
         ! mat_r = d_iso * sigmasigma
 
         mat_r(1:length,iz) = d_iso(iz) * mat_diff(2:length+1,iz)
 
      end do
 
      ! mat_r =  efield * (p + psi_p * sigmasigma) + d_iso * sigmasigma
 
      mat_r = aux - mat_r
 

	
 
   end subroutine mat_cdr_f_ad_r
 

	
 
   subroutine mat_cdr_f_ad_z(data_array,efield,d_iso,mat_z,r0,r1,z0,z1)
 
!     ..
 
      implicit none
 
!     ..
 
!     .. Parameters ..
 
      double precision,parameter :: ZERO = 0.0D0,HALF = 0.5D0, &
 
                                    ONE  = 1.0D0,THREE = 3.0D0, &
 
                                    verysmall = 1.0e-20
 
!     ..
 
!     .. Dummy Variables ..
 
      integer,intent(in)          :: r0,r1,z0,z1
 
!     ..
 
!     .. Dummy Arrays ..
 
      double precision,dimension(z1-z0+1),intent(in)           :: d_iso
 
      double precision,dimension(r0:r1-1,z0-1:z1-1),intent(in) :: efield
 
      double precision,dimension(r1-r0,z1-z0+4),intent(in)     :: data_array
 
      double precision,dimension(r1-r0,z1-z0+1),intent(out)    :: mat_z
 
!     ..
 
!     .. Local Variables ..
 
      integer          :: iz,length
 
!     ..
 
!     .. Local Arrays ..
 
      double precision,dimension(r1-r0,z1-z0+1) :: aux,psi_p,pij
 
      double precision,dimension(r1-r0,z1-z0+3) :: mat_diff
 
!-----------------------------------------------
 
      length = z1 - z0 + 1
 
      mat_diff(:,1:length+2) = data_array(:,2:length+3) - &
 
                               data_array(:,1:length+2)
 

	
 
      where (abs(mat_diff(:,2:length+1)) > verysmall)
 
         ! psi_p = (p - p_min) / (p_plus- p)
 
         where (efield>ZERO)
 
            ! p_min  =data_array(ir-k1,iz-k2)
 
            ! p      =data_array(ir,iz)
 
            ! p_plus =data_array(ir+k1,iz+k2)
 
   
 
            psi_p = mat_diff(:,1:length) / mat_diff(:,2:length+1)
 
         elsewhere ! efield=<ZERO
 
            ! p       =data_array(ir,iz)
 
            ! p_plus  =data_array(ir+  k1,iz+  k2)
 
            ! p_2plus =data_array(ir+2*k1,iz+2*k2)
 

	
 
            psi_p = mat_diff(:,3:length+2) / mat_diff(:,2:length+1) 
 
         end where
 
         ! psi_p = psi_MN (psi_p)
 
         pij   = psi_p
 
         where ((psi_p > 0.4) .and. (psi_p < 4))
 
            pij =  (ONE + HALF * psi_p) / THREE
 
         elsewhere (psi_p >= 4)
 
            pij = ONE
 
         else where (psi_p <= ZERO)
 
            pij = ZERO
 
         end where
 
      elsewhere ! abs(mat_diff(:,2:length+1)) < verysmall
 
         pij = ONE
 
      end where
 

	
 
      ! sigmasigma is (sigma_{i+1,j} - sigma_{i,j})*/
 
      ! sigmasigma = p - p_plus 
 
      aux = pij * mat_diff(:,2:length+1)
 
      ! aux = p + pij * sigmasigma
 
      where (efield>=0)
 
         aux = data_array(:,2:length+1) + aux
 
      elsewhere
 
         aux = data_array(:,3:length+2) - aux
 
      end where
 

	
 
      ! aux = efield * (p + pij * sigmasigma)
 
      aux = aux * efield
 
      do iz = 1,length
 
         ! mat_z = d_iso * sigmasigma
 
         mat_z(:,iz) = d_iso(iz) * mat_diff(:,iz+1)
 
      end do
 
      ! mat_z =  efield * (p + pij * sigmasigma) + d_iso * sigmasigma
 
      mat_z = aux - mat_z
 

	
 
   end subroutine mat_cdr_f_ad_z
 

	
 
   subroutine make_vecs_er (er_min,er,r0,r1,dr)
 
!     ..
 
      implicit none
 
!
 
!     .. Parameters ..
 
      double precision,parameter :: HALF = 0.5D0,ONE  = 1.0D0
 
!     ..
 
!     .. Dummy Variables ..
 
      integer,intent(in)                              :: r0,r1
 
      double precision,intent(in)                     :: dr
 
!     ..
 
!     .. Dummy Arrays ..
 
      double precision,dimension(r0:r1-1),intent(out) :: er_min
 
      double precision,dimension(r0+1:r1),intent(out) :: er
 
!     ..
 
!     .. Local Variables ..
 
      integer          :: ir
 
      double precision :: r_inv
 
!     ..
 
! .............................................................
 
      do ir = r0,r1-1
 
         r_inv = ONE / ((ir+ HALF) * dr)
 
         er_min(ir) = ir * r_inv
 
         er(ir+1)   = (ir+1) * r_inv
 
      end do
 

	
 
   end subroutine make_vecs_er
arcos_f90/src/cdr_advect_diffu_wrap.c
Show inline comments
 
new file 100644
 
/** @file cdr_advect_diffu_wrap.c
 
*   @brief Wrapper function for the cdr_advect_diffu function. 
 
*
 
*   This function makes it possible to call the Fortran routine cdr_advect_vec
 
*   a c function. The c routine is named arcos_cdr_advect_vec.
 
*
 
*   @author Margreet Nool - 2009
 
*/
 

	
 
#include "stdlib.h"
 
#include "stdio.h"
 
#include "math.h"
 

	
 
int number_cdr=0;
 

	
 
/* cdr_advect: vectorized fortran90 routine; see f90/src/cdr_advect_vec.f90 */
 
void cdr_advect_vec_(double *mass,double *charge,double *dens_array, 
 
                 double *d_dens_array,double *er_array,double *ez_array,
 
		 double *diffusion_coeff,double *dr,double *dz,
 
		 int *sprite_module,int *r0,int *r1,int *z0,int *z1);
 

	
 
/* Calls hstcrt and checks for errors. If an error occurs, prints the
 
 corresponding message and exists. */
 
void 
 
arcos_cdr_advect_vec(double mass,double charge,double *dens_array, 
 
                 double *d_dens_array,double *er_array,int er_len,
 
		 double *ez_array,int ez_len,double diffusion_coeff,
 
                 double dr,double dz,int sprite_module,
 
                 int r0,int r1,int z0,int z1)
 
{
 
  if ( number_cdr % 1000 == 0 ) {
 

	
 
     fprintf(stdout, "wrap:# calls cdr_advec_vec       =%d\n",number_cdr);
 
     
 
  }
 

	
 
  cdr_advect_vec_(&mass,&charge,dens_array,d_dens_array,er_array,ez_array,
 
              &diffusion_coeff,&dr,&dz,&sprite_module,&r0,&r1,&z0,&z1);
 
  number_cdr += 1;
 

	
 
}
 

	
doc/README
Show inline comments
 
new file 100644
 
Use jannis versie van doxygen:
 

	
 
/ufs/teunisse/progs/doxygen-1.8.2/bin/doxygen
doc/doxygen_config_file
Show inline comments
 
new file 100644
 
# Doxyfile 1.7.5
 

	
 
# This file describes the settings to be used by the documentation system
 
# doxygen (www.doxygen.org) for a project
 
#
 
# All text after a hash (#) is considered a comment and will be ignored
 
# The format is:
 
#       TAG = value [value, ...]
 
# For lists items can also be appended using:
 
#       TAG += value [value, ...]
 
# Values that contain spaces should be placed between quotes (" ")
 

	
 
#---------------------------------------------------------------------------
 
# Project related configuration options
 
#---------------------------------------------------------------------------
 

	
 
# This tag specifies the encoding used for all characters in the config file
 
# that follow. The default is UTF-8 which is also the encoding used for all
 
# text before the first occurrence of this tag. Doxygen uses libiconv (or the
 
# iconv built into libc) for the transcoding. See
 
# http://www.gnu.org/software/libiconv for the list of possible encodings.
 

	
 
DOXYFILE_ENCODING      = UTF-8
 

	
 
# The PROJECT_NAME tag is a single word (or a sequence of words surrounded
 
# by quotes) that should identify the project.
 

	
 
PROJECT_NAME           = "Streamer fluid modeling - An overview of ARCoS"
 

	
 
# The PRO4JECT_NUMBER tag can be used to enter a project or revision number.
 
# This could be handy for archiving the generated documentation or
 
# if some version control system is used.
 

	
 
PROJECT_NUMBER         = 1.0
 

	
 
# The OUTPUT_DIRECTORY tag is used to specify the (relative or absolute)
 
# base path where the generated documentation will be put.
 
# If a relative path is entered, it will be relative to the location
 
# where doxygen was started. If left blank the current directory will be used.
 

	
 
OUTPUT_DIRECTORY       = documentation
 

	
 
# If the CREATE_SUBDIRS tag is set to YES, then doxygen will create
 
# 4096 sub-directories (in 2 levels) under the output directory of each output
 
# format and will distribute the generated files over these directories.
 
# Enabling this option can be useful when feeding doxygen a huge amount of
 
# source files, where putting all generated files in the same directory would
 
# otherwise cause performance problems for the file system.
 

	
 
CREATE_SUBDIRS         = NO
 

	
 
# The OUTPUT_LANGUAGE tag is used to specify the language in which all
 
# documentation generated by doxygen is written. Doxygen will use this
 
# information to generate all constant output in the proper language.
 
# The default language is English, other supported languages are:
 
# Afrikaans, Arabic, Brazilian, Catalan, Chinese, Chinese-Traditional,
 
# Croatian, Czech, Danish, Dutch, Esperanto, Farsi, Finnish, French, German,
 
# Greek, Hungarian, Italian, Japanese, Japanese-en (Japanese with English
 
# messages), Korean, Korean-en, Lithuanian, Norwegian, Macedonian, Persian,
 
# Polish, Portuguese, Romanian, Russian, Serbian, Serbian-Cyrilic, Slovak,
 
# Slovene, Spanish, Swedish, Ukrainian, and Vietnamese.
 

	
 
OUTPUT_LANGUAGE        = English
 

	
 
# If the BRIEF_MEMBER_DESC tag is set to YES (the default) Doxygen will
 
# include brief member descriptions after the members that are listed in
 
# the file and class documentation (similar to JavaDoc).
 
# Set to NO to disable this.
 

	
 
BRIEF_MEMBER_DESC      = YES
 

	
 
# If the REPEAT_BRIEF tag is set to YES (the default) Doxygen will prepend
 
# the brief description of a member or function before the detailed description.
 
# Note: if both HIDE_UNDOC_MEMBERS and BRIEF_MEMBER_DESC are set to NO, the
 
# brief descriptions will be completely suppressed.
 

	
 
REPEAT_BRIEF           = YES
 

	
 
# This tag implements a quasi-intelligent brief description abbreviator
 
# that is used to form the text in various listings. Each string
 
# in this list, if found as the leading text of the brief description, will be
 
# stripped from the text and the result after processing the whole list, is
 
# used as the annotated text. Otherwise, the brief description is used as-is.
 
# If left blank, the following values are used ("$name" is automatically
 
# replaced with the name of the entity): "The $name class" "The $name widget"
 
# "The $name file" "is" "provides" "specifies" "contains"
 
# "represents" "a" "an" "the"
 

	
 
ABBREVIATE_BRIEF       =
 

	
 
# If the ALWAYS_DETAILED_SEC and REPEAT_BRIEF tags are both set to YES then
 
# Doxygen will generate a detailed section even if there is only a brief
 
# description.
 

	
 
ALWAYS_DETAILED_SEC    = NO
 

	
 
# If the INLINE_INHERITED_MEMB tag is set to YES, doxygen will show all
 
# inherited members of a class in the documentation of that class as if those
 
# members were ordinary class members. Constructors, destructors and assignment
 
# operators of the base classes will not be shown.
 

	
 
INLINE_INHERITED_MEMB  = NO
 

	
 
# If the FULL_PATH_NAMES tag is set to YES then Doxygen will prepend the full
 
# path before files name in the file list and in the header files. If set
 
# to NO the shortest path that makes the file name unique will be used.
 

	
 
FULL_PATH_NAMES        = NO
 

	
 
# If the FULL_PATH_NAMES tag is set to YES then the STRIP_FROM_PATH tag
 
# can be used to strip a user-defined part of the path. Stripping is
 
# only done if one of the specified strings matches the left-hand part of
 
# the path. The tag can be used to show relative paths in the file list.
 
# If left blank the directory from which doxygen is run is used as the
 
# path to strip.
 

	
 
STRIP_FROM_PATH        =
 

	
 
# The STRIP_FROM_INC_PATH tag can be used to strip a user-defined part of
 
# the path mentioned in the documentation of a class, which tells
 
# the reader which header file to include in order to use a class.
 
# If left blank only the name of the header file containing the class
 
# definition is used. Otherwise one should specify the include paths that
 
# are normally passed to the compiler using the -I flag.
 

	
 
STRIP_FROM_INC_PATH    =
 

	
 
# If the SHORT_NAMES tag is set to YES, doxygen will generate much shorter
 
# (but less readable) file names. This can be useful is your file systems
 
# doesn't support long names like on DOS, Mac, or CD-ROM.
 

	
 
SHORT_NAMES            = NO
 

	
 
# If the JAVADOC_AUTOBRIEF tag is set to YES then Doxygen
 
# will interpret the first line (until the first dot) of a JavaDoc-style
 
# comment as the brief description. If set to NO, the JavaDoc
 
# comments will behave just like regular Qt-style comments
 
# (thus requiring an explicit @brief command for a brief description.)
 

	
 
JAVADOC_AUTOBRIEF      = NO
 

	
 
# If the QT_AUTOBRIEF tag is set to YES then Doxygen will
 
# interpret the first line (until the first dot) of a Qt-style
 
# comment as the brief description. If set to NO, the comments
 
# will behave just like regular Qt-style comments (thus requiring
 
# an explicit \brief command for a brief description.)
 

	
 
QT_AUTOBRIEF           = NO
 

	
 
# The MULTILINE_CPP_IS_BRIEF tag can be set to YES to make Doxygen
 
# treat a multi-line C++ special comment block (i.e. a block of //! or ///
 
# comments) as a brief description. This used to be the default behaviour.
 
# The new default is to treat a multi-line C++ comment block as a detailed
 
# description. Set this tag to YES if you prefer the old behaviour instead.
 

	
 
MULTILINE_CPP_IS_BRIEF = NO
 

	
 
# If the INHERIT_DOCS tag is set to YES (the default) then an undocumented
 
# member inherits the documentation from any documented member that it
 
# re-implements.
 

	
 
INHERIT_DOCS           = YES
 

	
 
# If the SEPARATE_MEMBER_PAGES tag is set to YES, then doxygen will produce
 
# a new page for each member. If set to NO, the documentation of a member will
 
# be part of the file/class/namespace that contains it.
 

	
 
SEPARATE_MEMBER_PAGES  = NO
 

	
 
# The TAB_SIZE tag can be used to set the number of spaces in a tab.
 
# Doxygen uses this value to replace tabs by spaces in code fragments.
 

	
 
TAB_SIZE               = 3
 

	
 
# This tag can be used to specify a number of aliases that acts
 
# as commands in the documentation. An alias has the form "name=value".
 
# For example adding "sideeffect=\par Side Effects:\n" will allow you to
 
# put the command \sideeffect (or @sideeffect) in the documentation, which
 
# will result in a user-defined paragraph with heading "Side Effects:".
 
# You can put \n's in the value part of an alias to insert newlines.
 

	
 
ALIASES                =
 

	
 
# Set the OPTIMIZE_OUTPUT_FOR_C tag to YES if your project consists of C
 
# sources only. Doxygen will then generate output that is more tailored for C.
 
# For instance, some of the names that are used will be different. The list
 
# of all members will be omitted, etc.
 

	
 
OPTIMIZE_OUTPUT_FOR_C  = NO
 

	
 
# Set the OPTIMIZE_OUTPUT_JAVA tag to YES if your project consists of Java
 
# sources only. Doxygen will then generate output that is more tailored for
 
# Java. For instance, namespaces will be presented as packages, qualified
 
# scopes will look different, etc.
 

	
 
OPTIMIZE_OUTPUT_JAVA   = NO
 

	
 
# Set the OPTIMIZE_FOR_FORTRAN tag to YES if your project consists of Fortran
 
# sources only. Doxygen will then generate output that is more tailored for
 
# Fortran.
 

	
 
OPTIMIZE_FOR_FORTRAN   = YES
 

	
 
# Set the OPTIMIZE_OUTPUT_VHDL tag to YES if your project consists of VHDL
 
# sources. Doxygen will then generate output that is tailored for
 
# VHDL.
 

	
 
OPTIMIZE_OUTPUT_VHDL   = NO
 

	
 
# Doxygen selects the parser to use depending on the extension of the files it
 
# parses. With this tag you can assign which parser to use for a given extension.
 
# Doxygen has a built-in mapping, but you can override or extend it using this
 
# tag. The format is ext=language, where ext is a file extension, and language
 
# is one of the parsers supported by doxygen: IDL, Java, Javascript, CSharp, C,
 
# C++, D, PHP, Objective-C, Python, Fortran, VHDL, C, C++. For instance to make
 
# doxygen treat .inc files as Fortran files (default is PHP), and .f files as C
 
# (default is Fortran), use: inc=Fortran f=C. Note that for custom extensions
 
# you also need to set FILE_PATTERNS otherwise the files are not read by doxygen.
 

	
 
EXTENSION_MAPPING      = *.F
 

	
 
# If you use STL classes (i.e. std::string, std::vector, etc.) but do not want
 
# to include (a tag file for) the STL sources as input, then you should
 
# set this tag to YES in order to let doxygen match functions declarations and
 
# definitions whose arguments contain STL classes (e.g. func(std::string); v.s.
 
# func(std::string) {}). This also make the inheritance and collaboration
 
# diagrams that involve STL classes more complete and accurate.
 

	
 
#BUILTIN_STL_SUPPORT    = NO
 
BUILTIN_STL_SUPPORT    = YES
 

	
 
# If you use Microsoft's C++/CLI language, you should set this option to YES to
 
# enable parsing support.
 

	
 
CPP_CLI_SUPPORT        = NO
 

	
 
# Set the SIP_SUPPORT tag to YES if your project consists of sip sources only.
 
# Doxygen will parse them like normal C++ but will assume all classes use public
 
# instead of private inheritance when no explicit protection keyword is present.
 

	
 
SIP_SUPPORT            = NO
 

	
 
# For Microsoft's IDL there are propget and propput attributes to indicate getter
 
# and setter methods for a property. Setting this option to YES (the default)
 
# will make doxygen to replace the get and set methods by a property in the
 
# documentation. This will only work if the methods are indeed getting or
 
# setting a simple type. If this is not the case, or you want to show the
 
# methods anyway, you should set this option to NO.
 

	
 
IDL_PROPERTY_SUPPORT   = YES
 

	
 
# If member grouping is used in the documentation and the DISTRIBUTE_GROUP_DOC
 
# tag is set to YES, then doxygen will reuse the documentation of the first
 
# member in the group (if any) for the other members of the group. By default
 
# all members of a group must be documented explicitly.
 

	
 
DISTRIBUTE_GROUP_DOC   = NO
 

	
 
# Set the SUBGROUPING tag to YES (the default) to allow class member groups of
 
# the same type (for instance a group of public functions) to be put as a
 
# subgroup of that type (e.g. under the Public Functions section). Set it to
 
# NO to prevent subgrouping. Alternatively, this can be done per class using
 
# the \nosubgrouping command.
 

	
 
SUBGROUPING            = YES
 

	
 
# When TYPEDEF_HIDES_STRUCT is enabled, a typedef of a struct, union, or enum
 
# is documented as struct, union, or enum with the name of the typedef. So
 
# typedef struct TypeS {} TypeT, will appear in the documentation as a struct
 
# with name TypeT. When disabled the typedef will appear as a member of a file,
 
# namespace, or class. And the struct will be named TypeS. This can typically
 
# be useful for C code in case the coding convention dictates that all compound
 
# types are typedef'ed and only the typedef is referenced, never the tag name.
 

	
 
TYPEDEF_HIDES_STRUCT   = NO
 

	
 
# The SYMBOL_CACHE_SIZE determines the size of the internal cache use to
 
# determine which symbols to keep in memory and which to flush to disk.
 
# When the cache is full, less often used symbols will be written to disk.
 
# For small to medium size projects (<1000 input files) the default value is
 
# probably good enough. For larger projects a too small cache size can cause
 
# doxygen to be busy swapping symbols to and from disk most of the time
 
# causing a significant performance penality.
 
# If the system has enough physical memory increasing the cache will improve the
 
# performance by keeping more symbols in memory. Note that the value works on
 
# a logarithmic scale so increasing the size by one will rougly double the
 
# memory usage. The cache size is given by this formula:
 
# 2^(16+SYMBOL_CACHE_SIZE). The valid range is 0..9, the default is 0,
 
# corresponding to a cache size of 2^16 = 65536 symbols
 

	
 
SYMBOL_CACHE_SIZE      = 0
 

	
 
#---------------------------------------------------------------------------
 
# Build related configuration options
 
#---------------------------------------------------------------------------
 

	
 
# If the EXTRACT_ALL tag is set to YES doxygen will assume all entities in
 
# documentation are documented, even if no documentation was available.
 
# Private class members and static file members will be hidden unless
 
# the EXTRACT_PRIVATE and EXTRACT_STATIC tags are set to YES
 

	
 
EXTRACT_ALL            = YES
 

	
 
# If the EXTRACT_PRIVATE tag is set to YES all private members of a class
 
# will be included in the documentation.
 

	
 
EXTRACT_PRIVATE        = YES
 

	
 
# If the EXTRACT_STATIC tag is set to YES all static members of a file
 
# will be included in the documentation.
 

	
 
EXTRACT_STATIC         = YES
 

	
 
# If the EXTRACT_LOCAL_CLASSES tag is set to YES classes (and structs)
 
# defined locally in source files will be included in the documentation.
 
# If set to NO only classes defined in header files are included.
 

	
 
EXTRACT_LOCAL_CLASSES  = YES
 

	
 
# This flag is only useful for Objective-C code. When set to YES local
 
# methods, which are defined in the implementation section but not in
 
# the interface are included in the documentation.
 
# If set to NO (the default) only methods in the interface are included.
 

	
 
EXTRACT_LOCAL_METHODS  = YES
 

	
 
# If this flag is set to YES, the members of anonymous namespaces will be
 
# extracted and appear in the documentation as a namespace called
 
# 'anonymous_namespace{file}', where file will be replaced with the base
 
# name of the file that contains the anonymous namespace. By default
 
# anonymous namespace are hidden.
 

	
 
EXTRACT_ANON_NSPACES   = NO
 

	
 
# If the HIDE_UNDOC_MEMBERS tag is set to YES, Doxygen will hide all
 
# undocumented members of documented classes, files or namespaces.
 
# If set to NO (the default) these members will be included in the
 
# various overviews, but no documentation section is generated.
 
# This option has no effect if EXTRACT_ALL is enabled.
 

	
 
HIDE_UNDOC_MEMBERS     = NO
 

	
 
# If the HIDE_UNDOC_CLASSES tag is set to YES, Doxygen will hide all
 
# undocumented classes that are normally visible in the class hierarchy.
 
# If set to NO (the default) these classes will be included in the various
 
# overviews. This option has no effect if EXTRACT_ALL is enabled.
 

	
 
HIDE_UNDOC_CLASSES     = NO
 

	
 
# If the HIDE_FRIEND_COMPOUNDS tag is set to YES, Doxygen will hide all
 
# friend (class|struct|union) declarations.
 
# If set to NO (the default) these declarations will be included in the
 
# documentation.
 

	
 
HIDE_FRIEND_COMPOUNDS  = NO
 

	
 
# If the HIDE_IN_BODY_DOCS tag is set to YES, Doxygen will hide any
 
# documentation blocks found inside the body of a function.
 
# If set to NO (the default) these blocks will be appended to the
 
# function's detailed documentation block.
 

	
 
HIDE_IN_BODY_DOCS      = NO
 

	
 
# The INTERNAL_DOCS tag determines if documentation
 
# that is typed after a \internal command is included. If the tag is set
 
# to NO (the default) then the documentation will be excluded.
 
# Set it to YES to include the internal documentation.
 

	
 
INTERNAL_DOCS          = NO
 

	
 
# If the CASE_SENSE_NAMES tag is set to NO then Doxygen will only generate
 
# file names in lower-case letters. If set to YES upper-case letters are also
 
# allowed. This is useful if you have classes or files whose names only differ
 
# in case and if your file system supports case sensitive file names. Windows
 
# and Mac users are advised to set this option to NO.
 

	
 
CASE_SENSE_NAMES       =  YES
 

	
 
# If the HIDE_SCOPE_NAMES tag is set to NO (the default) then Doxygen
 
# will show members with their full class and namespace scopes in the
 
# documentation. If set to YES the scope will be hidden.
 

	
 
HIDE_SCOPE_NAMES       = NO
 

	
 
# If the SHOW_INCLUDE_FILES tag is set to YES (the default) then Doxygen
 
# will put a list of the files that are included by a file in the documentation
 
# of that file.
 

	
 
SHOW_INCLUDE_FILES     = YES
 

	
 
# If the FORCE_LOCAL_INCLUDES tag is set to YES then Doxygen
 
# will list include files with double quotes in the documentation
 
# rather than with sharp brackets.
 

	
 
FORCE_LOCAL_INCLUDES   = NO
 

	
 
# If the INLINE_INFO tag is set to YES (the default) then a tag [inline]
 
# is inserted in the documentation for inline members.
 

	
 
INLINE_INFO            = YES
 

	
 
# If the SORT_MEMBER_DOCS tag is set to YES (the default) then doxygen
 
# will sort the (detailed) documentation of file and class members
 
# alphabetically by member name. If set to NO the members will appear in
 
# declaration order.
 

	
 
#SORT_MEMBER_DOCS       = YES
 
SORT_MEMBER_DOCS       = NO
 

	
 
# If the SORT_BRIEF_DOCS tag is set to YES then doxygen will sort the
 
# brief documentation of file, namespace and class members alphabetically
 
# by member name. If set to NO (the default) the members will appear in
 
# declaration order.
 

	
 
SORT_BRIEF_DOCS        = NO
 

	
 
# If the SORT_MEMBERS_CTORS_1ST tag is set to YES then doxygen
 
# will sort the (brief and detailed) documentation of class members so that
 
# constructors and destructors are listed first. If set to NO (the default)
 
# the constructors will appear in the respective orders defined by
 
# SORT_MEMBER_DOCS and SORT_BRIEF_DOCS.
 
# This tag will be ignored for brief docs if SORT_BRIEF_DOCS is set to NO
 
# and ignored for detailed docs if SORT_MEMBER_DOCS is set to NO.
 

	
 
SORT_MEMBERS_CTORS_1ST = NO
 

	
 
# If the SORT_GROUP_NAMES tag is set to YES then doxygen will sort the
 
# hierarchy of group names into alphabetical order. If set to NO (the default)
 
# the group names will appear in their defined order.
 

	
 
SORT_GROUP_NAMES       = NO
 

	
 
# If the SORT_BY_SCOPE_NAME tag is set to YES, the class list will be
 
# sorted by fully-qualified names, including namespaces. If set to
 
# NO (the default), the class list will be sorted only by class name,
 
# not including the namespace part.
 
# Note: This option is not very useful if HIDE_SCOPE_NAMES is set to YES.
 
# Note: This option applies only to the class list, not to the
 
# alphabetical list.
 

	
 
SORT_BY_SCOPE_NAME     = NO
 

	
 
# The GENERATE_TODOLIST tag can be used to enable (YES) or
 
# disable (NO) the todo list. This list is created by putting \todo
 
# commands in the documentation.
 

	
 
GENERATE_TODOLIST      = YES
 

	
 
# The GENERATE_TESTLIST tag can be used to enable (YES) or
 
# disable (NO) the test list. This list is created by putting \test
 
# commands in the documentation.
 

	
 
GENERATE_TESTLIST      = YES
 

	
 
# The GENERATE_BUGLIST tag can be used to enable (YES) or
 
# disable (NO) the bug list. This list is created by putting \bug
 
# commands in the documentation.
 

	
 
GENERATE_BUGLIST       = YES
 

	
 
# The GENERATE_DEPRECATEDLIST tag can be used to enable (YES) or
 
# disable (NO) the deprecated list. This list is created by putting
 
# \deprecated commands in the documentation.
 

	
 
GENERATE_DEPRECATEDLIST= YES
 

	
 
# The ENABLED_SECTIONS tag can be used to enable conditional
 
# documentation sections, marked by \if sectionname ... \endif.
 

	
 
ENABLED_SECTIONS       =
 

	
 
# The MAX_INITIALIZER_LINES tag determines the maximum number of lines
 
# the initial value of a variable or define consists of for it to appear in
 
# the documentation. If the initializer consists of more lines than specified
 
# here it will be hidden. Use a value of 0 to hide initializers completely.
 
# The appearance of the initializer of individual variables and defines in the
 
# documentation can be controlled using \showinitializer or \hideinitializer
 
# command in the documentation regardless of this setting.
 

	
 
MAX_INITIALIZER_LINES  = 30
 

	
 
# Set the SHOW_USED_FILES tag to NO to disable the list of files generated
 
# at the bottom of the documentation of classes and structs. If set to YES the
 
# list will mention the files that were used to generate the documentation.
 

	
 
SHOW_USED_FILES        = YES
 

	
 
# Set the SHOW_FILES tag to NO to disable the generation of the Files page.
 
# This will remove the Files entry from the Quick Index and from the
 
# Folder Tree View (if specified). The default is YES.
 

	
 
SHOW_FILES             = YES
 

	
 
# Set the SHOW_NAMESPACES tag to NO to disable the generation of the
 
# Namespaces page.
 
# This will remove the Namespaces entry from the Quick Index
 
# and from the Folder Tree View (if specified). The default is YES.
 

	
 
SHOW_NAMESPACES        = YES
 

	
 
# The FILE_VERSION_FILTER tag can be used to specify a program or script that
 
# doxygen should invoke to get the current version for each file (typically from
 
# the version control system). Doxygen will invoke the program by executing (via
 
# popen()) the command <command> <input-file>, where <command> is the value of
 
# the FILE_VERSION_FILTER tag, and <input-file> is the name of an input file
 
# provided by doxygen. Whatever the program writes to standard output
 
# is used as the file version. See the manual for examples.
 

	
 
FILE_VERSION_FILTER    =
 

	
 
# The LAYOUT_FILE tag can be used to specify a layout file which will be parsed
 
# by doxygen. The layout file controls the global structure of the generated
 
# output files in an output format independent way. The create the layout file
 
# that represents doxygen's defaults, run doxygen with the -l option.
 
# You can optionally specify a file name after the option, if omitted
 
# DoxygenLayout.xml will be used as the name of the layout file.
 

	
 
LAYOUT_FILE            =
 

	
 
#---------------------------------------------------------------------------
 
# configuration options related to warning and progress messages
 
#---------------------------------------------------------------------------
 

	
 
# The QUIET tag can be used to turn on/off the messages that are generated
 
# by doxygen. Possible values are YES and NO. If left blank NO is used.
 

	
 
QUIET                  = NO
 

	
 
# The WARNINGS tag can be used to turn on/off the warning messages that are
 
# generated by doxygen. Possible values are YES and NO. If left blank
 
# NO is used.
 

	
 
WARNINGS               = YES
 

	
 
# If WARN_IF_UNDOCUMENTED is set to YES, then doxygen will generate warnings
 
# for undocumented members. If EXTRACT_ALL is set to YES then this flag will
 
# automatically be disabled.
 

	
 
WARN_IF_UNDOCUMENTED   = YES
 

	
 
# If WARN_IF_DOC_ERROR is set to YES, doxygen will generate warnings for
 
# potential errors in the documentation, such as not documenting some
 
# parameters in a documented function, or documenting parameters that
 
# don't exist or using markup commands wrongly.
 

	
 
WARN_IF_DOC_ERROR      = YES
 

	
 
# This WARN_NO_PARAMDOC option can be abled to get warnings for
 
# functions that are documented, but have no documentation for their parameters
 
# or return value. If set to NO (the default) doxygen will only warn about
 
# wrong or incomplete parameter documentation, but not about the absence of
 
# documentation.
 

	
 
WARN_NO_PARAMDOC       = NO
 

	
 
# The WARN_FORMAT tag determines the format of the warning messages that
 
# doxygen can produce. The string should contain the $file, $line, and $text
 
# tags, which will be replaced by the file and line number from which the
 
# warning originated and the warning text. Optionally the format may contain
 
# $version, which will be replaced by the version of the file (if it could
 
# be obtained via FILE_VERSION_FILTER)
 

	
 
WARN_FORMAT            = "$file:$line: $text"
 

	
 
# The WARN_LOGFILE tag can be used to specify a file to which warning
 
# and error messages should be written. If left blank the output is written
 
# to stderr.
 

	
 
WARN_LOGFILE           =
 

	
 
#---------------------------------------------------------------------------
 
# configuration options related to the input files
 
#---------------------------------------------------------------------------
 

	
 
# The INPUT tag can be used to specify the files and/or directories that contain
 
# documented source files. You may enter file names like "myfile.cpp" or
 
# directories like "/usr/src/myproject". Separate the files or directories
 
# with spaces.
 

	
 
INPUT                  =  ../src ../include ../input markdown ../arcos_f90/src
 

	
 
# This tag can be used to specify the character encoding of the source files
 
# that doxygen parses. Internally doxygen uses the UTF-8 encoding, which is
 
# also the default input encoding. Doxygen uses libiconv (or the iconv built
 
# into libc) for the transcoding. See http://www.gnu.org/software/libiconv for
 
# the list of possible encodings.
 

	
 
INPUT_ENCODING         = UTF-8
 

	
 
# If the value of the INPUT tag contains directories, you can use the
 
# FILE_PATTERNS tag to specify one or more wildcard pattern (like *.cpp
 
# and *.h) to filter out the source-files in the directories. If left
 
# blank the following patterns are tested:
 
# *.c *.cc *.cxx *.cpp *.c++ *.java *.ii *.ixx *.ipp *.i++ *.inl *.h *.hh *.hxx
 
# *.hpp *.h++ *.idl *.odl *.cs *.php *.php3 *.inc *.m *.mm *.py *.f90
 

	
 
FILE_PATTERNS          = *.c *.h MA*.md *.eps *.bib *.cfg *f90
 
#FILE_PATTERNS          = MA*.md *.eps *.bib
 

	
 
# The RECURSIVE tag can be used to turn specify whether or not subdirectories
 
# should be searched for input files as well. Possible values are YES and NO.
 
# If left blank NO is used.
 

	
 
RECURSIVE              = NO
 

	
 
# The EXCLUDE tag can be used to specify files and/or directories that should
 
# excluded from the INPUT source files. This way you can easily exclude a
 
# subdirectory from a directory tree whose root is specified with the INPUT tag.
 

	
 
EXCLUDE                =
 

	
 
# The EXCLUDE_SYMLINKS tag can be used select whether or not files or
 
# directories that are symbolic links (a Unix filesystem feature) are excluded
 
# from the input.
 

	
 
EXCLUDE_SYMLINKS       = NO
 

	
 
# If the value of the INPUT tag contains directories, you can use the
 
# EXCLUDE_PATTERNS tag to specify one or more wildcard patterns to exclude
 
# certain files from those directories. Note that the wildcards are matched
 
# against the file with absolute path, so to exclude all test directories
 
# for example use the pattern */test/*
 

	
 
EXCLUDE_PATTERNS       = *.f
 

	
 
# The EXCLUDE_SYMBOLS tag can be used to specify one or more symbol names
 
# (namespaces, classes, functions, etc.) that should be excluded from the
 
# output. The symbol name can be a fully qualified name, a word, or if the
 
# wildcard * is used, a substring. Examples: ANamespace, AClass,
 
# AClass::ANamespace, ANamespace::*Test
 

	
 
EXCLUDE_SYMBOLS        =
 

	
 
# The EXAMPLE_PATH tag can be used to specify one or more files or
 
# directories that contain example code fragments that are included (see
 
# the \include command).
 

	
 
EXAMPLE_PATH           =
 

	
 
# If the value of the EXAMPLE_PATH tag contains directories, you can use the
 
# EXAMPLE_PATTERNS tag to specify one or more wildcard pattern (like *.cpp
 
# and *.h) to filter out the source-files in the directories. If left
 
# blank all files are included.
 

	
 
EXAMPLE_PATTERNS       =
 

	
 
# If the EXAMPLE_RECURSIVE tag is set to YES then subdirectories will be
 
# searched for input files to be used with the \include or \dontinclude
 
# commands irrespective of the value of the RECURSIVE tag.
 
# Possible values are YES and NO. If left blank NO is used.
 

	
 
EXAMPLE_RECURSIVE      = NO
 

	
 
# The IMAGE_PATH tag can be used to specify one or more files or
 
# directories that contain image that are included in the documentation (see
 
# the \image command).
 

	
 
IMAGE_PATH             = figures
 

	
 
# The INPUT_FILTER tag can be used to specify a program that doxygen should
 
# invoke to filter for each input file. Doxygen will invoke the filter program
 
# by executing (via popen()) the command <filter> <input-file>, where <filter>
 
# is the value of the INPUT_FILTER tag, and <input-file> is the name of an
 
# input file. Doxygen will then use the output that the filter program writes
 
# to standard output.
 
# If FILTER_PATTERNS is specified, this tag will be
 
# ignored.
 

	
 
INPUT_FILTER           =
 

	
 
# The FILTER_PATTERNS tag can be used to specify filters on a per file pattern
 
# basis.
 
# Doxygen will compare the file name with each pattern and apply the
 
# filter if there is a match.
 
# The filters are a list of the form:
 
# pattern=filter (like *.cpp=my_cpp_filter). See INPUT_FILTER for further
 
# info on how filters are used. If FILTER_PATTERNS is empty, INPUT_FILTER
 
# is applied to all files.
 

	
 
FILTER_PATTERNS        =
 

	
 
# If the FILTER_SOURCE_FILES tag is set to YES, the input filter (if set using
 
# INPUT_FILTER) will be used to filter the input files when producing source
 
# files to browse (i.e. when SOURCE_BROWSER is set to YES).
 

	
 
FILTER_SOURCE_FILES    = NO
 

	
 
#---------------------------------------------------------------------------
 
# configuration options related to source browsing
 
#---------------------------------------------------------------------------
 

	
 
# If the SOURCE_BROWSER tag is set to YES then a list of source files will
 
# be generated. Documented entities will be cross-referenced with these sources.
 
# Note: To get rid of all source code in the generated output, make sure also
 
# VERBATIM_HEADERS is set to NO.
 

	
 
#SOURCE_BROWSER         = NO
 
SOURCE_BROWSER         = YES
 

	
 
# Setting the INLINE_SOURCES tag to YES will include the body
 
# of functions and classes directly in the documentation.
 

	
 
INLINE_SOURCES         = NO
 

	
 
# Setting the STRIP_CODE_COMMENTS tag to YES (the default) will instruct
 
# doxygen to hide any special comment blocks from generated source code
 
# fragments. Normal C and C++ comments will always remain visible.
 

	
 
STRIP_CODE_COMMENTS    = YES
 

	
 
# If the REFERENCED_BY_RELATION tag is set to YES
 
# then for each documented function all documented
 
# functions referencing it will be listed.
 

	
 
REFERENCED_BY_RELATION = NO
 

	
 
# If the REFERENCES_RELATION tag is set to YES
 
# then for each documented function all documented entities
 
# called/used by that function will be listed.
 

	
 
REFERENCES_RELATION    = NO
 

	
 
# If the REFERENCES_LINK_SOURCE tag is set to YES (the default)
 
# and SOURCE_BROWSER tag is set to YES, then the hyperlinks from
 
# functions in REFERENCES_RELATION and REFERENCED_BY_RELATION lists will
 
# link to the source code.
 
# Otherwise they will link to the documentation.
 

	
 
REFERENCES_LINK_SOURCE = YES
 

	
 
# If the USE_HTAGS tag is set to YES then the references to source code
 
# will point to the HTML generated by the htags(1) tool instead of doxygen
 
# built-in source browser. The htags tool is part of GNU's global source
 
# tagging system (see http://www.gnu.org/software/global/global.html). You
 
# will need version 4.8.6 or higher.
 

	
 
USE_HTAGS              = NO
 

	
 
# If the VERBATIM_HEADERS tag is set to YES (the default) then Doxygen
 
# will generate a verbatim copy of the header file for each class for
 
# which an include is specified. Set to NO to disable this.
 

	
 
VERBATIM_HEADERS       = YES
 

	
 
#---------------------------------------------------------------------------
 
# configuration options related to the alphabetical class index
 
#---------------------------------------------------------------------------
 

	
 
# If the ALPHABETICAL_INDEX tag is set to YES, an alphabetical index
 
# of all compounds will be generated. Enable this if the project
 
# contains a lot of classes, structs, unions or interfaces.
 

	
 
ALPHABETICAL_INDEX     = NO
 

	
 
# If the alphabetical index is enabled (see ALPHABETICAL_INDEX) then
 
# the COLS_IN_ALPHA_INDEX tag can be used to specify the number of columns
 
# in which this list will be split (can be a number in the range [1..20])
 

	
 
COLS_IN_ALPHA_INDEX    = 5
 

	
 
# In case all classes in a project start with a common prefix, all
 
# classes will be put under the same header in the alphabetical index.
 
# The IGNORE_PREFIX tag can be used to specify one or more prefixes that
 
# should be ignored while generating the index headers.
 

	
 
IGNORE_PREFIX          =
 

	
 
#---------------------------------------------------------------------------
 
# configuration options related to the HTML output
 
#---------------------------------------------------------------------------
 

	
 
# If the GENERATE_HTML tag is set to YES (the default) Doxygen will
 
# generate HTML output.
 

	
 
GENERATE_HTML          = YES
 

	
 
# The HTML_OUTPUT tag is used to specify where the HTML docs will be put.
 
# If a relative path is entered the value of OUTPUT_DIRECTORY will be
 
# put in front of it. If left blank `html' will be used as the default path.
 

	
 
HTML_OUTPUT            = html
 

	
 
# The HTML_FILE_EXTENSION tag can be used to specify the file extension for
 
# each generated HTML page (for example: .htm,.php,.asp). If it is left blank
 
# doxygen will generate files with .html extension.
 

	
 
HTML_FILE_EXTENSION    = .html
 

	
 
# The HTML_HEADER tag can be used to specify a personal HTML header for
 
# each generated HTML page. If it is left blank doxygen will generate a
 
# standard header.
 

	
 
HTML_HEADER            =
 

	
 
# The HTML_FOOTER tag can be used to specify a personal HTML footer for
 
# each generated HTML page. If it is left blank doxygen will generate a
 
# standard footer.
 

	
 
HTML_FOOTER            =
 

	
 
# The HTML_STYLESHEET tag can be used to specify a user-defined cascading
 
# style sheet that is used by each HTML page. It can be used to
 
# fine-tune the look of the HTML output. If the tag is left blank doxygen
 
# will generate a default style sheet. Note that doxygen will try to copy
 
# the style sheet file to the HTML output directory, so don't put your own
 
# stylesheet in the HTML output directory as well, or it will be erased!
 

	
 
HTML_STYLESHEET        =
 

	
 
# The HTML_COLORSTYLE_HUE tag controls the color of the HTML output.
 
# Doxygen will adjust the colors in the stylesheet and background images
 
# according to this color. Hue is specified as an angle on a colorwheel,
 
# see http://en.wikipedia.org/wiki/Hue for more information.
 
# For instance the value 0 represents red, 60 is yellow, 120 is green,
 
# 180 is cyan, 240 is blue, 300 purple, and 360 is red again.
 
# The allowed range is 0 to 359.
 

	
 
HTML_COLORSTYLE_HUE    = 220
 

	
 
# The HTML_COLORSTYLE_SAT tag controls the purity (or saturation) of
 
# the colors in the HTML output. For a value of 0 the output will use
 
# grayscales only. A value of 255 will produce the most vivid colors.
 

	
 
HTML_COLORSTYLE_SAT    = 100
 

	
 
# The HTML_COLORSTYLE_GAMMA tag controls the gamma correction applied to
 
# the luminance component of the colors in the HTML output. Values below
 
# 100 gradually make the output lighter, whereas values above 100 make
 
# the output darker. The value divided by 100 is the actual gamma applied,
 
# so 80 represents a gamma of 0.8, The value 220 represents a gamma of 2.2,
 
# and 100 does not change the gamma.
 

	
 
HTML_COLORSTYLE_GAMMA  = 80
 

	
 
# If the HTML_TIMESTAMP tag is set to YES then the footer of each generated HTML
 
# page will contain the date and time when the page was generated. Setting
 
# this to NO can help when comparing the output of multiple runs.
 

	
 
HTML_TIMESTAMP         = YES
 

	
 
# If the HTML_DYNAMIC_SECTIONS tag is set to YES then the generated HTML
 
# documentation will contain sections that can be hidden and shown after the
 
# page has loaded. For this to work a browser that supports
 
# JavaScript and DHTML is required (for instance Mozilla 1.0+, Firefox
 
# Netscape 6.0+, Internet explorer 5.0+, Konqueror, or Safari).
 

	
 
HTML_DYNAMIC_SECTIONS  = NO
 

	
 
# If the GENERATE_DOCSET tag is set to YES, additional index files
 
# will be generated that can be used as input for Apple's Xcode 3
 
# integrated development environment, introduced with OSX 10.5 (Leopard).
 
# To create a documentation set, doxygen will generate a Makefile in the
 
# HTML output directory. Running make will produce the docset in that
 
# directory and running "make install" will install the docset in
 
# ~/Library/Developer/Shared/Documentation/DocSets so that Xcode will find
 
# it at startup.
 
# See http://developer.apple.com/tools/creatingdocsetswithdoxygen.html
 
# for more information.
 

	
 
GENERATE_DOCSET        = NO
 

	
 
# When GENERATE_DOCSET tag is set to YES, this tag determines the name of the
 
# feed. A documentation feed provides an umbrella under which multiple
 
# documentation sets from a single provider (such as a company or product suite)
 
# can be grouped.
 

	
 
DOCSET_FEEDNAME        = "Doxygen generated docs 1.7.4"
 

	
 
# When GENERATE_DOCSET tag is set to YES, this tag specifies a string that
 
# should uniquely identify the documentation set bundle. This should be a
 
# reverse domain-name style string, e.g. com.mycompany.MyDocSet. Doxygen
 
# will append .docset to the name.
 

	
 
DOCSET_BUNDLE_ID       = org.doxygen.Project
 

	
 
# When GENERATE_PUBLISHER_ID tag specifies a string that should uniquely identify
 
# the documentation publisher. This should be a reverse domain-name style
 
# string, e.g. com.mycompany.MyDocSet.documentation.
 

	
 
DOCSET_PUBLISHER_ID    = org.doxygen.Publisher
 

	
 
# The GENERATE_PUBLISHER_NAME tag identifies the documentation publisher.
 

	
 
DOCSET_PUBLISHER_NAME  = Publisher
 

	
 
# If the GENERATE_HTMLHELP tag is set to YES, additional index files
 
# will be generated that can be used as input for tools like the
 
# Microsoft HTML help workshop to generate a compiled HTML help file (.chm)
 
# of the generated HTML documentation.
 

	
 
GENERATE_HTMLHELP      = NO
 

	
 
# If the GENERATE_HTMLHELP tag is set to YES, the CHM_FILE tag can
 
# be used to specify the file name of the resulting .chm file. You
 
# can add a path in front of the file if the result should not be
 
# written to the html output directory.
 

	
 
CHM_FILE               =
 

	
 
# If the GENERATE_HTMLHELP tag is set to YES, the HHC_LOCATION tag can
 
# be used to specify the location (absolute path including file name) of
 
# the HTML help compiler (hhc.exe). If non-empty doxygen will try to run
 
# the HTML help compiler on the generated index.hhp.
 

	
 
HHC_LOCATION           =
 

	
 
# If the GENERATE_HTMLHELP tag is set to YES, the GENERATE_CHI flag
 
# controls if a separate .chi index file is generated (YES) or that
 
# it should be included in the master .chm file (NO).
 

	
 
GENERATE_CHI           = NO
 

	
 
# If the GENERATE_HTMLHELP tag is set to YES, the CHM_INDEX_ENCODING
 
# is used to encode HtmlHelp index (hhk), content (hhc) and project file
 
# content.
 

	
 
CHM_INDEX_ENCODING     =
 

	
 
# If the GENERATE_HTMLHELP tag is set to YES, the BINARY_TOC flag
 
# controls whether a binary table of contents is generated (YES) or a
 
# normal table of contents (NO) in the .chm file.
 

	
 
BINARY_TOC             = NO
 

	
 
# The TOC_EXPAND flag can be set to YES to add extra items for group members
 
# to the contents of the HTML help documentation and to the tree view.
 

	
 
TOC_EXPAND             = NO
 

	
 
# If the GENERATE_QHP tag is set to YES and both QHP_NAMESPACE and
 
# QHP_VIRTUAL_FOLDER are set, an additional index file will be generated
 
# that can be used as input for Qt's qhelpgenerator to generate a
 
# Qt Compressed Help (.qch) of the generated HTML documentation.
 

	
 
GENERATE_QHP           = NO
 

	
 
# If the QHG_LOCATION tag is specified, the QCH_FILE tag can
 
# be used to specify the file name of the resulting .qch file.
 
# The path specified is relative to the HTML output folder.
 

	
 
QCH_FILE               =
 

	
 
# The QHP_NAMESPACE tag specifies the namespace to use when generating
 
# Qt Help Project output. For more information please see
 
# http://doc.trolltech.com/qthelpproject.html#namespace
 

	
 
QHP_NAMESPACE          = org.doxygen.Project
 

	
 
# The QHP_VIRTUAL_FOLDER tag specifies the namespace to use when generating
 
# Qt Help Project output. For more information please see
 
# http://doc.trolltech.com/qthelpproject.html#virtual-folders
 

	
 
QHP_VIRTUAL_FOLDER     = doc
 

	
 
# If QHP_CUST_FILTER_NAME is set, it specifies the name of a custom filter to
 
# add. For more information please see
 
# http://doc.trolltech.com/qthelpproject.html#custom-filters
 

	
 
QHP_CUST_FILTER_NAME   =
 

	
 
# The QHP_CUST_FILT_ATTRS tag specifies the list of the attributes of the
 
# custom filter to add. For more information please see
 
# <a href="http://doc.trolltech.com/qthelpproject.html#custom-filters">
 
# Qt Help Project / Custom Filters</a>.
 

	
 
QHP_CUST_FILTER_ATTRS  =
 

	
 
# The QHP_SECT_FILTER_ATTRS tag specifies the list of the attributes this
 
# project's
 
# filter section matches.
 
# <a href="http://doc.trolltech.com/qthelpproject.html#filter-attributes">
 
# Qt Help Project / Filter Attributes</a>.
 

	
 
QHP_SECT_FILTER_ATTRS  =
 

	
 
# If the GENERATE_QHP tag is set to YES, the QHG_LOCATION tag can
 
# be used to specify the location of Qt's qhelpgenerator.
 
# If non-empty doxygen will try to run qhelpgenerator on the generated
 
# .qhp file.
 

	
 
QHG_LOCATION           =
 

	
 
# If the GENERATE_ECLIPSEHELP tag is set to YES, additional index files
 
#  will be generated, which together with the HTML files, form an Eclipse help
 
# plugin. To install this plugin and make it available under the help contents
 
# menu in Eclipse, the contents of the directory containing the HTML and XML
 
# files needs to be copied into the plugins directory of eclipse. The name of
 
# the directory within the plugins directory should be the same as
 
# the ECLIPSE_DOC_ID value. After copying Eclipse needs to be restarted before
 
# the help appears.
 

	
 
GENERATE_ECLIPSEHELP   = NO
 

	
 
# A unique identifier for the eclipse help plugin. When installing the plugin
 
# the directory name containing the HTML and XML files should also have
 
# this name.
 

	
 
ECLIPSE_DOC_ID         = org.doxygen.Project
 

	
 
# The DISABLE_INDEX tag can be used to turn on/off the condensed index at
 
# top of each HTML page. The value NO (the default) enables the index and
 
# the value YES disables it.
 

	
 
DISABLE_INDEX          = NO
 

	
 
# This tag can be used to set the number of enum values (range [1..20])
 
# that doxygen will group on one line in the generated HTML documentation.
 

	
 
ENUM_VALUES_PER_LINE   = 4
 

	
 
# The GENERATE_TREEVIEW tag is used to specify whether a tree-like index
 
# structure should be generated to display hierarchical information.
 
# If the tag value is set to YES, a side panel will be generated
 
# containing a tree-like index structure (just like the one that
 
# is generated for HTML Help). For this to work a browser that supports
 
# JavaScript, DHTML, CSS and frames is required (i.e. any modern browser).
 
# Windows users are probably better off using the HTML help feature.
 

	
 
GENERATE_TREEVIEW      = NO
 

	
 
# If the treeview is enabled (see GENERATE_TREEVIEW) then this tag can be
 
# used to set the initial width (in pixels) of the frame in which the tree
 
# is shown.
 

	
 
TREEVIEW_WIDTH         = 250
 

	
 
# When the EXT_LINKS_IN_WINDOW option is set to YES doxygen will open
 
# links to external symbols imported via tag files in a separate window.
 

	
 
EXT_LINKS_IN_WINDOW    = NO
 

	
 
# Use this tag to change the font size of Latex formulas included
 
# as images in the HTML documentation. The default is 10. Note that
 
# when you change the font size after a successful doxygen run you need
 
# to manually remove any form_*.png images from the HTML output directory
 
# to force them to be regenerated.
 

	
 
FORMULA_FONTSIZE       = 10
 

	
 
# Use the FORMULA_TRANPARENT tag to determine whether or not the images
 
# generated for formulas are transparent PNGs. Transparent PNGs are
 
# not supported properly for IE 6.0, but are supported on all modern browsers.
 
# Note that when changing this option you need to delete any form_*.png files
 
# in the HTML output before the changes have effect.
 

	
 
FORMULA_TRANSPARENT    = YES
 

	
 
# When the SEARCHENGINE tag is enabled doxygen will generate a search box
 
# for the HTML output. The underlying search engine uses javascript
 
# and DHTML and should work on any modern browser. Note that when using
 
# HTML help (GENERATE_HTMLHELP), Qt help (GENERATE_QHP), or docsets
 
# (GENERATE_DOCSET) there is already a search function so this one should
 
# typically be disabled. For large projects the javascript based search engine
 
# can be slow, then enabling SERVER_BASED_SEARCH may provide a better solution.
 

	
 
SEARCHENGINE           = YES
 

	
 
# When the SERVER_BASED_SEARCH tag is enabled the search engine will be
 
# implemented using a PHP enabled web server instead of at the web client
 
# using Javascript. Doxygen will generate the search PHP script and index
 
# file to put on the web server. The advantage of the server
 
# based approach is that it scales better to large projects and allows
 
# full text search. The disadvances is that it is more difficult to setup
 
# and does not have live searching capabilities.
 

	
 
SERVER_BASED_SEARCH    = NO
 

	
 
#---------------------------------------------------------------------------
 
# configuration options related to the LaTeX output
 
#---------------------------------------------------------------------------
 

	
 
# If the GENERATE_LATEX tag is set to YES (the default) Doxygen will
 
# generate Latex output.
 

	
 
#GENERATE_LATEX         = YES
 
GENERATE_LATEX         = NO
 

	
 
# The LATEX_OUTPUT tag is used to specify where the LaTeX docs will be put.
 
# If a relative path is entered the value of OUTPUT_DIRECTORY will be
 
# put in front of it. If left blank `latex' will be used as the default path.
 

	
 
LATEX_OUTPUT           = latex
 

	
 
# The LATEX_CMD_NAME tag can be used to specify the LaTeX command name to be
 
# invoked. If left blank `latex' will be used as the default command name.
 
# Note that when enabling USE_PDFLATEX this option is only used for
 
# generating bitmaps for formulas in the HTML output, but not in the
 
# Makefile that is written to the output directory.
 

	
 
LATEX_CMD_NAME         = latex
 

	
 
# The MAKEINDEX_CMD_NAME tag can be used to specify the command name to
 
# generate index for LaTeX. If left blank `makeindex' will be used as the
 
# default command name.
 

	
 
MAKEINDEX_CMD_NAME     = makeindex
 

	
 
# If the COMPACT_LATEX tag is set to YES Doxygen generates more compact
 
# LaTeX documents. This may be useful for small projects and may help to
 
# save some trees in general.
 

	
 
COMPACT_LATEX          = NO
 

	
 
# The PAPER_TYPE tag can be used to set the paper type that is used
 
# by the printer. Possible values are: a4, a4wide, letter, legal and
 
# executive. If left blank a4wide will be used.
 

	
 
PAPER_TYPE             = a4wide
 

	
 
# The EXTRA_PACKAGES tag can be to specify one or more names of LaTeX
 
# packages that should be included in the LaTeX output.
 

	
 
EXTRA_PACKAGES         =
 

	
 
# The LATEX_HEADER tag can be used to specify a personal LaTeX header for
 
# the generated latex document. The header should contain everything until
 
# the first chapter. If it is left blank doxygen will generate a
 
# standard header. Notice: only use this tag if you know what you are doing!
 

	
 
LATEX_HEADER           =
 

	
 
# If the PDF_HYPERLINKS tag is set to YES, the LaTeX that is generated
 
# is prepared for conversion to pdf (using ps2pdf). The pdf file will
 
# contain links (just like the HTML output) instead of page references
 
# This makes the output suitable for online browsing using a pdf viewer.
 

	
 
PDF_HYPERLINKS         = YES
 

	
 
# If the USE_PDFLATEX tag is set to YES, pdflatex will be used instead of
 
# plain latex in the generated Makefile. Set this option to YES to get a
 
# higher quality PDF documentation.
 

	
 
USE_PDFLATEX           = YES
 

	
 
# If the LATEX_BATCHMODE tag is set to YES, doxygen will add the \\batchmode.
 
# command to the generated LaTeX files. This will instruct LaTeX to keep
 
# running if errors occur, instead of asking the user for help.
 
# This option is also used when generating formulas in HTML.
 

	
 
LATEX_BATCHMODE        = NO
 

	
 
# If LATEX_HIDE_INDICES is set to YES then doxygen will not
 
# include the index chapters (such as File Index, Compound Index, etc.)
 
# in the output.
 

	
 
LATEX_HIDE_INDICES     = NO
 

	
 
# If LATEX_SOURCE_CODE is set to YES then doxygen will include
 
# source code with syntax highlighting in the LaTeX output.
 
# Note that which sources are shown also depends on other settings
 
# such as SOURCE_BROWSER.
 

	
 
LATEX_SOURCE_CODE      = NO
 

	
 
#---------------------------------------------------------------------------
 
# configuration options related to the RTF output
 
#---------------------------------------------------------------------------
 

	
 
# If the GENERATE_RTF tag is set to YES Doxygen will generate RTF output
 
# The RTF output is optimized for Word 97 and may not look very pretty with
 
# other RTF readers or editors.
 

	
 
GENERATE_RTF           = NO
 

	
 
# The RTF_OUTPUT tag is used to specify where the RTF docs will be put.
 
# If a relative path is entered the value of OUTPUT_DIRECTORY will be
 
# put in front of it. If left blank `rtf' will be used as the default path.
 

	
 
RTF_OUTPUT             = rtf
 

	
 
# If the COMPACT_RTF tag is set to YES Doxygen generates more compact
 
# RTF documents. This may be useful for small projects and may help to
 
# save some trees in general.
 

	
 
COMPACT_RTF            = NO
 

	
 
# If the RTF_HYPERLINKS tag is set to YES, the RTF that is generated
 
# will contain hyperlink fields. The RTF file will
 
# contain links (just like the HTML output) instead of page references.
 
# This makes the output suitable for online browsing using WORD or other
 
# programs which support those fields.
 
# Note: wordpad (write) and others do not support links.
 

	
 
RTF_HYPERLINKS         = NO
 

	
 
# Load stylesheet definitions from file. Syntax is similar to doxygen's
 
# config file, i.e. a series of assignments. You only have to provide
 
# replacements, missing definitions are set to their default value.
 

	
 
RTF_STYLESHEET_FILE    =
 

	
 
# Set optional variables used in the generation of an rtf document.
 
# Syntax is similar to doxygen's config file.
 

	
 
RTF_EXTENSIONS_FILE    =
 

	
 
#---------------------------------------------------------------------------
 
# configuration options related to the man page output
 
#---------------------------------------------------------------------------
 

	
 
# If the GENERATE_MAN tag is set to YES (the default) Doxygen will
 
# generate man pages
 

	
 
GENERATE_MAN           = NO
 

	
 
# The MAN_OUTPUT tag is used to specify where the man pages will be put.
 
# If a relative path is entered the value of OUTPUT_DIRECTORY will be
 
# put in front of it. If left blank `man' will be used as the default path.
 

	
 
MAN_OUTPUT             = man
 

	
 
# The MAN_EXTENSION tag determines the extension that is added to
 
# the generated man pages (default is the subroutine's section .3)
 

	
 
MAN_EXTENSION          = .3
 

	
 
# If the MAN_LINKS tag is set to YES and Doxygen generates man output,
 
# then it will generate one additional man file for each entity
 
# documented in the real man page(s). These additional files
 
# only source the real man page, but without them the man command
 
# would be unable to find the correct page. The default is NO.
 

	
 
MAN_LINKS              = NO
 

	
 
#---------------------------------------------------------------------------
 
# configuration options related to the XML output
 
#---------------------------------------------------------------------------
 

	
 
# If the GENERATE_XML tag is set to YES Doxygen will
 
# generate an XML file that captures the structure of
 
# the code including all documentation.
 

	
 
GENERATE_XML           = NO
 

	
 
# The XML_OUTPUT tag is used to specify where the XML pages will be put.
 
# If a relative path is entered the value of OUTPUT_DIRECTORY will be
 
# put in front of it. If left blank `xml' will be used as the default path.
 

	
 
XML_OUTPUT             = xml
 

	
 
# The XML_SCHEMA tag can be used to specify an XML schema,
 
# which can be used by a validating XML parser to check the
 
# syntax of the XML files.
 

	
 
XML_SCHEMA             =
 

	
 
# The XML_DTD tag can be used to specify an XML DTD,
 
# which can be used by a validating XML parser to check the
 
# syntax of the XML files.
 

	
 
XML_DTD                =
 

	
 
# If the XML_PROGRAMLISTING tag is set to YES Doxygen will
 
# dump the program listings (including syntax highlighting
 
# and cross-referencing information) to the XML output. Note that
 
# enabling this will significantly increase the size of the XML output.
 

	
 
XML_PROGRAMLISTING     = YES
 

	
 
#---------------------------------------------------------------------------
 
# configuration options for the AutoGen Definitions output
 
#---------------------------------------------------------------------------
 

	
 
# If the GENERATE_AUTOGEN_DEF tag is set to YES Doxygen will
 
# generate an AutoGen Definitions (see autogen.sf.net) file
 
# that captures the structure of the code including all
 
# documentation. Note that this feature is still experimental
 
# and incomplete at the moment.
 

	
 
GENERATE_AUTOGEN_DEF   = NO
 

	
 
#---------------------------------------------------------------------------
 
# configuration options related to the Perl module output
 
#---------------------------------------------------------------------------
 

	
 
# If the GENERATE_PERLMOD tag is set to YES Doxygen will
 
# generate a Perl module file that captures the structure of
 
# the code including all documentation. Note that this
 
# feature is still experimental and incomplete at the
 
# moment.
 

	
 
GENERATE_PERLMOD       = NO
 

	
 
# If the PERLMOD_LATEX tag is set to YES Doxygen will generate
 
# the necessary Makefile rules, Perl scripts and LaTeX code to be able
 
# to generate PDF and DVI output from the Perl module output.
 

	
 
PERLMOD_LATEX          = NO
 

	
 
# If the PERLMOD_PRETTY tag is set to YES the Perl module output will be
 
# nicely formatted so it can be parsed by a human reader.
 
# This is useful
 
# if you want to understand what is going on.
 
# On the other hand, if this
 
# tag is set to NO the size of the Perl module output will be much smaller
 
# and Perl will parse it just the same.
 

	
 
PERLMOD_PRETTY         = YES
 

	
 
# The names of the make variables in the generated doxyrules.make file
 
# are prefixed with the string contained in PERLMOD_MAKEVAR_PREFIX.
 
# This is useful so different doxyrules.make files included by the same
 
# Makefile don't overwrite each other's variables.
 

	
 
PERLMOD_MAKEVAR_PREFIX =
 

	
 
#---------------------------------------------------------------------------
 
# Configuration options related to the preprocessor
 
#---------------------------------------------------------------------------
 

	
 
# If the ENABLE_PREPROCESSING tag is set to YES (the default) Doxygen will
 
# evaluate all C-preprocessor directives found in the sources and include
 
# files.
 

	
 
ENABLE_PREPROCESSING   = YES
 

	
 
# If the MACRO_EXPANSION tag is set to YES Doxygen will expand all macro
 
# names in the source code. If set to NO (the default) only conditional
 
# compilation will be performed. Macro expansion can be done in a controlled
 
# way by setting EXPAND_ONLY_PREDEF to YES.
 

	
 
MACRO_EXPANSION        = YES
 

	
 
# If the EXPAND_ONLY_PREDEF and MACRO_EXPANSION tags are both set to YES
 
# then the macro expansion is limited to the macros specified with the
 
# PREDEFINED and EXPAND_AS_DEFINED tags.
 

	
 
EXPAND_ONLY_PREDEF     = YES
 

	
 
# If the SEARCH_INCLUDES tag is set to YES (the default) the includes files
 
# in the INCLUDE_PATH (see below) will be search if a #include is found.
 

	
 
SEARCH_INCLUDES        = YES
 

	
 
# The INCLUDE_PATH tag can be used to specify one or more directories that
 
# contain include files that are not input files but should be processed by
 
# the preprocessor.
 

	
 
INCLUDE_PATH           = 
 

	
 
# You can use the INCLUDE_FILE_PATTERNS tag to specify one or more wildcard
 
# patterns (like *.h and *.hpp) to filter out the header-files in the
 
# directories. If left blank, the patterns specified with FILE_PATTERNS will
 
# be used.
 

	
 
INCLUDE_FILE_PATTERNS  = *.h
 

	
 
# The PREDEFINED tag can be used to specify one or more macro names that
 
# are defined before the preprocessor is started (similar to the -D option of
 
# gcc). The argument of the tag is a list of macros of the form: name
 
# or name=definition (no spaces). If the definition and the = are
 
# omitted =1 is assumed. To prevent a macro definition from being
 
# undefined via #undef or recursively expanded use the := operator
 
# instead of the = operator.
 

	
 
PREDEFINED             = decl_param()=
 

	
 
# If the MACRO_EXPANSION and EXPAND_ONLY_PREDEF tags are set to YES then
 
# this tag can be used to specify a list of macro names that should be expanded.
 
# The macro definition that is found in the sources will be used.
 
# Use the PREDEFINED tag if you want to use a different macro definition.
 

	
 
EXPAND_AS_DEFINED      = 
 

	
 
# If the SKIP_FUNCTION_MACROS tag is set to YES (the default) then
 
# doxygen's preprocessor will remove all function-like macros that are alone
 
# on a line, have an all uppercase name, and do not end with a semicolon. Such
 
# function macros are typically used for boiler-plate code, and will confuse
 
# the parser if not removed.
 

	
 
SKIP_FUNCTION_MACROS   = YES
 

	
 
#---------------------------------------------------------------------------
 
# Configuration::additions related to external references
 
#---------------------------------------------------------------------------
 

	
 
# The TAGFILES option can be used to specify one or more tagfiles.
 
# Optionally an initial location of the external documentation
 
# can be added for each tagfile. The format of a tag file without
 
# this location is as follows:
 
#
 
# TAGFILES = file1 file2 ...
 
# Adding location for the tag files is done as follows:
 
#
 
# TAGFILES = file1=loc1 "file2 = loc2" ...
 
# where "loc1" and "loc2" can be relative or absolute paths or
 
# URLs. If a location is present for each tag, the installdox tool
 
# does not have to be run to correct the links.
 
# Note that each tag file must have a unique name
 
# (where the name does NOT include the path)
 
# If a tag file is not located in the directory in which doxygen
 
# is run, you must also specify the path to the tagfile here.
 

	
 
TAGFILES               =
 

	
 
# When a file name is specified after GENERATE_TAGFILE, doxygen will create
 
# a tag file that is based on the input files it reads.
 

	
 
GENERATE_TAGFILE       =
 

	
 
# If the ALLEXTERNALS tag is set to YES all external classes will be listed
 
# in the class index. If set to NO only the inherited external classes
 
# will be listed.
 

	
 
ALLEXTERNALS           = NO
 

	
 
# If the EXTERNAL_GROUPS tag is set to YES all external groups will be listed
 
# in the modules index. If set to NO, only the current project's groups will
 
# be listed.
 

	
 
EXTERNAL_GROUPS        = YES
 

	
 
# The PERL_PATH should be the absolute path and name of the perl script
 
# interpreter (i.e. the result of `which perl').
 

	
 
PERL_PATH              = /usr/bin/perl
 

	
 
#---------------------------------------------------------------------------
 
# Configuration options related to the dot tool
 
#---------------------------------------------------------------------------
 

	
 
# If the CLASS_DIAGRAMS tag is set to YES (the default) Doxygen will
 
# generate a inheritance diagram (in HTML, RTF and LaTeX) for classes with base
 
# or super classes. Setting the tag to NO turns the diagrams off. Note that
 
# this option is superseded by the HAVE_DOT option below. This is only a
 
# fallback. It is recommended to install and use dot, since it yields more
 
# powerful graphs.
 

	
 
#CLASS_DIAGRAMS         = YES
 
CLASS_DIAGRAMS         = NO
 

	
 
# You can define message sequence charts within doxygen comments using the \msc
 
# command. Doxygen will then run the mscgen tool (see
 
# http://www.mcternan.me.uk/mscgen/) to produce the chart and insert it in the
 
# documentation. The MSCGEN_PATH tag allows you to specify the directory where
 
# the mscgen tool resides. If left empty the tool is assumed to be found in the
 
# default search path.
 

	
 
MSCGEN_PATH            =
 

	
 
# If set to YES, the inheritance and collaboration graphs will hide
 
# inheritance and usage relations if the target is undocumented
 
# or is not a class.
 

	
 
#HIDE_UNDOC_RELATIONS   = NO
 
HIDE_UNDOC_RELATIONS   = YES
 

	
 
# If you set the HAVE_DOT tag to YES then doxygen will assume the dot tool is
 
# available from the path. This tool is part of Graphviz, a graph visualization
 
# toolkit from AT&T and Lucent Bell Labs. The other options in this section
 
# have no effect if this option is set to NO (the default)
 

	
 
HAVE_DOT               = YES
 

	
 
# By default doxygen will write a font called FreeSans.ttf to the output
 
# directory and reference it in all dot files that doxygen generates. This
 
# font does not include all possible unicode characters however, so when you need
 
# these (or just want a differently looking font) you can specify the font name
 
# using DOT_FONTNAME. You need need to make sure dot is able to find the font,
 
# which can be done by putting it in a standard location or by setting the
 
# DOTFONTPATH environment variable or by setting DOT_FONTPATH to the directory
 
# containing the font.
 

	
 
DOT_FONTNAME           = FreeSans
 

	
 
# The DOT_FONTSIZE tag can be used to set the size of the font of dot graphs.
 
# The default size is 10pt.
 

	
 
DOT_FONTSIZE           = 10
 

	
 
# By default doxygen will tell dot to use the output directory to look for the
 
# FreeSans.ttf font (which doxygen will put there itself). If you specify a
 
# different font using DOT_FONTNAME you can set the path where dot
 
# can find it using this tag.
 

	
 
DOT_FONTPATH           =
 

	
 
# If the CLASS_GRAPH and HAVE_DOT tags are set to YES then doxygen
 
# will generate a graph for each documented class showing the direct and
 
# indirect inheritance relations. Setting this tag to YES will force the
 
# the CLASS_DIAGRAMS tag to NO.
 

	
 
CLASS_GRAPH            = YES
 

	
 
# If the COLLABORATION_GRAPH and HAVE_DOT tags are set to YES then doxygen
 
# will generate a graph for each documented class showing the direct and
 
# indirect implementation dependencies (inheritance, containment, and
 
# class references variables) of the class with other documented classes.
 

	
 
#COLLABORATION_GRAPH    = YES
 
COLLABORATION_GRAPH    = NO
 

	
 
# If the GROUP_GRAPHS and HAVE_DOT tags are set to YES then doxygen
 
# will generate a graph for groups, showing the direct groups dependencies
 

	
 
GROUP_GRAPHS           = YES
 

	
 
# If the UML_LOOK tag is set to YES doxygen will generate inheritance and
 
# collaboration diagrams in a style similar to the OMG's Unified Modeling
 
# Language.
 

	
 
UML_LOOK               = NO
 

	
 
# If set to YES, the inheritance and collaboration graphs will show the
 
# relations between templates and their instances.
 

	
 
TEMPLATE_RELATIONS     = NO
 

	
 
# If the ENABLE_PREPROCESSING, SEARCH_INCLUDES, INCLUDE_GRAPH, and HAVE_DOT
 
# tags are set to YES then doxygen will generate a graph for each documented
 
# file showing the direct and indirect include dependencies of the file with
 
# other documented files.
 

	
 
INCLUDE_GRAPH          = YES
 

	
 
# If the ENABLE_PREPROCESSING, SEARCH_INCLUDES, INCLUDED_BY_GRAPH, and
 
# HAVE_DOT tags are set to YES then doxygen will generate a graph for each
 
# documented header file showing the documented files that directly or
 
# indirectly include this file.
 

	
 
INCLUDED_BY_GRAPH      = YES
 

	
 
# If the CALL_GRAPH and HAVE_DOT options are set to YES then
 
# doxygen will generate a call dependency graph for every global function
 
# or class method. Note that enabling this option will significantly increase
 
# the time of a run. So in most cases it will be better to enable call graphs
 
# for selected functions only using the \callgraph command.
 

	
 
CALL_GRAPH             = YES
 

	
 
# If the CALLER_GRAPH and HAVE_DOT tags are set to YES then
 
# doxygen will generate a caller dependency graph for every global function
 
# or class method. Note that enabling this option will significantly increase
 
# the time of a run. So in most cases it will be better to enable caller
 
# graphs for selected functions only using the \callergraph command.
 

	
 
CALLER_GRAPH           = YES
 

	
 
# If the GRAPHICAL_HIERARCHY and HAVE_DOT tags are set to YES then doxygen
 
# will graphical hierarchy of all classes instead of a textual one.
 

	
 
GRAPHICAL_HIERARCHY    = YES
 

	
 
# The DOT_IMAGE_FORMAT tag can be used to set the image format of the images
 
# generated by dot. Possible values are png, jpg, or gif
 
# If left blank png will be used.
 

	
 
DOT_IMAGE_FORMAT       = png
 

	
 
# The tag DOT_PATH can be used to specify the path where the dot tool can be
 
# found. If left blank, it is assumed the dot tool can be found in the path.
 

	
 
DOT_PATH               =
 

	
 
# The DOTFILE_DIRS tag can be used to specify one or more directories that
 
# contain dot files that are included in the documentation (see the
 
# \dotfile command).
 

	
 
DOTFILE_DIRS           =
 

	
 
# The DOT_GRAPH_MAX_NODES tag can be used to set the maximum number of
 
# nodes that will be shown in the graph. If the number of nodes in a graph
 
# becomes larger than this value, doxygen will truncate the graph, which is
 
# visualized by representing a node as a red box. Note that doxygen if the
 
# number of direct children of the root node in a graph is already larger than
 
# DOT_GRAPH_MAX_NODES then the graph will not be shown at all. Also note
 
# that the size of a graph can be further restricted by MAX_DOT_GRAPH_DEPTH.
 

	
 
DOT_GRAPH_MAX_NODES    = 50
 

	
 
# The MAX_DOT_GRAPH_DEPTH tag can be used to set the maximum depth of the
 
# graphs generated by dot. A depth value of 3 means that only nodes reachable
 
# from the root by following a path via at most 3 edges will be shown. Nodes
 
# that lay further from the root node will be omitted. Note that setting this
 
# option to 1 or 2 may greatly reduce the computation time needed for large
 
# code bases. Also note that the size of a graph can be further restricted by
 
# DOT_GRAPH_MAX_NODES. Using a depth of 0 means no depth restriction.
 

	
 
MAX_DOT_GRAPH_DEPTH    = 3
 

	
 
# Set the DOT_TRANSPARENT tag to YES to generate images with a transparent
 
# background. This is disabled by default, because dot on Windows does not
 
# seem to support this out of the box. Warning: Depending on the platform used,
 
# enabling this option may lead to badly anti-aliased labels on the edges of
 
# a graph (i.e. they become hard to read).
 

	
 
DOT_TRANSPARENT        = NO
 

	
 
# Set the DOT_MULTI_TARGETS tag to YES allow dot to generate multiple output
 
# files in one run (i.e. multiple -o and -T options on the command line). This
 
# makes dot run faster, but since only newer versions of dot (>1.8.10)
 
# support this, this feature is disabled by default.
 

	
 
DOT_MULTI_TARGETS      = YES
 

	
 
# If the GENERATE_LEGEND tag is set to YES (the default) Doxygen will
 
# generate a legend page explaining the meaning of the various boxes and
 
# arrows in the dot generated graphs.
 

	
 
GENERATE_LEGEND        = YES
 

	
 
# If the DOT_CLEANUP tag is set to YES (the default) Doxygen will
 
# remove the intermediate dot files that are used to generate
 
# the various graphs.
 

	
 
DOT_CLEANUP            = YES
 

	
 
#  The CITE_BIB_FILES tag can be used to specify one or more bib files
 
#  containing the reference definitions. This must be a list of .bib files.
 
#  The .bib extension is automatically appended if omitted.
 
#  This requires the bibtex tool to be installed. See also
 
#  http://en.wikipedia.org/wiki/BibTeX for more info. For LaTeX the style
 
#  of the bibliography can be controlled using LATEX_BIB_STYLE.
 
#  See also \cite for info how to create references.
 

	
 
CITE_BIB_FILES         = ../markdown/benzi
 

	
 
# The LATEX_BIB_STYLE tag can be used to specify the style to use for the
 
# bibliography, e.g. plainnat, or ieeetr. The default style is plain.
 
# See http://en.wikipedia.org/wiki/BibTeX and \cite for more info.
 

	
 
LATEX_BIB_STYLE       = plain
 

	
 
FORMULA_FONTSIZE	= 12
doc/figures/figure2.eps
Show inline comments
 
new file 100644
 
%!PS-Adobe-3.0
 
%%Creator: PyX 0.10
 
%%LanguageLevel: 2
 
%%DocumentSuppliedResources: (atend)
 
%%DocumentMedia: plain 189 252 0 () ()
 
%%BoundingBox: 0 0 189 252
 
%%Pages: 1
 
%%EndComments
 
%%BeginDefaults
 
%%PageMedia: plain
 
%%EndDefaults
 
%%BeginProlog
 
%%BeginResource: procset xpdf 3.00 0
 
%%Copyright: Copyright 1996-2004 Glyph & Cog, LLC
 
/xpdf 75 dict def xpdf begin
 
% PDF special state
 
/pdfDictSize 15 def
 
/pdfSetup {
 
  3 1 roll 2 array astore
 
  /setpagedevice where {
 
    pop 3 dict begin
 
      /PageSize exch def
 
      /ImagingBBox null def
 
      { /Duplex true def } if
 
    currentdict end setpagedevice
 
  } {
 
    pop pop
 
  } ifelse
 
} def
 
/pdfStartPage {
 
  pdfDictSize dict begin
 
  /pdfFillCS [] def
 
  /pdfFillXform {} def
 
  /pdfStrokeCS [] def
 
  /pdfStrokeXform {} def
 
  /pdfFill [0] def
 
  /pdfStroke [0] def
 
  /pdfFillOP false def
 
  /pdfStrokeOP false def
 
  /pdfLastFill false def
 
  /pdfLastStroke false def
 
  /pdfTextMat [1 0 0 1 0 0] def
 
  /pdfFontSize 0 def
 
  /pdfCharSpacing 0 def
 
  /pdfTextRender 0 def
 
  /pdfTextRise 0 def
 
  /pdfWordSpacing 0 def
 
  /pdfHorizScaling 1 def
 
  /pdfTextClipPath [] def
 
} def
 
/pdfEndPage { end } def
 
% PDF color state
 
/cs { /pdfFillXform exch def dup /pdfFillCS exch def
 
      setcolorspace } def
 
/CS { /pdfStrokeXform exch def dup /pdfStrokeCS exch def
 
      setcolorspace } def
 
/sc { pdfLastFill not { pdfFillCS setcolorspace } if
 
      dup /pdfFill exch def aload pop pdfFillXform setcolor
 
     /pdfLastFill true def /pdfLastStroke false def } def
 
/SC { pdfLastStroke not { pdfStrokeCS setcolorspace } if
 
      dup /pdfStroke exch def aload pop pdfStrokeXform setcolor
 
     /pdfLastStroke true def /pdfLastFill false def } def
 
/op { /pdfFillOP exch def
 
      pdfLastFill { pdfFillOP setoverprint } if } def
 
/OP { /pdfStrokeOP exch def
 
      pdfLastStroke { pdfStrokeOP setoverprint } if } def
 
/fCol {
 
  pdfLastFill not {
 
    pdfFillCS setcolorspace
 
    pdfFill aload pop pdfFillXform setcolor
 
    pdfFillOP setoverprint
 
    /pdfLastFill true def /pdfLastStroke false def
 
  } if
 
} def
 
/sCol {
 
  pdfLastStroke not {
 
    pdfStrokeCS setcolorspace
 
    pdfStroke aload pop pdfStrokeXform setcolor
 
    pdfStrokeOP setoverprint
 
    /pdfLastStroke true def /pdfLastFill false def
 
  } if
 
} def
 
% build a font
 
/pdfMakeFont {
 
  4 3 roll findfont
 
  4 2 roll matrix scale makefont
 
  dup length dict begin
 
    { 1 index /FID ne { def } { pop pop } ifelse } forall
 
    /Encoding exch def
 
    currentdict
 
  end
 
  definefont pop
 
} def
 
/pdfMakeFont16 {
 
  exch findfont
 
  dup length dict begin
 
    { 1 index /FID ne { def } { pop pop } ifelse } forall
 
    /WMode exch def
 
    currentdict
 
  end
 
  definefont pop
 
} def
 
% graphics state operators
 
/q { gsave pdfDictSize dict begin } def
 
/Q {
 
  end grestore
 
  /pdfLastFill where {
 
    pop
 
    pdfLastFill {
 
      pdfFillOP setoverprint
 
    } {
 
      pdfStrokeOP setoverprint
 
    } ifelse
 
  } if
 
} def
 
/cm { concat } def
 
/d { setdash } def
 
/i { setflat } def
 
/j { setlinejoin } def
 
/J { setlinecap } def
 
/M { setmiterlimit } def
 
/w { setlinewidth } def
 
% path segment operators
 
/m { moveto } def
 
/l { lineto } def
 
/c { curveto } def
 
/re { 4 2 roll moveto 1 index 0 rlineto 0 exch rlineto
 
      neg 0 rlineto closepath } def
 
/h { closepath } def
 
% path painting operators
 
/S { sCol stroke } def
 
/Sf { fCol stroke } def
 
/f { fCol fill } def
 
/f* { fCol eofill } def
 
% clipping operators
 
/W { clip newpath } def
 
/W* { eoclip newpath } def
 
/Ws { strokepath clip newpath } def
 
% text state operators
 
/Tc { /pdfCharSpacing exch def } def
 
/Tf { dup /pdfFontSize exch def
 
      dup pdfHorizScaling mul exch matrix scale
 
      pdfTextMat matrix concatmatrix dup 4 0 put dup 5 0 put
 
      exch findfont exch makefont setfont } def
 
/Tr { /pdfTextRender exch def } def
 
/Ts { /pdfTextRise exch def } def
 
/Tw { /pdfWordSpacing exch def } def
 
/Tz { /pdfHorizScaling exch def } def
 
% text positioning operators
 
/Td { pdfTextMat transform moveto } def
 
/Tm { /pdfTextMat exch def } def
 
% text string operators
 
/cshow where {
 
  pop
 
  /cshow2 {
 
    dup {
 
      pop pop
 
      1 string dup 0 3 index put 3 index exec
 
    } exch cshow
 
    pop pop
 
  } def
 
}{
 
  /cshow2 {
 
    currentfont /FontType get 0 eq {
 
      0 2 2 index length 1 sub {
 
        2 copy get exch 1 add 2 index exch get
 
        2 copy exch 256 mul add
 
        2 string dup 0 6 5 roll put dup 1 5 4 roll put
 
        3 index exec
 
      } for
 
    } {
 
      dup {
 
        1 string dup 0 3 index put 3 index exec
 
      } forall
 
    } ifelse
 
    pop pop
 
  } def
 
} ifelse
 
/awcp {
 
  exch {
 
    false charpath
 
    5 index 5 index rmoveto
 
    6 index eq { 7 index 7 index rmoveto } if
 
  } exch cshow2
 
  6 {pop} repeat
 
} def
 
/Tj {
 
  fCol
 
  1 index stringwidth pdfTextMat idtransform pop
 
  sub 1 index length dup 0 ne { div } { pop pop 0 } ifelse
 
  pdfWordSpacing pdfHorizScaling mul 0 pdfTextMat dtransform 32
 
  4 3 roll pdfCharSpacing pdfHorizScaling mul add 0
 
  pdfTextMat dtransform
 
  6 5 roll Tj1
 
} def
 
/Tj16 {
 
  fCol
 
  2 index stringwidth pdfTextMat idtransform pop
 
  sub exch div
 
  pdfWordSpacing pdfHorizScaling mul 0 pdfTextMat dtransform 32
 
  4 3 roll pdfCharSpacing pdfHorizScaling mul add 0
 
  pdfTextMat dtransform
 
  6 5 roll Tj1
 
} def
 
/Tj16V {
 
  fCol
 
  2 index stringwidth pdfTextMat idtransform exch pop
 
  sub exch div
 
  0 pdfWordSpacing pdfTextMat dtransform 32
 
  4 3 roll pdfCharSpacing add 0 exch
 
  pdfTextMat dtransform
 
  6 5 roll Tj1
 
} def
 
/Tj1 {
 
  0 pdfTextRise pdfTextMat dtransform rmoveto
 
  currentpoint 8 2 roll
 
  pdfTextRender 1 and 0 eq {
 
    6 copy awidthshow
 
  } if
 
  pdfTextRender 3 and dup 1 eq exch 2 eq or {
 
    7 index 7 index moveto
 
    6 copy
 
    currentfont /FontType get 3 eq { fCol } { sCol } ifelse
 
    false awcp currentpoint stroke moveto
 
  } if
 
  pdfTextRender 4 and 0 ne {
 
    8 6 roll moveto
 
    false awcp
 
    /pdfTextClipPath [ pdfTextClipPath aload pop
 
      {/moveto cvx}
 
      {/lineto cvx}
 
      {/curveto cvx}
 
      {/closepath cvx}
 
    pathforall ] def
 
    currentpoint newpath moveto
 
  } {
 
    8 {pop} repeat
 
  } ifelse
 
  0 pdfTextRise neg pdfTextMat dtransform rmoveto
 
} def
 
/TJm { pdfFontSize 0.001 mul mul neg 0
 
       pdfTextMat dtransform rmoveto } def
 
/TJmV { pdfFontSize 0.001 mul mul neg 0 exch
 
        pdfTextMat dtransform rmoveto } def
 
/Tclip { pdfTextClipPath cvx exec clip newpath
 
         /pdfTextClipPath [] def } def
 
/Tclip* { pdfTextClipPath cvx exec eoclip newpath
 
         /pdfTextClipPath [] def } def
 
% Level 2 image operators
 
/pdfImBuf 100 string def
 
/pdfIm {
 
  image
 
  { currentfile pdfImBuf readline
 
    not { pop exit } if
 
    (%-EOD-) eq { exit } if } loop
 
} def
 
/pdfImM {
 
  fCol imagemask
 
  { currentfile pdfImBuf readline
 
    not { pop exit } if
 
    (%-EOD-) eq { exit } if } loop
 
} def
 
/pr { 2 index 2 index 3 2 roll putinterval 4 add } def
 
/pdfImClip {
 
  gsave
 
  0 2 4 index length 1 sub {
 
    dup 4 index exch 2 copy
 
    get 5 index div put
 
    1 add 3 index exch 2 copy
 
    get 3 index div put
 
  } for
 
  pop pop rectclip
 
} def
 
/pdfImClipEnd { grestore } def
 
% shading operators
 
/colordelta {
 
  false 0 1 3 index length 1 sub {
 
    dup 4 index exch get 3 index 3 2 roll get sub abs 0.004 gt {
 
      pop true
 
    } if
 
  } for
 
  exch pop exch pop
 
} def
 
/funcCol { func n array astore } def
 
/funcSH {
 
  dup 0 eq {
 
    true
 
  } {
 
    dup 6 eq {
 
      false
 
    } {
 
      4 index 4 index funcCol dup
 
      6 index 4 index funcCol dup
 
      3 1 roll colordelta 3 1 roll
 
      5 index 5 index funcCol dup
 
      3 1 roll colordelta 3 1 roll
 
      6 index 8 index funcCol dup
 
      3 1 roll colordelta 3 1 roll
 
      colordelta or or or
 
    } ifelse
 
  } ifelse
 
  {
 
    1 add
 
    4 index 3 index add 0.5 mul exch 4 index 3 index add 0.5 mul exch
 
    6 index 6 index 4 index 4 index 4 index funcSH
 
    2 index 6 index 6 index 4 index 4 index funcSH
 
    6 index 2 index 4 index 6 index 4 index funcSH
 
    5 3 roll 3 2 roll funcSH pop pop
 
  } {
 
    pop 3 index 2 index add 0.5 mul 3 index  2 index add 0.5 mul
 
    funcCol sc
 
    dup 4 index exch mat transform m
 
    3 index 3 index mat transform l
 
    1 index 3 index mat transform l
 
    mat transform l pop pop h f*
 
  } ifelse
 
} def
 
/axialCol {
 
  dup 0 lt {
 
    pop t0
 
  } {
 
    dup 1 gt {
 
      pop t1
 
    } {
 
      dt mul t0 add
 
    } ifelse
 
  } ifelse
 
  func n array astore
 
} def
 
/axialSH {
 
  dup 0 eq {
 
    true
 
  } {
 
    dup 8 eq {
 
      false
 
    } {
 
      2 index axialCol 2 index axialCol colordelta
 
    } ifelse
 
  } ifelse
 
  {
 
    1 add 3 1 roll 2 copy add 0.5 mul
 
    dup 4 3 roll exch 4 index axialSH
 
    exch 3 2 roll axialSH
 
  } {
 
    pop 2 copy add 0.5 mul
 
    axialCol sc
 
    exch dup dx mul x0 add exch dy mul y0 add
 
    3 2 roll dup dx mul x0 add exch dy mul y0 add
 
    dx abs dy abs ge {
 
      2 copy yMin sub dy mul dx div add yMin m
 
      yMax sub dy mul dx div add yMax l
 
      2 copy yMax sub dy mul dx div add yMax l
 
      yMin sub dy mul dx div add yMin l
 
      h f*
 
    } {
 
      exch 2 copy xMin sub dx mul dy div add xMin exch m
 
      xMax sub dx mul dy div add xMax exch l
 
      exch 2 copy xMax sub dx mul dy div add xMax exch l
 
      xMin sub dx mul dy div add xMin exch l
 
      h f*
 
    } ifelse
 
  } ifelse
 
} def
 
/radialCol {
 
  dup t0 lt {
 
    pop t0
 
  } {
 
    dup t1 gt {
 
      pop t1
 
    } if
 
  } ifelse
 
  func n array astore
 
} def
 
/radialSH {
 
  dup 0 eq {
 
    true
 
  } {
 
    dup 8 eq {
 
      false
 
    } {
 
      2 index dt mul t0 add radialCol
 
      2 index dt mul t0 add radialCol colordelta
 
    } ifelse
 
  } ifelse
 
  {
 
    1 add 3 1 roll 2 copy add 0.5 mul
 
    dup 4 3 roll exch 4 index radialSH
 
    exch 3 2 roll radialSH
 
  } {
 
    pop 2 copy add 0.5 mul dt mul t0 add
 
    radialCol sc
 
    encl {
 
      exch dup dx mul x0 add exch dup dy mul y0 add exch dr mul r0 add
 
      0 360 arc h
 
      dup dx mul x0 add exch dup dy mul y0 add exch dr mul r0 add
 
      360 0 arcn h f
 
    } {
 
      2 copy
 
      dup dx mul x0 add exch dup dy mul y0 add exch dr mul r0 add
 
      a1 a2 arcn
 
      dup dx mul x0 add exch dup dy mul y0 add exch dr mul r0 add
 
      a2 a1 arcn h
 
      dup dx mul x0 add exch dup dy mul y0 add exch dr mul r0 add
 
      a1 a2 arc
 
      dup dx mul x0 add exch dup dy mul y0 add exch dr mul r0 add
 
      a2 a1 arc h f
 
    } ifelse
 
  } ifelse
 
} def
 
end
 
%%EndResource
 
%%EndProlog
 
%%BeginSetup
 
xpdf begin
 
%%BeginResource: font CMR7
 
%!PS-AdobeFont-1.0: CMR7 003.002
 
%%Title: CMR7
 
%Version: 003.002
 
%%CreationDate: Mon Jul 13 16:17:00 2009
 
%%Creator: David M. Jones
 
%Copyright: Copyright (c) 1997, 2009 American Mathematical Society
 
%Copyright:  (<http://www.ams.org>), with Reserved Font Name CMR7.
 
% This Font Software is licensed under the SIL Open Font License, Version 1.1.
 
% This license is in the accompanying file OFL.txt, and is also
 
% available with a FAQ at: http://scripts.sil.org/OFL.
 
%%EndComments
 
FontDirectory/CMR7 known{/CMR7 findfont dup/UniqueID known{dup
 
/UniqueID get 5000790 eq exch/FontType get 1 eq and}{pop false}ifelse
 
{save true}{false}ifelse}{false}ifelse
 
11 dict begin
 
/FontType 1 def
 
/FontMatrix [0.001 0 0 0.001 0 0 ]readonly def
 
/FontName /CMR7 def
 
/FontBBox {-27 -250 1122 750 }readonly def
 
/PaintType 0 def
 
/FontInfo 9 dict dup begin
 
/version (003.002) readonly def
 
/Notice (Copyright \050c\051 1997, 2009 American Mathematical Society \050<http://www.ams.org>\051, with Reserved Font Name CMR7.) readonly def
 
/FullName (CMR7) readonly def
 
/FamilyName (Computer Modern) readonly def
 
/Weight (Medium) readonly def
 
/ItalicAngle 0 def
 
/isFixedPitch false def
 
/UnderlinePosition -100 def
 
/UnderlineThickness 50 def
 
end readonly def
 
/Encoding 256 array
 
0 1 255 { 1 index exch /.notdef put} for
 
dup 48 /zero put
 
readonly def
 
currentdict end
 
currentfile eexec
 
892db0c466661f5ace3182477f6cfe03c4ecb7c3bcd69df2fb2a2a41c6311ada
 
b5598c75c9526ca01f132cee8a0328dddc1c12f4591a4aadc721dde5d6ca2e75
 
3ad174cedb36653be8c04790a13510d794abdeade434a069d33c7bfbb9abf7a9
 
38439d17a4c580429ea31e28998faec722d6fe5b17cf3b4e0d2f616b0714b605
 
0e24f36269072b2a3bef76e8442347855beacd82ae8c084c6c34b92f43789072
 
f9cb6d419fa4f58c701787bd08f3cda229d693fbdb8feae19afb8d601a4a80c1
 
d2f5378fa0ba44b751da264c145ae8c52e39014e0124f20e9c141cb9393d7689
 
139420ab3d0f9c10aac4f670253eeb03dbf10fe689d5f82f32c35d17b505ab57
 
63954e8e6822e016b77dfb01e453cf7c0c82a345f95b164d03059fbd7a724674
 
fcb5d450eb6ca2478ea0972d354833129ff736a3085d113f94667ec7f6e66f7e
 
7fca2703f032d3f1e8194d17e5f9d66e21b23e0356fcde3c0edf90f14a164257
 
bd1b4f39b11d6427a1016870468588c56ad0e902282321091b05c1eafb6add8a
 
2ac5a0fa8973a1b9269ea354f8ac75b7284af4f089cd79eabc42071ac43dbf23
 
2ec7dcf728b23cc369c786eb1ebb21eed0e4f6608a6cb2eff0e722b768a3c8d7
 
bee0ba5555d73081462445a016fdc2ee770045933fdc4e22e6394067d9f93d5c
 
46b5c1c66871415fa92661d17d9264e89fbff6122906ce84fc4df08a33e529e5
 
d3b37aa940355462813b4df8659a91c12e245e49478389d50aeb61fb9a802792
 
e1e528ff2db39d9bfc6658e8350605922df51f7e186e066697aed5576249ec2c
 
a2f31ecb2b2f675e2e0575329fd585a6be8810ae22cd327351fb5bf4a87671ed
 
c78f98d2daeccef3e5c995ff1940e35c128e675e571787395f9c5142145db688
 
2d871187b2a1b47ffd2738512131e7dd5a833666e622b1e81c50bdcde060d6de
 
4e2bd9021565b8b042dfaa177a723070cca2e817400e7e678152361f6ce22de6
 
b8f86c1d6bc979d84a659d24f8c1e48279284ae8e9397f7d338e2a9dffaf691d
 
96a91c84d4439dceaff7a98fd0829a21d4adbe649ec4d11a1f141e0fc36b0fb1
 
fcad607bfe51a946c2d5b30373bdd4fb87f126b26e025678b4913c2b16d5ebc9
 
015f469ac215fd8a5fe1f8853ee1d321914e5c306955e0b2e4d8f1c102f46c5e
 
1fdb0f5b3347e085ff6639a7141bcfb1410148b25ded7444f9088daaafa729d6
 
cca65c9cd8b2d91a69df15ccc34fd0337b1a5f16ce9d204bdebc628e8dad73f8
 
71f1aa33b76dea846271d4ab3f93c5ec266428f1a802a5e4b30c93e03bd6498b
 
bafa7a3104e70868b2609baa23626e68cbeda0128e148907a3706721344ad77d
 
11b92c05c06e5bd921f042cdffb3ddac4c6c5fc6278418040b0a82cf07febb9a
 
7b5a78f9210c59b8fa80c9d027aa27d3b01e7d1507e05c7545a7b3765ee11ea5
 
8870770a84596325540ae518c794f0d2dedb932857848b25fcafb8944fb25cc4
 
0c1b332391f70aea80dccf3df5714e20ae4c3e402e871aa014ea2ebca4dbc72f
 
42b702a7520469411c6809c27b3aa5135c46bd64ec9992d43123b772b592d1df
 
c88c183652a638ea17f1875df664da29e7b27da3b0b0f4b860d2f8b3c6b7aacc
 
b7bef222b7d7518bc79c31b47d01a253f7cf938d9e6dbed05ce1856889cbf6bf
 
83355c22f7cf74db17503fe761e4fdc3efb5cc0124263923a8504d69537a4bc7
 
4929db5f404f6078ca37c61a37775cd94eb39709ff40c92553c418373986e935
 
87b7d22fe9be308012a725ba59eb2108f21cb5a87471ffe32f094838c1f786bd
 
21a551bf59ad3a43f027fe8e7a91aa4f73fef51c8b62aefb268700c2dfbd9752
 
bcf6f136acae815c0aa4147aa2ce6d0f9913894704a84b1b0a47fd2524e1eed1
 
4947a199d504bd2c61d46d0c5afb5b1bcd238d7a64fc8356ecc91b6a70c69772
 
3229c1c5b8521bc99d6c915804510c90f789b4a7184f87285286a9c65345f508
 
37b4d55f5c3907d31b5c39ada127d0d6e0fa579b6279214e8805dcee07399722
 
f4e79695d48d233a591743df859bbc4006905bbe3bcbf91b8f6668c8ac0e82b5
 
c802d16f941210cbc1f0c1397db7f3b25f57a2a8146396113c72314119a79d44
 
4f102224b38f5aef24c85bae122f51c6ca99d85d52a058b7881262e71aa8eab4
 
e3c8b1a01b84897281c85071d1df152948494b151ddf1d88649e569ecba7c834
 
34c4da34e82b13208d5da981a6f84fc53d9bb0f47135c415d37f9e1e640be21a
 
28e4ee391fd0bf786611511e34b725d53ef4729b2a7571ef334599cdeb07c7bb
 
2e4723edb20c860f754e35096fbc8574230677ad007f63917c85465a0eab7b5f
 
a5ccaa47fc3f757243456a89fd2bf15c38b208c6098606b5f14667c63a6493c0
 
c3f779c9b6cb8cadc4f9e5cbc2dd30695479959711289441817b64dec64dfece
 
b7f9ab7be1277df5a49b2c61388a968e262e6e9b992a33e71c107d6d43b29dbe
 
64b2673143a1ee8821ea1a0ac2ff59373f567b02eb3e27bcb3cded713638acaa
 
246d5d2034e38ef239e230304579df0190ade195a1233aeb9439f701ec860e1d
 
9437d3e5af6784054e2e9821e8f4db3943ffd70126abf5ee3b7626fb822c05db
 
db67e9a76ea8d385c7a16ad6e01f2e70b25717529cda6353390118b93355003d
 
0f2be7d74527448c050c96955a352bfff89f5781598e029c137def3ff7397c71
 
7747f58befcc0c130a0955702d0a82dd8c81e53e311b38aea4848570023b6b9d
 
52cc73a210b328132c8e127195a4cc06143b4ef2a1a2b29ada4e314b588ea4b2
 
768abf63c269052725b25c7cbd0a3d06c1787cb99064b7dedf6f012e77047037
 
920b970bd679c9e243afbd0eb50e59eb96de23a80c7b71affe411db0575fd1ba
 
2c6f9229536d6ebc2f7bbe0fab71788b97c628b9dacde872e2a44ebb1a4d1536
 
b416d7d5a6a9281e75923c046b41d7b57934a509f4fcddac1f792e193cd8f209
 
58f1fd30caa2d7715ec675efcae4893ecb743baed81388c6b12029a7df8f7bba
 
3394e11aabde635a7ac07925556c0aed05e39fc132abd2a13d5bb05d502d56d2
 
050d1f2016629bb93e9ff43f08ff609fd6f4064ccf273a8f563e1923233213b0
 
cec1663edc8e4e4b16f8ec9fa7ff83d644d9fbdbb27fa7cb27ed0256185af0c2
 
3e086bbf445bafcac4ad404fd75a35979b644e324f01bc2881d19e40559f1012
 
5377d2f642de4cc8d4993ad9547423eb2f823f08ed5c1dfd6f3ca282689afec6
 
8f8e2073fc23b8e31d1a9d1c69b256423e4517d65b56fb818e96945859090f2c
 
58b2eaab3af11ae7699a3d0ca8abf8ff6f6177987effbe837f9cd4f872fa5dff
 
8fbee3c1fc21102ab257adb392a5d45ad72f58ebc6dac5a1d05e5b1505ef3f09
 
ee0a50a1447c1be056e7295a4c02633259ae82e6dc25d13e125a59006d47bf10
 
075d537c45868652288e3cef3f419a639ec27293f766614f45f8bff6e1dec472
 
a786f9c928b1a5e4cf565891fb64edd012c71d4f6a17715f90c769eb2b0ecf9d
 
72b8bc8d96d6c05e29615da4b8d1ec9862cb6ca341192e86d9f443063f6b6698
 
e1e9b05b89949e598fbc2827ba676ae33978336c0f81ab6609155b95684ab66c
 
fb7c9cfef5f89e71b124eb87e9c6f5585e4cd24b5b6c50b9d3919adaf1a293a0
 
1dce3cd6be58b795aabaca161c954f7b4d6a5413795a813b9f692b28797eee92
 
13b9ea49b0b71a4f655bae6af92381a38d924c56365e0aa546a3a1e54bf707da
 
f87e3056f5e5ab271a74624156e0a2ebde7be5fa059c1a84e8f3b61508e37644
 
a8fdb2b0961453f4270a209b4c91f0894b96ab43cd53320daa39e867763883e5
 
ab645cc5eceb6ffa343f0ec9f440de32b8ffa69f6b4acbb4cbda95599b394ae9
 
6806252c1f9ac3be4b22af7336a042086ee6a9021badad13f1c65ffdaec869b5
 
ff4bec13cb811e5e7e3ed88496384dc94d015b3fc39c5f27005ee92dd2b97424
 
199b7361d032d4b5b910795a4999c65abcf491bd3d63b93af40fe96d0b33ef46
 
d44cb3ded6794f5812f8b86fae36a624c18aaa6efac4399a0f71278567680f90
 
92c37ecd9a2cb52790dfa41c23a26b83df06eeb1e51be3d80e9517a930e7e61e
 
de317a2279e5844505fe8a58635f697869eb3d9b80f8ee58455822f07deebef9
 
7400fe68d0ce6c855b133b5e89c9f06916f8aafc7cba0f7e7021fca6d3ac27ed
 
613f291dc1594c54824a991bb9cac58f35080d2b222a035e8232058acfaf0bce
 
9f43d899ca3f9a07a3d329550d97647bfa5a3f29e0ba349499186fdb0eeeec91
 
5927b513a3293e68a6322bf8969377b8215a90c0fe9bd8e99f7da58912868624
 
529896738470204f0f206e5da50f8415b06ef0811dcb2153b6773eabb15acf89
 
e0614b8a60f4a71dc4f067a698eddab43ce7c086ab09ebd4ace3064db42de3c1
 
9a2fabd7178c7988747a198d827a6a071eab4b1042c8e540e01ee3e3a9cd2cd8
 
1ee1920d00f91d5886cf57249f1cdf113b0d06497e8c68688ac2ca0d98a56ac6
 
221083221dbc4d0007e203abc9bf11c19113ca529a308dfa1c03371f7201e277
 
7c3b873ac4f63c9bea20952a0be26d920620b72478904dad90c247571a26520c
 
9f250da5d342d6d03f8dfc0081c5458805c63a2af26f7603aab12bd226586f46
 
44a39d4456450cd395a12011e62f88ac722833a08934bd304bb8bb688ecf181c
 
36a5d5d447ac8b9736f1ac66fb4093846e128bb9a17d2e31aa17c53d7550fe5c
 
d8583300efd78342cbc6b5fcca55a5ecefb18f3c64676d489afe9bafc8898134
 
9ae4619999488d53e23bfa6acfd0047192a2a6021f9da0c8c6a2c63479bafe28
 
5ae01622eec62c3d9cf1c0c918cea515b6cd49c5c76a862c6a9d55fd7bc5384e
 
0e4852697bf74cef69cf6407b3f4a90a6f8063924c7dd674953b8ce80a52cf95
 
efc7e3718d3748a967246ae89fecd74ecd3f315b50acc14585435321e7ba745f
 
d588e7074258e9d7eeaeb54439735f7acc2bf90f3d01e140d60221f1aa603a1f
 
3b28b4c345a460576ddbf54a586aa485d8e5b450768521a5988b83629e0ad749
 
f864703894889ad9ec51a2324b82f9a503fe43698ce473ce36f1e023ee5d778b
 
f371c42dd25199cfd2597f3fee8e560d9409679d9b1cb8f7deb89fefc53bacf2
 
30bf1b763f70c8800feaa7f42c25b39028417c08409b5ec208c90b314fbdbabe
 
25cf538ad3c949931a231157f6f00f43360c28969a05c762c2adc527228cacf1
 
6ffe6fd3debd622ca0992ae8f655391cdb718782ff5d7aeaba72bf6c9a10aea5
 
3bc8d69a707f6916195a71ece15e35651fc29d82081fcf35ea927fafadb340e8
 
cf9542aebf327fa09fc638e87910cbe0256b05d0d72a2fe71a7702909e09e160
 
3d0ec0d919b3e4497776b177935ea0ee1709980307c997b6ad54417cb3c537d5
 
aa22442415eb41d80c732b7f29d24c6cb2341d82bd4de9c07e6cd300cebd5a22
 
b25fd5d53464f67061bad88619c1897c9e7ed498968b62c377083c024b523034
 
ec77e0d3caed819d11d0d4ebdc4a355af4e028b756cfdd9e7912d1da265a2fc9
 
7a2cb6a8b1090de6ad26e06baf5b2bf676a09ae08295bc7483faedcd4920e339
 
bfbafb2ecf221495cbcabedec1be2424661037ebff429973d02b9f8fc51e7259
 
4dacdc4d4da92a06c1456920bad4fdc1d2142124e3c0f7c2cd31d6fc5b927014
 
1f9d3f84a397ff5c80ca8bc37f848008bbe0e3f7b7e773d9cb9fd565275a0167
 
b08b32e8ab6da742cb78ced1282073e7e2f062f7d2d0633a53f8ef6c5d7f5027
 
46bfe1b05901b537c04744fce5e279d09b84755b26fc4bc7e1f535ba6cf0b559
 
9052eed5f55edeb18601ca16f4bc2bf831a94a300328c7a3bcd2bf93badf3531
 
9368ce1b135940bb0462656e306cbd919cf1abc9cecdbdef7fa9a301729d7e47
 
01c74d2e3df5d6008bd0aeb4d6ff0604ba46fd07d74396fddbf9249c04fa714b
 
d46e37111b40ed611ffb7d6a0159c5a10159ac2bb23485ec255074dd69f9ff6d
 
ae053a79b576cc1aba2acc9a2382615c2af1286fcd33a632252e68a46b9d580f
 
c9f496caa5396548465e4cdb0d5f4203ab24acf34e358287bf74e777b329f6ec
 
766a0c077f529b43a229f8a9ee7f16500b33bf4fb7127ccba54dbf0038b02d8a
 
2cbe0ad93099c189f90d4062ff5b257093348c98852e7821455e9695550d2887
 
83fb8c87120484f4bbd0c34a1c9cf9984a0d0cf92a3b0f9089d87229703b9784
 
48bc518a93f1792bff7b38364ee73d35f11db5d15f3ca996a0c21f291b163990
 
88d1f23a893550754c65863031fd060603ee2d34428f11bb4fd2a8d9958e6413
 
93d9936d059d949ec36531f4116575ae5cdef393bb09f0e72f4b49256aa6362f
 
c56934e9acf82d032b8b326a07606723dc67552af93058bdd5e1f0e4c14abebc
 
b5e34fd9cee8b0a7d560be09206136ce7145cd952420aa6c3917b64f8a08a14a
 
184b4c78cf8ff4d5cb13e4d7745544e75ffa3ff7a959623f2cbfc217e7f7209e
 
178758ce7009144c2238087290c1579372d8254714dddb0a7735028c13510c86
 
13d6715b692ccdfa2000a0ae2d80a82b10eeeefb2af94f7e66ace714188afe60
 
cf83fd2bb51bc267a48e552f15e2dfd3f8ca6a5cd757c8bb2205b1bb4dc7e396
 
e85b07394fc2eb12290c6692a157105e90f47d549cbdaf05b1a637381a96012f
 
6ce7f0fd052a4b3df0a16a17d3e95a9f3ce98415b101d356ac94aba772756ca3
 
04d5a117d730f8cd3f26e3c78b3a97de52ff72824c77ac16e60e919a1df7c91a
 
1f9391a23ae0fc6524febe291f66ee42ed92198c35f8a525f2a5065fbc1afea4
 
090e010366b3e826b78679d627db4d6735ec1e18b3816b322c114d625b05c5cb
 
e79b51b22f4259d06035f71d22d1bf4b40c2f938e08f48f1328b0bb4072d1d4c
 
096662b789a7908b4ab80bac1ee87b560a1d6729ebd79940861d282862b154a4
 
0a3a4762af361fa753e41e3265bf2a769ae8ee124ca996657d30385d2666b08e
 
f93425c6226c7aa38bb1c6f8e4cc08ec4867326e722458422d4b6931ba73177c
 
05777b927909871fb2da53afc06a19871d6763d52f5edeec853cacf44aab09ce
 
9431b68832d0980d96803fbfefb9b04ef6940c20ff1fcba200e2c6dc020829e7
 
040eb3856f682ffcde18df69e706932461ba9ec0d27bc841a038ee942c5b9305
 
e46d7c8cd916cc55b8c1a2047b18026fb1b2c4c1b473a5b67cb6e46f14003b3d
 
aad57673fc8fd2ccd40b76f21dc17c69b656130a903ade20db3af0ffb68ab195
 
a20f49fb998d0246705a7c55c5ff1994dafc862a8d7820049fe8be08bbaafd98
 
95c4b192fd3c293f92e3fc31cde1463d4cd2031a4c4cdf48f6958604dd8f11dc
 
acd4c19412a73c2ec5ca31374d5fc015cf17b11cd383490d00e893136b6360e3
 
e2704a19cf6c593c604651a8c10d9f6c3c3771d7ea6335e315413ee6109ae729
 
9e91967cd1d1596b9eca33efa552c4e8c5df782930b03da0e70267f304de1e87
 
194e7a0520e2e073bea1dfade068220a0f9d917c9120d8ffab4ea7dac47c5ffe
 
75d2e3aac8d33c8e17d7895272a43856fedb7889c3743c6dacf31a4aa75ac55b
 
8a61c3dc617754eba1162e72d3d0f90361445f1a9c0acdc9474e88556d5e01d3
 
eb5752d2ad63b0c5e28d0f885c6d54912272a9c7d71eb7e4dfaaa10acd07e7a5
 
9ea2bd4716dbc0ba7cd3e65d4c14cbc21b8e5bceef7dd56bb00ad9ead133b890
 
f2ea39f3628dc65fb34dc9907dcec3882c868ffeb021223eb973466835841ee0
 
ab41d0ee7af1f28c43d69095f2be54738fbfc1d55928f2a901acf1640c9abc3c
 
4c86bbbb536e1b4e9deadbdac843ee08e24fb9c909ba4a0c0a5e9d519b03b172
 
beb98432bd3aeb742fcb1475b760677c647535e83f0d79bfb6bb14346ae4209b
 
f4cbc7c16337f882d33e5a43ef209edf01fae8d08feaca14d1bf20be9eeb14ec
 
33cf2810647622abd036c51689bae0d66235e5b9e5b0fff669bf74c026f3efa3
 
cf97f4114534d0e67caeda282ec1e64af4c0d9c992f199044098c01a3b4b88a6
 
d53c60d180a1d0e957ebb9eeaac3b35284926a228bb799e86fd8f04a0d1a01fe
 
50fb0142fee3cf7bac21019137962b4c34b8056c87b09d10d3f3a577c8e58c9b
 
fb54dd1bd548625ab295fd2d09f905e777dd4841816f369ec6cae888ce0fa9b0
 
5e7b70c234617bd7b4e82217ee9356d55bde0532fe7626acbaf56d89868afe1f
 
63ee787687d8f2e452c03ec06e077fcffedaaec2294b9af1447fbb2cb225ad37
 
5f
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
cleartomark
 
%%EndResource
 
/F9_0 /CMR7 1 1
 
[ /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /zero/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef]
 
pdfMakeFont
 
%%BeginResource: font CMMI10
 
%!PS-AdobeFont-1.0: CMMI10 003.002
 
%%Title: CMMI10
 
%Version: 003.002
 
%%CreationDate: Mon Jul 13 16:17:00 2009
 
%%Creator: David M. Jones
 
%Copyright: Copyright (c) 1997, 2009 American Mathematical Society
 
%Copyright:  (<http://www.ams.org>), with Reserved Font Name CMMI10.
 
% This Font Software is licensed under the SIL Open Font License, Version 1.1.
 
% This license is in the accompanying file OFL.txt, and is also
 
% available with a FAQ at: http://scripts.sil.org/OFL.
 
%%EndComments
 
FontDirectory/CMMI10 known{/CMMI10 findfont dup/UniqueID known{dup
 
/UniqueID get 5087385 eq exch/FontType get 1 eq and}{pop false}ifelse
 
{save true}{false}ifelse}{false}ifelse
 
11 dict begin
 
/FontType 1 def
 
/FontMatrix [0.001 0 0 0.001 0 0 ]readonly def
 
/FontName /CMMI10 def
 
/FontBBox {-32 -250 1048 750 }readonly def
 
/PaintType 0 def
 
/FontInfo 10 dict dup begin
 
/version (003.002) readonly def
 
/Notice (Copyright \050c\051 1997, 2009 American Mathematical Society \050<http://www.ams.org>\051, with Reserved Font Name CMMI10.) readonly def
 
/FullName (CMMI10) readonly def
 
/FamilyName (Computer Modern) readonly def
 
/Weight (Medium) readonly def
 
/ItalicAngle -14.04 def
 
/isFixedPitch false def
 
/UnderlinePosition -100 def
 
/UnderlineThickness 50 def
 
/ascent 750 def
 
end readonly def
 
/Encoding 256 array
 
0 1 255 { 1 index exch /.notdef put} for
 
dup 30 /phi put
 
dup 76 /L put
 
dup 80 /P put
 
dup 81 /Q put
 
dup 82 /R put
 
dup 193 /phi put
 
readonly def
 
currentdict end
 
currentfile eexec
 
892db0c466661f5ace3182477f6cfe03c4ecb6348a995df511820ba74300f66e
 
43387c4008e9fd81d9bc09d5e59f4e25ca6630c54002de532868dace52378761
 
960cc96173cd754ec5f51118b6058590fe367c7292644cfebb246bc306e67f90
 
3f99cfb380637250cba851aebde36dd379dc7ff4d935aa77e84e11aad67f976f
 
69d5f4f011271d1d58c362a77701e48a0f99c9234fbf7f2e5d314c68d294a2ed
 
69c87e4cb607dafdf6c0cd9ec06692fea3fecdb025c5cb9609b65e0b3c0ea934
 
3aacf9e513b8b27769f4c7d343e4ea00e1056252fd6683bae17117e046024230
 
180b883b6bbe1fe109500492fd7d60a9c077f0fe0101dd30f1da9b8f7a2287bd
 
0dd5ebbb512b290ded8588ea7c3a812eb7feb21c7456902183148fde06612740
 
a750cfbbacefa2670e84d61594b98b68e7541bc94f055881276ae3421c7c0c51
 
848b00e1d79a96d46537e0a071194db1d273b11b44a2de9d26b0ca02250acc0f
 
424c02062f643ee17ff7a2455b7ba2f63b55a95b9b2a278df1a1cec9b33d4ab5
 
fa28bec8579a86988046097c6634adcaf1669e533c8679645bfb3bca1296fb90
 
d079deccbffd2341f7111c8b29af29bab77828b8e9d8d21ccd076858b78d15a7
 
1ef6adb73a160e8961829b858228884c33bc6437eea3eb139dffcec321afce34
 
3252e3a0ea775186cd869365a196d95a18511305d6d16e9a01e7fc297bb3ed67
 
ecfd0ee906fd78900cfec4c9b94377303e4f564cc2412536af291c9850598cc0
 
265b22e3b8399a25c47312015503dcdcc5784254c3e19034c799bd9b22aaf408
 
b696cba9acbd4b1ee4c9de8319e618e9c0ed29ca3ecd0184336ad51dd06988ee
 
20ad564c72fc61dce95d173f88ab770e872b10390480218546925ae0197b8eaa
 
71e208d2ca5986463dde31ccd0516bd0d5c311f50c931e35b5f04e2863dc0783
 
846d5db4835c4d0a591d7e332e2bd16aac08e1c9db3930c5a05aeb5ea0129b43
 
9340b720879155a775b69ccf1c045521375986fa96db216e77c7ec2388f92b8f
 
05fc704f99c0697ed088acac007fce2c498ab6475b8bea8ce1dbdea5745e6eb5
 
770f4d0eef8f8d15d3c7db97eade7a17591f09919bbc6c367bd9adbafa98c84e
 
92ced4bb8552fb5a20f6e420df13480936f8e4d8e112c4665f6f5b57ec492230
 
33f3e956d9defd8f7dcd565e6506640ac2ced1a5d1951d11166380ca80c88a15
 
ce02a5dfb627a3e049e095501c9202f25ae044314f518853b49fe8a7b7c804e3
 
cccd3e81131097338cf93cfecbe47baa27ed4ae92569b7878d7c00499dc9c4ea
 
8b96fcb8288c9a0403b79e0fe5b371d8f250c69ca6d64cc30070ff0ee6c83812
 
e048761db709fafc9c2f5a415f39d0648f7ede1ae4badff86f3833c98ea2fb52
 
57a3be1c393c11d2b9dc5f031d23cdf6f46445bc5bb34f8b1f5fbfbbef334321
 
db7f7f514607d65145e2ffe984da77f955a98ab3a17affb3297bd66ff5b8a466
 
249f5354eb2cf00e8d699cc5fe35aecd2f7a2575942e0518fb3bb735b235b302
 
1ea562f83ecf6d730e65f376a3e6101512c1ada60f4dc9f7cc2fafe649d13db5
 
e372caf3efa9b32883d64edd9ffbc7a2e072bc6cfb0efdb6118f577cbb751517
 
ddc57b8a771aa1a81f1840ab0cf2c7c06df61bbabf558572725592cd3a2922b3
 
3ed65380d7a79fb1a223d3f76038e7eeeebedc725bab3e5cc9f8c3bb95c9fff4
 
886b658cee6f4299415fecebf5b904ea2bf0ad964aa66ddae50d7113557fdac3
 
311c06cd8ec863f5f7ea955d2a0fb8f7362464021d288ace7c536cb95d0df802
 
9f62778f17f24ee86fba5c55e48e6c492e92b867d853d11997a69c48045e0c41
 
c9f60efd267d983eea9a6e1fd8e09a6889427f8a86fa739db56688116729c660
 
ea3c92454efe4ba7f8bdda11e5e3d25d112e23521394272bfa4babbc8134feb0
 
ac821d11a5b975a32c3f939790b6a59ea5d18e57846f95b6c588280381dd5d99
 
69650c331428d562ed249679dffc12703c8f3ce24ceccccc22f404cc0262291d
 
2743c66910f7dbc461bb42d986616731b88f8ab92b115645ee462e25d025612a
 
536f7541023db615c314c9a5916ff8631ad4f0c790cdc0bf7c705c261694b7a0
 
ed5832f7067ab4d64f9ed4330efc8004a8806b528721aa81b88b8bb037d47ad1
 
107124e356ed94d676267a14c3097b5aa594092058e88858f13247b428e8d77d
 
08639a5765f9c0ed5d4e823196a5ce020ed4bd899887bfe014454838eb5b7da6
 
f8d8384dbc263130b6c674539279809a58503183708d15dd68ed3746e14e9ae3
 
d9c3288cd05968658e309da25d933b80d1a53e24bb4ccd068a618d9e8aa24b69
 
2a0ec1464260f278e347327bef9308d04bd11f0b660a2b47ac4d0e1ca038a939
 
518f122ca45073e73af7ea09c18c41097deb88e79f528341a888af2a47487de4
 
d9770bb51d5a34d9692db60495b0e12f46957ed8937d993bf58cff1c95854426
 
9c3f15fe61aa8accf3f7afa4fc53c002c31ee191612fcf0da09d60b9f3f5759d
 
f150f31724cc253c73bdfa2e24f242e1a3ae59f42bd715bfbf55d4e244375f37
 
2832c4e7851f60ef0c029d46c7a129f4af36315b7bb518886f370838614ce18c
 
ebb90bc0df6d14680b1c794f760f91c1c8a5d2f0b9b916e905df5406457409d6
 
25e0e31a754c2b0f9eca11bc095c61463c8994b51b7733f767a3c9effb277356
 
23f49e5c40eb0b3512a877a4e93718e524f487f18aa7fae8ed80c6a28345bb7a
 
d8ee34d62beba5f555d9c6ea27837205a0c1e8b8c325fef1da5c081048c38909
 
3693b2020756e276b2191646afd354bc468b5b4b0e19970e9a601291fdf8b391
 
15e7cf667e2ee44dbd5caaceb45a6df40f4e0b7aca989db89f3838b63cd6582a
 
ee3019802c4fa81f12790b1caff369367710d09a1888c66e16697fbfc2f0326f
 
296325cec8893325fb8fb601cc4bac3c7793fae746b97a8c6bba8f5f8095ac08
 
1d5b0bfeb8cf76f7542c6693747de8dae6ea875cf91f34ab04264aef950222b5
 
3db11118272d47b57d8fca22e988f146ad6518aab00aaf1e2e24a10943560239
 
cbda524fe8c7e7cf0145254a2752ebc9e77dd585bb0ca96cc68e09803af24e59
 
0637b74c4f7af229849e240ba2ad127c68ca295b85fd2f09664d98a80f59d033
 
6a2e4d681ec957bf974a838e08fffe6fa156a81caff5157c45fb09a054b6cc78
 
39838f61f5bd9feb80ce469d48c0ef5574cc6a06429fbeacea38ede47c622853
 
1430fc265e8b8648e781e869a10f05668c8b31df1055b7d617efd32474977b5c
 
6801705c770e014ade17bf1122778139841af59eecd9f18944ff889621ab42e6
 
a4961e561981c4b266422659d5faf7d65332f1638d44d78be9c61d1259d1bbd0
 
8871901e2396d9a210a2640a388baf71f42e168dedb02caa4f0af4433ad57401
 
5bba1b9871c6cf5c40b6a0553fd1ad42564cb3299d7e7f6c64758760ab09a1f7
 
b4a1c6050490ed1c5e37ab61e6933df7ef7bd4811177620a886c6bc040c838d1
 
e8820390d7cb1290c7de3d22616113856c72cbd2839bb1b27100d0ae3d5bdfef
 
da95dd47db33a64c4d9721030f968ff6b6f9b9007561cdc8643d4d7bf82d95d0
 
866126f8ba941213ed7ca2445f0fe45d2ddde5501a1eb57d5bffe4885df55ea6
 
1096edffa1fbd623657ccaa43e666743ef60a4db27f3887a56b86542ddf487da
 
4edeb18e3b908150ba0f4af3c4ba33a06d11de7f33af7e0bea6f03eeedd925aa
 
d917d1c3e71fa2356a225610b722c3b1ddbc4eecab2879eec165af9b10e692f4
 
2521cda6c4b57430348a47bf669315790a6bd16ad0a3496e831971124a763608
 
6070954f3593eae4a879b4ff308f00c63fdc091e1ca9f3d0b7a87bb06dae2afa
 
f11eac39f98c2ef557cc7e98c05abe169b41811027229df43225ed1c11adb91a
 
5a5c5e61afac57ac67e4eb39bf86c0928bf50101c29fe62103efd6863508b1bf
 
ca58a7f3bbeeba64c929c57aaa0a87d4dd8461662982506f49a304bf60f48338
 
50a16aa6d6076f76d3928e01feb5127f39b4926f39d1a13a7dcfee610a33e581
 
6bb40cc3766161b25c4a4f044b01291f709b8590011a3a827266e32a293fb118
 
64deb1fb2766956cc15c642b589578414d9f01f259c35f3817e11c85505bfeec
 
0f2410ff1e283877ef378c06baa3856a48c4a1e0e56eaae6f00ca5be4f5ff8c0
 
841a5bd882541bfea2f85bf249bf4527d27e63dd171227b7d835327c210dba81
 
2a0ffdaae0636d609b2c1a73aeccdb901af190c86b07021a098fa58ed5772b2c
 
ff1a56e7cae8f6b43a589dd566cdca3cedac4ccda46302ac86308cfe0cda85bd
 
96b8dda8366adb7e72f11396dc4485a9a38cff605bfab63e635482ba45c30c80
 
91a67c4fca609a3732760f808fc8f8eade6f22c36a2d6a3ce764fb5be9ae7099
 
9486b624740cf5fe3ac175e54d57d5d974b32564619ecedcb98d50654d17557a
 
d545787f16d47e880a1f90fb18a66310ecbce1e596dfcdee91c3a6b44023f3be
 
3cdcb9b8c720e3bb7b8f4fe62a649b2af427324046aac3253f7401a2fbc1aa2c
 
a5cfcbcccdece29a1f9851551d497390f671979277fbb619b7f872c9fad986ce
 
063307edfcd7451ee3bc6d1e7e4253cca3b1852c6fdd0d048dcefecff5c57f3a
 
3bf66b48015a85cb76e3214e090d7e660d1f913880626f3a40f3446f76c4fbb6
 
5ba89b24a6ad8e30dde13ac962df66dd6eb13edc580be2013f73779efc940a8c
 
f0fdebc75ec1980dcc6bf8ce15b3c02764fd33bddab9a77074b08d0d662cb70a
 
992dd2afb485c52b08a5f19d94fdf2f1428a25ecc3f26ca0d9433d04fb7ba11e
 
95bd626a458b0e3194d73d9ee7bba982550e0ab5e1c39dda0a64dde566eef06d
 
41f3aa36a129f1433e3d349a7cb1b9ff52ed6548ba698c5cf8725704ab17c112
 
47a6bd9932db12b67c33850f9cefebc1fb21de63ae4fc30a4db3717badcbeaf7
 
49175655c09363f1a2ae8f05d06528d930d84404de897970b513f0f62a2ccbb7
 
142f091d3a33ca2532ce955e4a877f1c2d7e7ec45682120570816076ebab862e
 
2335ed23c597e81b1147818f73a786f49d0d428803fd4a149b58765e34383f87
 
da5050d643504ee00ed49a4923791b3ab1bcf9b603154be1fb06fd98338a3118
 
12c34586177655ed4138ee8871a92fa128e82a639d668f02d906784babecc0ad
 
384b43eabaf95aeb5cbef759f890c1ca570f6b3dce669a3ee00b833c51705786
 
53c958e12ddbd2db60d2a9347140568303293ae87ac124cec90fa6ff17f161bd
 
5ac03af7115e1cc94795361150b1155eb5cf9ca8e9693d0d8539aa82437e634e
 
c3745a1ddb2e57a5dc8c85eeeea27fd538d474d60eb855613ed99831b0487553
 
5c9293305e347ec32b18b4a2117d25b116180eb1ef2a1c114644bd5dd25f1c0d
 
c019be096655c828e0466bd21a1b3f254f320dd92747bc86a754116289cafcdf
 
60224f37180d720f8586acb44bd43ab228fa45bfea3c1012033689ef856a7cc1
 
8dd29fef20b7ea863d804d74ec78bad8672fd84653fbf7a651b49e5d0bc2d796
 
9b54c9ee8536ec92d93a29d9b4d3be88dbe733db80953c3050c9bca71a521679
 
6a4e87b89f13402d1066f11aef918e981e7f934f2e9acfd16c2a17b84412ea49
 
a9f22a6c249ce7a650333ac6dd0e6965ff9f260e9e1f0e13363bc8fcfaa8b3dc
 
1f193dba1b86aa97d0f6b97abc3818b25eea68835035fd5d4cae23d676e9bf03
 
e2c580eb7d6ba2e6e1569de262c73dce73673afae24f1aa34deccef4cefa8cdf
 
7c77cc42db5d6051f13df0f9e70777cc08d7bdc2e00e94c7063697c70906218a
 
6a8b9120744511e0f95e4332bc01507b099bc13ca9c961fb8a5312eea8c380ce
 
39c1a73f9e7e131fef73d725811ba8e68ba72e96a11026f23ede94ab702a6479
 
3c4fa63a79272cd2514d0d3c729b7d56e59cd006dde91b73ac5080d244bb511c
 
fdca2e4b840e5e5babc093cbe4dff95b789154879b6f67b56d019efef615f071
 
20c3cfaf05512fc06856bf3d2d2d6c0d5c8c7da135bb0b5b7595339e222d059f
 
e964f842e183f98887ae870764e8417f32824e93f393c4706ccc263379753b92
 
40b1d01d4e9327d05cab07aa1654370d54b284ea3c0d4125701b6fbc50d4b3b5
 
9359247ca4a6110268c788f90ef16dcd2eb2dc2e05f76ac0721e2308c2444ef2
 
18cc3784bf88726b66e61391ed2e98d54a87ddf38740a98d0eb0cb9deb320e60
 
3e5e03c076f8fcdf63bbc6514f64927254dd683a1d8753688f7c8510e26fbac6
 
73a39e599862959af9c3dcd1b8256578649570d82a2bb728457b44ee949fe8f7
 
a1fce6e6d8fb2b0d665e8775f395e573086d934f3ff14d4746094d547d0bb1f1
 
b1835382ba0c94eb0321aa1b8eaee7bf3a81ce164323bc55edaa75aa03136a8f
 
f6cb298483faabd754209bf76b4326e75c752614eded216dc482edcf737672cc
 
b5d90b5e477b48cfe3f032c6b4e7b3caff7e015bac45c273cffc2e44ebafd670
 
c9787cd5d014b7d67c078710c212e5d69cee0b3311a1738a117e51fcd056b43c
 
b7e0ab46555e207de3757c907f89fa6dcc773237f3f0a5c319cb559dac692cd3
 
304c6a4991005d5a8e6900234e7f611a6d857bcddf5bea8892bc307b106bc373
 
3717d3a85b11518b05c03d6d13345b09e74f5cc484b8dec2fcee45de1dcd080f
 
6236544f6171c688c6bf49c85ca69a835c14ea95b72d611d399a79c926703d81
 
7dd1de3fa1e8481f82fea5c6a43ae2865127419112decb44baec3d47baa145c7
 
17588d98d373073c34ec1d9f5adf004ad8b3421a61e64eb1ee2273f75ba77069
 
1afef3e7f81b0088dc51d168cba7dca50b0a2c6ed2f7972f96666045fbf78965
 
6ac71eeaea52a615aeaf901bbd34c402d349163676c779c5e37a993a60f93ab9
 
6f1143daf20335650154b7098429168e69d626c03af3491cb0df11c2e50354bc
 
df9dc0a6643e3cdfbb90376c0588ca7c3caa39985b10c1cd5329f5ce7099c009
 
783e1653c1d530f4cdde183ebba135434ad2e1822c1f3a6c2090b6e2e34bfc9a
 
08ab5d3db00c86d78bd83172d74c8088a1d400ec66d60deb04178eb83debfaf4
 
363f1312248cc0f5bac59789813bba9b56b0c1e13f647c49acad383f5f64cf07
 
49b097db74d2e6aa3e0a684b54702fac1a7fce4ae4361dab4455363370038988
 
22d567419499711cdc90abeeefe9e7b4b56e48d7ec1397726e8c00b035ebd6ba
 
448b6e605279babd8438055bbbdccd8aa582da2f4d499c3ed2529e33e041986d
 
a2f22db3c819a497881175a07edcec1a2870fcba526e2189bd6b3dd5e8c41da0
 
f6542918a2c12f9ca9d9b1e750e0711de9c538d203aa796ed6eba8bcf0369583
 
f92a4e0124976c4596bdfc1d145234edbbe10d7de3f39806f0cafc824a4a5217
 
d259453db2e8dbc500e711c569ccc4f4443b5705b2c0238d6e50789e301ea397
 
4a0a47d5ee89a06f610d43f14651686f38b7365717fd15e868d4f07e02d4b4eb
 
f1fe01afc9784838629f6c08c0fc1260879f9a6f3eafde976770fe1717247979
 
1d9fb1553a9903e4358f82cc93bd7b49d4ef6ba2b248a50adbd4fa603dae3c1c
 
636cd5fc1f6a5ef39c076a319349bbf4a60f1b1fb72634bc46947b44bcfd98d8
 
26911f90254c0d32bf52ab7cd3d8d67b93cc419bc49c59e287f2e1d93554b6e3
 
1b8b52fed1e4847b965c5319bced5d8737d80d321eb51499c1a0451dd6928795
 
9e919f3b0fa521a5c461557bcb43d830af036fd38a8e6d411107e492eb4e4909
 
2918151075966d6180461c27d839ed76b361f465dddac8b14ce2cf779dfb644b
 
8332ef8e06eec02477f01b2f7b2f987e8a380b14e4b5b26eaf84c0e219a489cc
 
b5be1e2e3501b83606704433227a1962d035e6ac70e1b1b575cf6f593b2792e3
 
423d99231d47b3729f7f9f83158d7b839cc44aade6df41d996c8a445db8ba22b
 
1e79d2e7ff19091c9b89611f167866197b1138e7ad8930e3bd20f32fb0607c3c
 
f3cc955e17f0223e05c740b6363057ed88c13ea0699ec208155132fb97e57153
 
ebccb45cc938a1532bde68cd33668c976deeab4c2a7e60e5608b5a7f8fd593d5
 
fd7d19b3c4b93cf52bf89a725b024c5d6cc10eaa641c8c8cdd9cb265064e0349
 
0d5ed0b5ba6b36e3843ea5346d743ea7fffd0a40fe9f99705e6eee55baebb9bf
 
7f6857874fc5df04321822cc2f2658477764659d5802c55a5a734cea6c456e76
 
a99ece7ffe4ba3315a78bbf05bcd8f8fddcc2b6697de59ec49dea15950e45cb5
 
37d7fdefa7ae6e5e571186f06074af8d25aa0e08ac5a11b12a4b45ddab801cf1
 
6226ffaa2b0f08744791794d3fd5fe09dace13db9e94b02fd829cd381d11a7a1
 
50fc7a4856db7836d1d582ade4ef17cf63d62496ae1545b6d96d3299965248ef
 
b08ce9bb8a9da1b85d77f68cbf97dd3b5adfa5c4f8ac373baa559f5512a10af0
 
b3b300ff6704dd8992280ccd64deac68e4a398c2014ae5c8a2ed35cb182b0633
 
d6d71091b8721e5cc9331a1edc1aca3c6d20b2f017088560e36014df8b842ce1
 
580887ecd837e39accea78d50330ae25ecfede46d005458c620bdf93d5feea33
 
1c4201a4d011d156b59f28ceb25900e4de64f2b0cc6487148458b2b21053cd0f
 
50b60be5684587f650ba16ae1393b6d7257ff740dd8e518a1602a69e5613a5d6
 
3de5471231c67a4bde169012316e418e9e13c02d6ee1c6b480835e02ead9651a
 
81b7bbaa31913cb62a32b5c444a8f260a9ff3130aa4142ce5cc32b64cc951a1c
 
6bcd85befd1c58dd86195889fc229a74a419d831701b6a4cf07ed6802aadc9d1
 
ef2dfe08d574baf590749e03d94e9f5ffa823b643bf4e5b46dec42daced4062e
 
8260480c1e6d7e4033ea4bbf885660941b8eb953e5f2c0acebc736730ed37800
 
7f2158b26396a7c21042f550dde97179ae6e2f430a418714e30f0fdb533dcca2
 
779f209f34a9b75c4a989c72403d936ed6db358cb4786b73e886244b3f8c64d4
 
4084899be0f41d336845db73ef6783b8d06b0a5a5760c224c25cf8564f313512
 
9cb2bf152295f0f24e61c9f0a35fbfa55bf2feb6178491145858f09cb156083d
 
479289e6f48d9a2e6a19d9dd1f022f3ca32ea1be46896ef84e19276f6aaff991
 
e41d594239d9b4424d4a574cce6ed531f62e06883f6b60ce8db2d274108f3bb6
 
06e865999ebbf2e3afc4707267082f877215258bda3b7111715a2fe2ac26c351
 
de99e76ced01f1d745283d5ac4185d00b0fc1585f83ce55bb6df3bd69f4bd5ff
 
7f326adad552b1700d169ce15881feac11748f9b23f38bc4d842f3f12c67a839
 
60907fe6bd6d3c697c6ab3025416ab43ded64079e096f2a81dbeb8c97463e0cf
 
785d894fee962f6139f50eda7e30ba41f7ae51e3eae8a6a7fff1fa3a8b92c6ca
 
7ac719d5247bf538e96fff040402f73303a15e316cb60ee6ac54f41091659202
 
306f95b23a03aef4c7648f087b47063e95bc81179a12dfb3a73608fb4e7ed9ea
 
051e11322ec9bcf9240e0779b0027eac790e7e043f0800eaf3057d8aabc5a8dd
 
2ab0190bc3a53272f92442f1cad92cb1f8dde69a2f171d6895916710f48ebd17
 
2b5a37751894b10a48a0a9c4dcef8eee1c3bbeedf5eba6d1aee3e56fc153903e
 
e7b662c3fb561ca6a853ea82ae903d4e376d1d9a185eb55672bb835ee3d0bb8d
 
ac626ea696745d01e964ece2f474e1706fbdc3d05095f8b5caa899afb8d88996
 
68ec4829385f02abdea78a91f34f886b0469ded5ac775e1eb1432225c5288ea5
 
dacb32b300d14abc079acb6b07622604a5fb49d1383bc8a584ba9125f4ff5dda
 
a02a9d919202fbb8953e067e7fbaf2ec401bacf3aa703f7c0aba
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
cleartomark
 
%%EndResource
 
/F3_0 /CMMI10 1 1
 
[ /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/phi/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/L/.notdef/.notdef/.notdef
 
  /P/Q/R/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/phi/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef]
 
pdfMakeFont
 
%%BeginResource: font CMR10
 
%!PS-AdobeFont-1.0: CMR10 003.002
 
%%Title: CMR10
 
%Version: 003.002
 
%%CreationDate: Mon Jul 13 16:17:00 2009
 
%%Creator: David M. Jones
 
%Copyright: Copyright (c) 1997, 2009 American Mathematical Society
 
%Copyright:  (<http://www.ams.org>), with Reserved Font Name CMR10.
 
% This Font Software is licensed under the SIL Open Font License, Version 1.1.
 
% This license is in the accompanying file OFL.txt, and is also
 
% available with a FAQ at: http://scripts.sil.org/OFL.
 
%%EndComments
 
FontDirectory/CMR10 known{/CMR10 findfont dup/UniqueID known{dup
 
/UniqueID get 5000793 eq exch/FontType get 1 eq and}{pop false}ifelse
 
{save true}{false}ifelse}{false}ifelse
 
11 dict begin
 
/FontType 1 def
 
/FontMatrix [0.001 0 0 0.001 0 0 ]readonly def
 
/FontName /CMR10 def
 
/FontBBox {-40 -250 1009 750 }readonly def
 
/PaintType 0 def
 
/FontInfo 9 dict dup begin
 
/version (003.002) readonly def
 
/Notice (Copyright \050c\051 1997, 2009 American Mathematical Society \050<http://www.ams.org>\051, with Reserved Font Name CMR10.) readonly def
 
/FullName (CMR10) readonly def
 
/FamilyName (Computer Modern) readonly def
 
/Weight (Medium) readonly def
 
/ItalicAngle 0 def
 
/isFixedPitch false def
 
/UnderlinePosition -100 def
 
/UnderlineThickness 50 def
 
end readonly def
 
/Encoding 256 array
 
0 1 255 { 1 index exch /.notdef put} for
 
dup 48 /zero put
 
dup 61 /equal put
 
readonly def
 
currentdict end
 
currentfile eexec
 
892db0c466661f5ace3182477f6cfe03c4ecb7c3bcd69df2fb2a2a41c6311ada
 
b5598c75c9526ca01f132cee8a0328dddc1c12f4591a4aadc721dde5d6ca2e75
 
3ad174cedb36653be8c04790a13510d794abdeade434a069d33c7bfbb9abf7a9
 
38439d17a4c580429ea31e28998faec722d6fe5b17cf3b4e0d2f616b0714b605
 
0e24f36269072b2a3bef76e8442347855beacd82ae8c084c6c34b92f43789072
 
f9cb6d419fa4f58c701787bd08f3cda229d693fbdb8feae19afb8d601a4a80c1
 
d2f5378fa0ba44b751da264c145ae8c52e39014e0124f20c3fc2d9ef2eb0aa47
 
b8c3c51c19cbefa3b4ef9c3292802dce33af530f7af78dc334144a08f40699f1
 
a064b89ae7d1ee4ce3f5cfe66e3763d146d77740354ebc3fdd4ac5bb0b70d8f7
 
a3287b912b71f699ff55ecef824f947569e66740aacd3fa6092f722e0d42a5c7
 
8be68b0ff1ffa1b2fd8c8136b7488f0e3ecb3da8e60c094d0455611beebd3e1d
 
6198f99a5ea66044781a69831b03574a995789244d80f200fd3e297089a2afd2
 
8ef237c824a0c80f4d77ad6e3b4035b4d31babff14a30be0fbb964c39cdbbf0c
 
c00627357bc1c6cb29e361cf3ecccc799f08d5cab34a52641ed598a3196eb162
 
b173e4c06e415374e0381c213cd5f2743a3a33cce1e039ad54f9ec5ed3fd013b
 
df71654242d7e121f936ab2ea5b307f1b4b8320524a48130df5b9cd50a78694c
 
359a289ede8b2aa10c14ec16df869562e333898a426e81dd69b445634f31c9b3
 
8f4650571c9cb199cdc1ed024c75df42dd68d201ff1e87a269bdaa6045f64191
 
80b13360fdf834853789a9fdf284dd68945a0c2bea8f34d2b26040c20848e955
 
7f1a99ec7c104cae79aee80cae44120d40fa1bfe2aef9de150909da5dd8c3099
 
1adc198c3a606701a35382d7abdd951f0bb812f9c5e995fe79bed9eec021b30b
 
27b2a1b275fb4a1720ba2eef00f4bf831baa85d6ef3b9a61554ccd8d760ad238
 
82ccf2bf7edebbebd891dd78f15a88cdaf69039805048d6cacfdd6b82e9a3878
 
861794633899b37fed494b77b56bedc4636b3b3b5930745fbe53519de3f62022
 
245bdde77c935cd9234c45b33dc755b4984875d6d8da1b92f1d4ad64e8c6097b
 
15ffb5d2940b25b87cf43aff2063373a2414752b91382be499f174daeb459386
 
4c0006045849e305c0c5d2e1f2915b362a3d2c424f5014f223e45e0f6472479d
 
f0c094ffe5f1dcc137b81749ee49a7090d25ca9af38f56f048b988758d5e2b78
 
05b903fb684c0954fdce4ac753bcb53e46cfce35435a31a5744b1017e7123e9d
 
0aaafb0be4f469d84c4797a434ac9c1f1596741bcba12607f7e65c43339f06fc
 
42ad1b381ea066c3778838d79f8cf42ba5ab31796b84db5e6a5f1eb43873a492
 
ca91af1d2a83635013d9cc06e293f0cbf0d9b95b65d0757f8f512649eb236528
 
403c2ce5bcb1c5b5f919d0c9222f89eb165ca40095ca242f39df3d23c9fa5974
 
38a777383e375a9b7a08a5ada42b1c19f35c03afe7a91123544d07c183713d6f
 
19e59090437051ef70f30e518da273bb2f70a78351ad3a5a5c1b1ef22c2ae5ec
 
1da8d62757ec33024147e4917bdbbdde95247e9bece88c2d8e6071ad627bdc98
 
d8d1f4726c0a75282e6e4efec5b82179dd996cb6df4834eb288b162c1c696972
 
5da5e6aad09ea106b99ec14cb9cf9f848b84729db61c540655e0289008a59009
 
41dfb1e8b38b2e1cd41c837e2f4a7c7b75fe5de5cdd455059eb4fa4f02aa9e0b
 
cb98b9f09bdb79967e2746c2faec00550dfa2a8fa312bd9a7b83b120478dfcf8
 
cce877d9a0b2dd31cf2627ddcdcfcb8f11bad2d9047a216f0c2c61ae6c7baa46
 
9fd331d0de5c87dcf8d7b5e9c7b60e33af626437eb61426640589f420dd83e3e
 
ec7eead04ba24090549b4bff3253edbb2d2d66f92df24a26dddbd0bdccc09c4d
 
73d883c7abcc9a56ec9f882fdd2279ae6d52d0b420e2af225544f935343bffc7
 
879ebb3836c5261b4a3bcaff7365decf138e5a05f3a2b4880a2460735f614bab
 
c85170d5e7a0f21e133f87ba867582356a8c9427a0c7999e5b79b68946f3e7e7
 
de0aea2b3a34564a4165563b35f15b5b40bb17d9888353cae6451e74a0e9f0f4
 
29a1fbd27ebe78e05df71d4d8c284b77fa6c805cf4bc0109e14eb46dcd3d7f59
 
a41f1286e80598ce7be6883c0236aa1d8391939e5c819a15451cb15e92781230
 
525c444595a95b3bed5ad7db8f0d337457e9dd72c89e762307487d51bf186c02
 
656686dfa191c56f1a566ee60442a30112a4cda34b867013908e49bbaa888385
 
e1b008609c5be1a7835e8621445de5798fa09529f0126d0b68001aa8aafc77dc
 
c96281f1db1e51342ef1f40e8eee3b4e90e994f62428e8db2e32bf0ef1e25660
 
5ada02fe98972fc8b270e3c78c951c5420c77b6ecebbc0e2bd0e548ec49b2ab1
 
3ae068cadeeba2767d9d357601ed173340821950ee4a9935e851aa82688f276f
 
cace1d8f88c5baf64e32246d2006b7480efc42a0010d7f5bfa8aa6676407f9b5
 
eb401eedbd7233bd72bfa6dafcdd9396f0c69b58eb906e08bf831cfde222f4de
 
f8a9f071d80916911bc17c5641cbe6409ae19ff2d12ecf8f4d33a09127102177
 
192ebc7332c247ee17627fde3da101a803cf4f20897c090e2da981ce7d7e4905
 
b5ef69619659df5be75ad0a530fbb63fa00541b651fa3c090ddbb491c23344c9
 
7cd427c4464429c29c435fc31de5a8bcadd786ca90661ecfc56a825bf9e45c08
 
466dd58d66123977b9860fcb222ac454d6aa26f1a7e0da5ccb8cdd5416a84c5a
 
eae8ea18fd455973f559f5c7c1e22e8e617ee022b5a3f38b49832fc13438b270
 
2890d892fb937768883832f6e8dc1d0b533ddbb449ed955bb94841ed3262a8bf
 
b2f3300d30f81e24d2502ddf62680e3bba6d9325dbe79e55c669e98c843d6afb
 
68c8269f07d2a482676711858cbc3d9adf0f42ad8ed78c197af0b8f6e662a202
 
6598a4a6d247a341ff4ff9b45e8d138a39f8b87eea0513ccf78ea9c3c41e55bc
 
f73f1993603a21c0aa73c40485835ea796068a9f89bba20af10d1a9ef250c0b1
 
607b2eba79d252ec70746a5d0cc22649d3ba538e87f115ed02b447ce7ffaba0b
 
033195a0eedd4e63898cd1415d149de1515b27b0dfc1c63608616cca2d750afa
 
cd22f4b5c7dff2e1087042393cf2d95aaccca1619bb83c84439ed1f21b77b7cd
 
b35c54f1a173e1ac178db7f0b710aabc3bbb7a37e1364de0b6c7c4d42e5757e8
 
f1da58a4c466b6a5f3fb7feb992df7626b3ce2ba13e5b67b850159437f9f846a
 
7f37fce5ecc62d22e267e56b353bbcd4c016b54f9f514e6406f3f91fdb62490a
 
7fd0780e19ccdc42cd72da3cae55dac7d25e2e86cf508c4ab11104e575e13c39
 
065b0099d272f961ed94edc5252353e12b0c7f7e1194d068a51b1481a2f72ec3
 
32832b4747c54e1085e823f114bead2e99ffd0e98507dbd25bd099337647dd6e
 
c10a45fd99f0ec2edde031cc1304b70015eb79ea541e73c11dfbe8e47689d679
 
443caf6c176b26002824d42fad1cee52e375613c074008f75ac832f3f381de1a
 
500a4572e12690fd8536d9ab1cc14b9acda253b369ae72da91706421b767215a
 
f66debf629aeeacec8b498d28b295d1cdd6efb4aed2e16fd9761c181c223254b
 
faf6088f01a106a3429acb0c3b27066823029804ef168c21c7acbb3a5ef00bad
 
d8ba86da6a62c18349925b7670048759e0511e52d278cead8364f2005be9cc32
 
5aa0b0321aea539672c28649aa59206fc647f298d0bb2a2a7f571c33e3e14f4a
 
b1b946c9ee78ed13b3a925380dc1746334181edc37ec98a9eaf2979bfee8d991
 
7b179fb09bc73335644c0570d2bfe5c1df8b6d78b942626405c683b51094c775
 
373700f97778a5ec1934dadcb59ac8eb6825be65c153c41bb268da25e532b117
 
1d137e47e2f2e58839137e673f5f3fdaeb42e7b44c4d3dac67b719914f1b3b74
 
81fbd801167a918c55432f2da4f32bc6e36442c33b7b5a5968c70705526d2ef9
 
9d1434f5b5b2197e3caa9b8a673cb2148064570e76953c07cadc1ad7b92351b9
 
8cf42019b36ea04f1916c241e7fbce880220a017fe3b2bbb9c8535c404749f58
 
9779a49dc2154f14754b5063dba93860b8b6c48438b265a8e96b108494494c82
 
7bedcdefecb6a7f80b993236162c302f4f091393a488a9263d96c9adc56f98ff
 
e4d382c5e9ea7d7a627a496fd01130e2863ead633ccd3b7178b91b756238e1b6
 
7a84a6217ab30cf3947b9a9c1dbbb031ab2d6854c1f915d802d89edc6df7328d
 
7f2031dfa34e386f153104fc09ace364269c77225e97c5d5bfe9581f8a2235df
 
73d4f2edd97a9afa10605ec4ffcd59743901aa19d864e58d666e0225e9c25315
 
1b8fe284877c8f6718ea7a789fcd060410bf224e3b01f6b09ab804d73a8c2e22
 
5b783a6ad1780cb3d5d3a5af20ded97d6eb3b497490eaf435a4b3c9f7f69cc18
 
494724f9b2913613dd2a822767dbaee07d8cae06c7b3bb5d21c64d3b48db43f6
 
32db3b534003100430e4219e1959b282096b99880560ec1b50d01c7434e3328f
 
b134f90d0282d5d4adb4ea40ad7c0d30af6b2346e4f6d9470bd2ef85864eac72
 
48091607c6bc37cd54fabeb66540b73b477e58552e957fa2f44e03bbd5694a19
 
f389cb4f5507414cf2e2a1f38f73634c40e80c34dab2959d0906b10145ad373f
 
e482a5aa2b4af96021563bbcae25c9b1daa6b34d9b850191c3b672a9576e32c2
 
373e20ec27953c404da84e413650b407608ef4d83cacc63558244d0c058244f8
 
8c44731b9ab1c99499d020c432811aa313df46bbdfcd7afc40266f49e77ed8d6
 
aa5b426eb12011e87010ea8017ed69060d4489839cad9c93e7d350c2cc26e7ae
 
c181b86ab1383b89e68dd232ba64f2d33e21ed38d7964847b46ab38579c9630d
 
cd0fba34fdd5dc86e0de2e17c1a8918b7889a2ad7375985a13c3f08a6ca5b94d
 
90562b95de2fe48a156112dc2bf7052418102582f311ad1e79a53f4398692907
 
4bd865b6cdd4b9fc5784824488e3852b4131a130d6fcad1708dc8b1466ae7320
 
740f1ed3e1473fd5af5f1cee2f322d4f69fd2f984b877802078159aeb7818f02
 
c9754207bd55818386cd2acda90e2c581698b9937ba8ac13933543e2bffe8bf2
 
aa8c2a51dd6c70cc155df0570ece6e824da745deb3ad700720e90c62bd585751
 
1048b01187e3637b1a341ea267d300f01acbd6573be13f7cd60c5b09756d7884
 
cdec124b97992db667c96fc1a96efd1673136f13e6549c476ae94fe379585d90
 
0e9d31ec103ce245c48e1077d1b2cd4b4e200a87c625fcb973d19912981940d9
 
cf6491847c93f8a42ecdaf3a9b43e862b451d06dac8916d69f8d0ad7a8773fab
 
d6b8a2cdb6cf17a4b2b074458ff68ecca898b8960623fda1f58e55c9d50d0b26
 
f410fcc54747817b33db3ed325e3d5e2f801bb1b46e674c3da92e74367c005e4
 
ad5210134610ccf9453a81926243fe008c1104a40c2e0584af51fb4920052433
 
a8fe7d94436d1d7ea817bcbd69d2a008e4b59098181c47929a4ab5525af2ced6
 
2e2453fcf603fa0edc32f16b92c8a6ac18bb4669b3712160c0ae22b68cbdeb32
 
788730fb28c47e5b370d873eb5237e3ecb6295dde35d0232a8c8fd8188fb640a
 
3fc0d3491b4fa32ede3a4d3f307cdd0a106d9cb48acbee2f008e127e40eb9472
 
88de19de86243bdc7e53af0ecddd27b105bde9ef4fe3ee03a5a52657bd476fca
 
6de8eaeef76b4ed4a93cacdd856f5e5c76f1dabd242587686afe19634305e4aa
 
8d19adab1d61092d573861458855846959f2a7746570cd544096cbfe2e1ae5d4
 
1b1f93e53b1e585bf4679c1300d4669bdc3d864a734353ae00388d67410bc7f1
 
f14977ed57088695f308ed50e4eda8d4350fefd535d1551054f1ce0ad30da030
 
73adc5207abb4be22e9baf045f497c9994c86e8ab20be96682ae8c3e713a594a
 
f70c9a3428d78b4bf118447f90312bafc400266c7548d6cc2abd62e3a02633e6
 
21df7ab5acb26e0f523f9d38fec65fc28e9d6126c2f6944dcc4ce60720e3a611
 
3dae48641845f702483b7de6888ce0d3e3c1837d23315efe3cb89508cd6f8f4b
 
43fb4bea85875faceb6ff372ec27fe4a3139f078e06d0614b3e69794a7b0d92e
 
47f93b35ce0312b264aa3ce319675a611aa0cfa32ec9734d099d94a7ab480b35
 
778ec91269b35a5ca8b33d25da195cc85fec931c628f396181ca78fccf9c7ec7
 
0cf23e4c107f457de714a8f2020ef89533ebc1377f972692e014bcb0b824d3e4
 
9fa66ff4a5c0aa8ae4f2231807b41995b3fa9ee96362edae54b7cb244c72c46f
 
839ff70597cd2e5a973e78d35b1c55cc7f8f21a489da8b0bb2faac0ef8f324cd
 
30fb2da0c008a9e7630372cee5a5c7bb9a69ba6deb303bf995f5047b8c3b7798
 
157fb4f7bc62704212a83d39c88994aced6f78f99bf339afb6e4ab2f63a4b2a1
 
19fc5e3d6ade4ed5af142ccc69b22a88f6e731b810f97e1247ae4fe12a294536
 
1e73ae988040032b2f60e228963a534cb5ddf2a110b614149ffbf6c7aa0f6c46
 
7df8533c08c2855c1a104d2bbd39aba4b798e8c7803098fd68c0089722f8f140
 
1358e857de0be8cdd1a5d5a3ef863d8fff08d8dc71245a59a3111ab8de3b64a5
 
e982f907e7539c541718ee962cd97760462b1fbcd0f9a6de85cc977d924850df
 
364664017cf47ac2df83070e3b3ea84c1118085adf53a2be57dd67e168556f56
 
32c6efada26e5a51727a5313c20987bde461919313b645ba2a3c38caac60cc55
 
e5364c2cd60b4dadd1cd46cc33dfc278f5d7a07dde879c7599559e50789e40f4
 
5cf7e7eb5498d98480f7d1116d6afffae79f01e0b818d88200de6f889d3c578a
 
0c99c2499945dfedc29c8f00e3ce315a104ca9e754f0c3e1fc45f2e9ed9440de
 
6a7f6aefcb03811db3a09b34e2cf6e088a27900aafd50b872c96f15ce9b3cf8c
 
058d08a0ae0a594bb2a5ff0b3a5bb42e8ba16ec33c29db87fd1535357a8202bb
 
b874eace6af3fc1702a0b44530068867407353eb81ca267178ed6b3e2093cfeb
 
781256c8c663aa80af172fc60ad959f06d852d7ba72af326836eb782bf2ef1a3
 
59691324484b6a6782a5c8b8adb5d19d889d0d000118ebce8dba525782cf32ef
 
4d4bfdb9c6468b7f45bacf570a951f77d58f39a99c2393ae270dc573d5125927
 
e9a63825f27fa0994f038c8d6c24a36370262e61ada4d1c7af442c408d4efcf4
 
90ecf03941bf5a83840fbb538c9b336cedb017604ee712459ac403db4a3f9734
 
bacafb2cb6c7ca4dbd28ce941f184d6fa70121735ca6f87026169de820635f1a
 
42a4b2d4f45041fa1ea8f31a4d3c8915d93e4c9f7de152c8fded051e92a3aa99
 
b4a9fc434f1ecc5bd5416e93c4d5ebb2fa800623b7e24cfac49623b500d3e41d
 
9fb3424aa819162bb95bcaa57c9519eaf5b36d739f2c22dfb11ccf23fe82263a
 
3003f973095acb98f47ff80ba51b95a64473984e9e3fbf390dd8004e2de7ecbd
 
ad4df8fcc41426b8ad2f8e33d30c8f52c6875c264499905605bfe51244183cda
 
efb9e026bf43d4d024c248d9f85e61b521b7a9ec4f7b1010deecda2716ede796
 
a5adfc078de52cf64acba6af14e8bfc63107bfd42a9404847b06370eda748851
 
762dbcc933ab522f3f9e3cdf5e1d692cb5042038e35bd7cc1415df5468250c77
 
2b0a19724609b0cd143f0374c4690fbdc5fb265e58fa2781ac0b16b6c9b0024b
 
8d5faad61cd7a822eeb19ef519a6ff491d453242977f4876a7d351c8aa44bf68
 
9cf87c0d2c0ea6247bfdc9a55bbde4b60b71b722b3aefa094fb0cf8b9e4a49c6
 
819201bae5b8cc48e76b58a4ae5bfcd9722171115891b22276e1498cbe95b35a
 
d758eb63b5cddac73cd58eb9bffdec8717b1aefb623ff21893765c8611362815
 
fc98b38d4b0b739d7ec6a3bd1b166dfce238c42fb0e43dadbb39e34fcbe1bf4f
 
a1661d656c27c486f6bd7daf977c64cbb3cd650f0b71710f84fa7e7943196464
 
069d5fb70da6c80a33c05cdd87c0819f8d92a4b3334bdafbca4095b767fc3245
 
d39946897ac8d1e1b9e903ec805abfb0189d8ee2041bb56968ade9bf702dce54
 
dd31eccb53fff1b3f1e6e43f95dc7e89469a14da91266db45bd2b8135792c707
 
e8c2dd0db20ab607c8daaa6feb38b73a0f069276325905667351c4578d0c1215
 
fba58c8dc8421cd919741eca93c08ae9eb78ee2a1ff20280b19cf2e70935f91d
 
8d24245d54bde23441cbe455b3f01d86b69abe6ee2e0d009eb6d70721c14f510
 
b71fe7165d2c6fd6ff7ba4d1ea43d6ce528fca9cbaee8fda776e6816c55338e6
 
37d9b904942bed61110b0c2ee1ef7813377adbb5ed23db0d3539248f917a86db
 
749917669225bb778d371c2e5cc31cef7f4ec8d39325e09dd0b3c917d3eec517
 
58d868c2bea0aafcd62e3f854fa6954f2c29c2a12bdb
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
cleartomark
 
%%EndResource
 
/F6_0 /CMR10 1 1
 
[ /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /zero/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/equal/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef]
 
pdfMakeFont
 
%%BeginResource: font CMMI7
 
%!PS-AdobeFont-1.0: CMMI7 003.002
 
%%Title: CMMI7
 
%Version: 003.002
 
%%CreationDate: Mon Jul 13 16:17:00 2009
 
%%Creator: David M. Jones
 
%Copyright: Copyright (c) 1997, 2009 American Mathematical Society
 
%Copyright:  (<http://www.ams.org>), with Reserved Font Name CMMI7.
 
% This Font Software is licensed under the SIL Open Font License, Version 1.1.
 
% This license is in the accompanying file OFL.txt, and is also
 
% available with a FAQ at: http://scripts.sil.org/OFL.
 
%%EndComments
 
FontDirectory/CMMI7 known{/CMMI7 findfont dup/UniqueID known{dup
 
/UniqueID get 5087382 eq exch/FontType get 1 eq and}{pop false}ifelse
 
{save true}{false}ifelse}{false}ifelse
 
11 dict begin
 
/FontType 1 def
 
/FontMatrix [0.001 0 0 0.001 0 0 ]readonly def
 
/FontName /CMMI7 def
 
/FontBBox {-1 -250 1171 750 }readonly def
 
/PaintType 0 def
 
/FontInfo 10 dict dup begin
 
/version (003.002) readonly def
 
/Notice (Copyright \050c\051 1997, 2009 American Mathematical Society \050<http://www.ams.org>\051, with Reserved Font Name CMMI7.) readonly def
 
/FullName (CMMI7) readonly def
 
/FamilyName (Computer Modern) readonly def
 
/Weight (Medium) readonly def
 
/ItalicAngle -14.04 def
 
/isFixedPitch false def
 
/UnderlinePosition -100 def
 
/UnderlineThickness 50 def
 
/ascent 750 def
 
end readonly def
 
/Encoding 256 array
 
0 1 255 { 1 index exch /.notdef put} for
 
dup 100 /d put
 
dup 101 /e put
 
dup 108 /l put
 
dup 110 /n put
 
readonly def
 
currentdict end
 
currentfile eexec
 
892db0c466661f5ace3182477f6cfe03c4ecb6348a995df511820ba74300f66e
 
43387c4008e9fd81d9bc09d5e59f4e25ca6630c54002de532868dace52378761
 
960cc96173cd754ec5f51118b6058590fe367c7292644cfebb246bc306e67f90
 
3f99cfb380637250cba851aebde36dd379dc7ff4d935aa77e84e11aad67f976f
 
69d5f4f011271d1d58c362a77701e48a0f99c9234fbf7f2e5d314c68d294a2ed
 
69c87e4cb607dafdf6c0cd9ec06692fea3fecdb025c5cb9609b65e0b3c0ea934
 
3aacf9e513b8b27769f4c7d343e4ea00e1056252fd6683bae3ce695190fb27eb
 
1b1c9f4502add678ba1de6f07aa3266f3910749e5536d0c1e2d65f93a3a5193c
 
5c639b2c267e3c64f3f618f98e9f7825ab9eaf26f150f80f23f0dd2019b4f8d9
 
ea61bd871e8a57afdee851739f9d88f334ba183f77b2433a5b583efda95a7fbd
 
b95096810a2b8a67d2f68db4f7b1a4f42dc38ec202373f37e1e87ee5d702a56f
 
d2dd6cc10ebaea63827321159a02c5d3ec7a5929bb0f9f6ee0dbce66470c9a45
 
70b1a3f1a99557f5439240a2c14b065baea0c1a82e6943fc00ce913124889e1c
 
78f54d96ebe65160213caf351981bad410fba47bd7dbbf71cd7af691b6314e62
 
e76af8c4f0e432afe796c94263f9f48858fe3209cf83e1ef95a8eef82af2d6a5
 
0c1b6194267c4cb1f9b2599ae304d31a63738e0acc71ef0d5cff36dc7fe99d8a
 
2c5a06c550c5f61f41cc2b7271d2e6dcab65e53a5b7c0e7f8ba84477172d6b49
 
ceb28d612cdc35bfb915725a5f91b8c9366d672a8adc7ef1c814e6c856f44787
 
7002b6904c13e3c246fc1b2c19c5bcef33bbb87da1ef5ae3e6922ed294a0a8a7
 
a95269ab23c89c65e0ea1f36ded2688000c1d6e36df6c7968fdfe416a71f5ca2
 
812a62bc4a079eb382e45cda4c54ffb9d128f5f581ee01cd2de5bbad1182acbd
 
dbf01c305aa177b9d8116a373aac93b61f1685f27e4bc1eaeeefd604adfa61e1
 
0122fc8c4bee23aceedc7cefdc6f284ee8b6eb1d75c8caef8ebb5d7440f88ca0
 
26bff55bccf2d0b0b41cf89d3db1fa342b8960785d3a9c4fb6c2c24c19996ae7
 
954c954d9be41f380d4f0be964fe95f26adadc1aa28da62a608ad6e1c7eeaf26
 
4e4dd65687e37f3ceac5f16d57063395b0f64592c4cd87bce8519c8b78570f92
 
f7ce4e5cb0db90794a2c80ef4058f5e66f4931da04c3ca6d9b309b3147141c20
 
3ccc2cf5695741ff4d2f1b4f9cb29b85e61b89e292fcbf1b7a893158cd3e5558
 
de258fee891470567c322a595bbe7c598c375e67156392178518b4bd9f2e4c60
 
0c1833b14bd58c9ae15367e1f224cefef7f9379d328d28c58651e5e6d57dc1db
 
0f732e570be622ca0dd1e0c0107a2832b5826e605cb4ef2ddf4b4dfceae3b932
 
7bd52e63b2edb7657881759bedc58c00950b17109705eaab333a49639e8af7cd
 
4a7ad0941155fd82f193578a34a19e5657624165fdc064a4521d6e979c056ba8
 
1df9c141b4c780fceca0a95a887bad19bd2ccad21ea43919d43ca1400df21a5d
 
9f631b3d2049fe0e600297721ec2f59c649a380ea3d21b6a6f750373e4bdd043
 
61c21ba5171b557c01836b96a68c1611a97dd203d8b8e68849b25032786abc13
 
a9f9bf3672a261fe6fd6ee3602d25dd8fe445285665b5a8979ae714141a74400
 
5878384a0e87baab534e10846b95820d749c01c0454f6032fb767a1547caab47
 
7fdb48fc17ff5cb2149ad9fd05b077c540b166e9e00b42be220b5aa69705b62a
 
1914fcd54d8a0756035cb8d76dc69134270435a33127296dd73239adc3eef1fb
 
cc5d82bc626d6ac8b00c73644865535005a30fa329c0f2704a84377868caf634
 
314b724b7abd251d613f8af1849313946a45ea88ce937385164163bfb2bf9be6
 
1de31f3cb2aedfa1bb07380f2bab32dd83a3e80959710b72d12ed3844a50cd64
 
17b6c0277e52c5322e02c98cd7e38608a8a8e1e9da1d3177e42570ae9a84c540
 
fbd44653a28531b4cd1a9d38bb137c1f019c90e628dded2931a1ccaff948ba0f
 
6eed4c5224174c024a81af9658dc7140aaf42fed2ca7ef5072c80f2a66a24712
 
a2a7254974936f5f2485df7beb658f558e9e77a5865c19164c9522eda1720cc8
 
f3d52d54d64620a1e31eaa7876bae7f0e60adfee51dd7e180be4e18695bcdea8
 
298e5fcb05f2e2f388fd80422e4467f8b9a16b95f6026876353ffa5025ac624a
 
d852b0b0b57f15452a4b34c1236d856434307883cf5a31b604902b0df3d2cfa6
 
12b1c92a1655a723762985320d08a9cdd502ad73104c55012a8ea1a8d6a264a1
 
e11017694ef62540af50297217079dd92d56152c7725965d91036c0518b8a5f3
 
7842104589883529f40a0804094129a5bcb533ec9d9afca090c9df9dae81c7d3
 
c7d7f7ca405f95406790453a170336f042bd3f619c6a1c00004ba0f420c7dded
 
403710898ed667d55b31fec1539e2a0ea93e1da55d79e5cea0e8a2e770ad0528
 
5eab509a631c15c1b51e422595e430ee44d9fa5ed339803cd2d0882a5f3da69d
 
4b0bbe0b1bb79a7c176682a47cb4fa885e95bc814ebc1213eed7b936c93ad4d4
 
69c932fdec8efb04efe4a0fcf615d29badfba5d5127cdf307209cf6d4d39b7c2
 
a791aa5f93f551db536ad65c6df592829aee17d040e66ca423eeb18d701e489a
 
32be050572ab9d1ff06c86ccd8c24b51c57159907fc774e8538a746f31953b7d
 
5110c938a4aec219dbb4c02022c0a7936405a77f6c09ff60e9feb0abdc149e93
 
afc98efa56b10bfac7789a9c4d82a8f11ff3341787a103dad3bc89051b1c60d5
 
893c1fe046bdd452fd7ed577468a32d5e06724657aeb93818e3c0e7a3fe372e8
 
c1eac1693605346639fb46a0de78cec5e6b92c06bddc39803cd073d8709a5206
 
7ba7f095ab95331f72f2fc037e641cfe8160606170d97371feb12093cfcb78ab
 
83389ef9a9e4a11c68f272696cd8fe1a97d3e9d38cae72c41dfd6f726bd597e8
 
a8d47eb7bc43613834f20eea528697cce0f5ceb0d9b6f26e07348098c38b962c
 
f7a4edb5823dc2d598f6b6a61811e2dd50a9081a5da2d982997097c7e9f5c653
 
762cc7b02b596795294b335672c9159a093999a66d975e7f528ed14734fdcc2c
 
4bdfbbc0e5f22983e4c94682302547924b9437e27487a2b528f25df0641165e9
 
5953f65a2e91a96933e84e1de610ff5e4391be91609b0faf26d248af9739a327
 
388388ba2675170dd4006ba26cc860e83aa9a92bf3203ff7e08b7f7c2e1fe401
 
6a1f1a7d9d15764349b0251239cdb3a729ebae70c840d3be541788693d4a053e
 
1152b4716b9617d7625bd44999edced34958770805995f595bc5362989808caa
 
8276ee678d465c931ac41889eec91a37e2f1abe24327c9b82aced90255fc8c9c
 
347f5a84c77bca27137afffb65e7ad2914a85ae4b0ac5d89037ea36333df4625
 
a0310bf23bca4dea76a8e8d74ab21d496f1e112647b3ab47a012e2a470783513
 
87547165403f6e2f3a7167d5db1b95a42c4509acdbbe1ff515ed5d9d98eaba76
 
304c5bc58ba09c623b96d3fa03e1f901386357ea76d1bdf05bec6a968c394b69
 
679fc49f79237bb57a0b400e0524d5f3c61c3044a54294c56737090b5ab6bc36
 
d2e13a3788214922b30391b95ebcaafa2e84a959331852e9a190a481f227807f
 
041509987140116167c35be12ef04b107b2d76eae26ddc2de6fe918c8ea45b3f
 
8eb03ed227c2dec271064a0879777baf5a1067a68452d8efe918f80808f3f976
 
bfc8875789da737cdd193ea27e78617690ed3dbe5b5de3f99b85768bbc3e67d5
 
b5fd01c50d3e18eab5f5d7e33a3a3b887f919fd5b0de1bb44204affc5e884d96
 
388c0074f61304fa3ff39231d3d48b3ff1be2a3ccf3257cd6dce35da3c702055
 
7d23adb4ff3b830568f891cf171de8a99e91969b9e85921c476f257ef6c05a11
 
4d0e133e7f9a96ed04230e41f9b5ea4efabfc2df832d0304b6239fd26f00cc33
 
eaa1913fa61e583ffcb0531a5497bd62bfd9ec90eb52253333e7fa8801fa6902
 
bd8fd7cf30ae6dc9c2a88c9fb3a2bc7396f1c93afb16e6a43d6b2a5268cb1095
 
b8aa98ffdbd1644638ce64b0e2fa2aa482eef170deca51bcf1a052ad5214d5fe
 
2bed0790901c8f09dea190b488f3ce2aa8e2f539afadb7a59dc2473bbba02aba
 
2a1314f9db9950f5f2c905cb535fd6f0ab25f90c4f6e3437ceececb904fd772e
 
99eb06a768092a511f7c9d047685a1cdf02d4a29c00faf836572ec61e5a78ba4
 
6267bc0376903c5fbbee9aa808b3d5fb3965dffa328b57d0c4cd8cb5825b76e9
 
81971c4fa98fae85dc3b612d40ba2851c46170e118a7a460bc39967e6b938e4a
 
3c360cf6d1f6a805fa18911e1a929db1f1af07838639e89737301127b2c81666
 
2f29acfd8db28d65db437bffd45d2dc6529c38c3dea6a113fa387de09c7fc595
 
26a10604fe9527355a15a96b999604bfeb0671f8b2291f85f36a61f85e39b474
 
b24518f6a7ea5f451bbb9cd4438cb3f4e7b2a99eca7118785d59948eb4fe858b
 
f7d5bdb5f6591eadbb333a07181bc97a2d4240e87fb4c77220a573a1a0489210
 
fb724ff3ecaf8f09faf03449b07569307b9c9ccc3fe89c35e3354dd6c2170c9c
 
b2e27e4efd01ca81b2dae76b39f14969a1db40c1e8ad368f539cfceb05a4afd6
 
4b87b7f1cc38dca1ff5084c34f84ffe0c1c08c4dacbc7c2c6e668617b8067007
 
8fea89c6f9647867fc6d59810ee57246611408ccebd7e60fdf3765b94b99aa84
 
5b02fe42802321fcc63c0ad9a875e2c7794042fbec91585970a9eecd529780e0
 
0e5419ca781c2e0a1029498d2df5cdba55158dcfa324cf102eb897bd915a7c34
 
cdbacd5fd43c3d47d9fc01f16238f757cf76ab2e194cf477b83fcfdcc1b83b57
 
a46b072d3071d47a675955f83da2f888197b5ab4e9a1a487bfb3e430ed07fac1
 
d2249948a1e221aef4ad2ebe08083611be57d9c86c0f191af7ce84115f8b7830
 
83800e53bef1a70f7fcad22226e3bd33573cc88ff57469bb8ed733953750ae0a
 
1087bbff4de64d11d07724bd9f8902ca26a71fcfd14d3f1bbc91c498c5a9f36b
 
7a7255d10865062c5fc4e5ed9fcf67bdc4115c6a376821a64c662868321b14a0
 
7252d80475249280f5d4e33b9e5e1a44e1bea33c4a89986ab69618408db14f0c
 
2f8ba75055a10f8a3b28d920518543b1b69159e85a508381ba6332aa4df81834
 
4ce46b5428244e31d7b5b8bb405f6289be69a728142360403ef60a8e618f44a1
 
1f2ce97d181f9319700c4bebcf5aa56edf94f2263d726f0cef4d14ba837a43bd
 
e285da142e61f963f4fe68a6eb3e5d634357045c46f4869fbdeee2f6da92bc43
 
f75f2a1b17869bb86244a82b15e75b04e01f614ca268df342912f1b37f584875
 
be3e81008d895bd31e33717458ca38eafcd8a4605b941afbbfd45907e281f2f5
 
c46ae38adfef0738877fdd67b96979c97013cd2c5bbb43315f7a9efc9cbcd492
 
339d5ce3ff7df9f09e2c232f72e614a5ecfc86faf692f5b61bb0dd79ff7bc08e
 
cbd59aca4c66560ecebfcc72906522bb02d39e4f0eaa1b62991e663a3542764e
 
489fde6ffbe252076422c94ba05ceb3d9c9dedf5d5d135de6e5bb39e94aa83d4
 
e4f2348ea3d368dbf255a953eb931773c417e9a46cd47a4507e04f4e2b76126d
 
a178b90162a378e0a7b1a77c46aff6715e5d997312404743104e720c7cbd129f
 
1a256218f16aa7c8d507944e9199a082ec7841e5239c09d261de452922b74e05
 
4aeee0b2c1a640f98513c8c9d951f5696115b15071954f6ed60017a98d76a92f
 
24c714478d3875609bfc0850294e657e0e0f2ac466b38eaa839aad2b469068ba
 
eadfd89b81b08d467a26868738884df2a23aa1d9ab63a9aa6b508ec41ca56e4e
 
ad55a6160139207c3cf786d0efa44603790f5ecd21c0550b1d223528c54b3af8
 
9d948ccb0670c0fff71a4a2e0a9bd93c8bad6b25e8bae0651cf2de13b9997bd2
 
318ad21a1969e055a1a5d8d7c8e02ceeb1179210c4a7e3725017d2bf324ba470
 
451b995a0aa3247450df354ca952f9d8142a32987786545e1b0d2d54b43fdcf6
 
9df6628635ec3b3591729cb08717721098d67c4d1c49bd94c46e564201b67ad3
 
9022953474f5ea0e21e74f8cab48f733400c542eeb00180cebf7bff133507944
 
04f23750c513883036fdc34d22dd9555cef238d1e2eb0cb5f69e77c5950d3046
 
5970e5e4c0325007127cdbf24fa684079ccefc8889af56145f59d4dbd03e1d20
 
bb184cb56e5786e45f3ff566db07c4cea4ccbc4919587972f5b3493194c48751
 
f60d5881893b3bda4ee2134ca6ff8d76934b4796c2f19ecc3e63f2b74b9d51f4
 
9272bfa33102283c870f36dd6e1e25f4f9c5d93fbd64451c8f9e834794eff825
 
96d25d2d4664710044ac43687435da534faf844a1a078b03a2d42bade31b36df
 
a9619a136d0323c1fc9f806465b405a7c57c0d64b7df34bb5f0d38fd57c85803
 
d75f93b701a7d9cedb3cf01f5536d8666f371f494fb2c5dfca9025a38954ceae
 
e21508a81a048b7bf693bd09363ff0f9f2c9a1d780c2640d8180a0316efac25b
 
7cb71c15a0f05ba4a2594327cd8706a2d98500a6c34ffac449ae98c8fc2b5185
 
a4d8a87e21d425b451aff8ddc300090b62a38e2d80b92e9fb12b96bd4c4e146e
 
30d3c79662bdfec8b18e179cbe0a55b49cee6bd2c27fc8e4cfbc7ce59da26eb7
 
85edb6816917b7e403bfa08821f44483475d5dc983f6e092ae649427a97d0e5f
 
7921452b794a450d3b3d1596b931af93a5882cbba93ee9b244ca65feb89b1429
 
15d8a350882c4ce74f41e57b92728bca2ea5af2712c556436ddec12aaff7d705
 
adb53228656a3ec55ded1963758bf2cb6ac1ede36a5269dba5bc0dfa68295dcd
 
8537862f82ef8a520641243f0a94cd8aae6f445dd643ea0940df4d2bf2a3d615
 
d9b605f7da18da79bf4dabd6132c9a1586c27270cdc0b4a25fa542ff70b4d171
 
6c8a4d590ac35256cc64cae9f880933074f23931140838995b46fda23146c1bc
 
91bc79624a2a47fc6f58fd38d53ebce99904398d4f535c634e14a34066ed793c
 
a73139de8c66d991cec2a7e0395db5b0c6e5de959a54aff0ec74374b0a644281
 
221c3f0da75387a033556be3cde0807445583ba511d130fd3af56d80de2fa6ad
 
89062db1d766000fd3f9b6ac975fd5c5bb1ee2756394d02db65e65426f271e31
 
b464f945ba8267999085655054ef2e7bc5b1f66245025881bacad3157ff74d4a
 
539b63a87ae5b12194393cdc41ae2d63a6f69f726e319d07d5f0807f11a94dba
 
bc4c8e52286325657558ebfcb951518436fd93cc6e303e38b57abfb7089ab7d7
 
b3710d15c484902be8d28f50faf21f0db8bf298aeaf7f8ce3942d29d228cbff1
 
7cbfdd28b80f4409aa841afe71005870137b75ac6a8b6717340c8bd4400d7de2
 
225e9896cead112915569e8f7dc363784a57fc50be85bb225b1bb5098468b53e
 
6d67219a1b1c750a1ba4e98260f3f1bd477e4f65e6c1df64a5c3d77074a2bb83
 
ae7d4c088470ab5a14c4ac02eb2bd93d390b9553c15edc1aa53f8fb875630e46
 
e5c97134093d070cd6bf2760d66427464144d2a12ebd42d9b76370b881a3c418
 
134bbb2632d42a74d6ab57859d505b09e53164c9f1b5e0f6a4e236da2b3d1b22
 
416a44375becc0bec2c191e2b844fff10e4fb26a95bb8c6414f1323b6edd8592
 
138deba43690f0e4ec17bb1c7f75467fcf4834e0c97d397250a68332b9ca4134
 
ecc6b9f4855592c835d9f8047e3e602ea23c62d37afa8db030e31ff26076b942
 
8cb065bb7b042cbdd3987e2058c518bfc48b98814841051a7c7632e923372257
 
debfdc6b1a469b400e48f96184810658e2702c1540016b943893d77a874561fb
 
ea7a0c0d3bb286591fe504a2626767ff1a4883d22a7f54ccc70c5628ea55b38f
 
9a8f9760ec7b1cd3607bfba9b98b63008b156e60d5354a23db779c385e23ab3b
 
2ed5fbd147b0ac82572eac2159b49c4dcba2e537e68387a161f72c8756752de0
 
44c4901cde4af3d68d2b6f11332aae28b61e01ea99ee04bba8d5d277b7b279e3
 
944c8d5d534f2c662a98980695f4ddc5f848eaba9316bf208761b6dca9fd285d
 
70ec909388b0d281d4a95c25c2d52fe60848498c341054eb5a05e7d0838f6bb9
 
cc8df1a6253065ddaccf9d059cb91a87d0a3c3fa7596bbf63fecb76f0326b5fb
 
d92ebf2b248bb761594de827ac99a9115b89bc96037a7ae3666b4253a0aecaf0
 
7ca69cdb54c3a1605dfd89c8c78ee303b1e1790c708d0cb4ce15c67584b6f008
 
3cf9ede0778c2df91c4b7456487441e044e93db3a66455e2595d792a2e70c032
 
e958897de90d9fb006e82972551e98f05b78739e94c55bcff46cbfe3a63033e2
 
015e1c436b97518e2f3b73cdea112aa231fd2ab3a47e272f6cf699f3430af0ff
 
f4b92dbfcb2eb81e729c512c6f5d8a9ae92222b18077fd87d2d84b5c175b94a7
 
c457a3129e9220875b814791eba6fe6284b37f325149e957a4f205c43e93e1e1
 
6731911ab4865a818f4d9efc8ba8d848474d233f670e6e4012ea64afd38ab999
 
72184544747064d6f9d163246e1bc0dbe1bbbdc9c45f7b3d7479105f833f559e
 
c61a826e107dc8030c17ff097cfe8b4f17c09c53d31b655c8cd9ff24b14d8d82
 
3f99a8cbdfb0f106a82ed98304fa772603a9f4844912e1ea67a2218d6fc8ef5a
 
6cb6cbbf8ade3f275b17e364eba8054f148f8e0b35e796f60d6281c89a736a59
 
df25c2dd15a3154e315128f67607e5d7e2df16f2ca6c20352fdfd44cdb0627a6
 
9f6e575e536c65c3ed5b66a52522588fecf7aa5b6f6b67e0ddf73827018886cd
 
543b18cfc433a303b24e0963354dea3caffec6d4e2a02f702ec24144cc46f35d
 
fd73284fb78f2b8fd7ab102ee64d93b9123eaae83f197cb8aa596d464cc12af1
 
a8cf473dd5ff0ae32adb9e46348d5ad7ce1b122e400ec64f6a32c4da1bc32089
 
0f06e1fa1b3c3155c4c2c9682c0125bc4b3d0f890c9655b6cdc7dee15e85244c
 
1fe7b7fef071e0e8632cc59eff99808d438459c48c6032a19894539aab8da6d7
 
c7738d9234183a30f0c0ba44850bd103bbacebfc444e24ac5f12484d12d9c4fe
 
d1fbf9e54fb9b5d37831d2353d82787f6287359f4c4e4d596bf99111ce05dead
 
6b93868bbedcbb868646882ea24d54cd21c96de70c8c4e1f794f9a6ae706bf0e
 
be3f92edeb48ee69aef76c71ab2876a272feff2f78368019d869b5c382d36ee1
 
9aa65e426c30834df1a83b409c8c434d05caeff20477659d229ae0aa70d7db6c
 
69236f84d4b57421b9ffa649ad900debad6420dae7c5c3c6a75b06891048ae77
 
6f6d481ff9ac40bfb5823bf4c1d18968ad749e883a79ff928d0fe24195cb190d
 
a9f9096bfd35d954023f492c4866554f3b029954744a9cddd50279a31ea9dc33
 
1d66ef
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
0000000000000000000000000000000000000000000000000000000000000000
 
cleartomark
 
%%EndResource
 
/F12_0 /CMMI7 1 1
 
[ /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/d/e/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/l/.notdef/n/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef
 
  /.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef/.notdef]
 
pdfMakeFont
 
189 252 false pdfSetup
 
%%EndSetup
 
%%Page: 1 1
 
%%BeginPageSetup
 
%%PageOrientation: Portrait
 
pdfStartPage
 
52 3 translate
 
-52 -3 189 252 re W
 
%%EndPageSetup
 
[] 0 d
 
1 i
 
0 j
 
0 J
 
10 M
 
1 w
 
/DeviceGray {} cs
 
[0] sc
 
/DeviceGray {} CS
 
[0] SC
 
false op
 
false OP
 
{} settransfer
 
q
 
0.5669 w
 
q
 
q
 
0.2835 w
 
0 J
 
[1] 0 d
 
/DeviceGray {} CS
 
[0.85] SC
 
/DeviceGray {} cs
 
[0.85] sc
 
0 0 m
 
0 0 l
 
74.4094 0 l
 
74.4094 188.8581 l
 
0 188.8581 l
 
0 0 l
 
h
 
f
 
Q
 
q
 
0.2835 w
 
0 J
 
[1] 0 d
 
/DeviceGray {} CS
 
[0.6] SC
 
/DeviceGray {} cs
 
[0.6] sc
 
0 188.8581 m
 
0 188.8581 l
 
74.4094 188.8581 l
 
S
 
Q
 
q
 
0.2835 w
 
0 J
 
[1] 0 d
 
/DeviceGray {} CS
 
[0.6] SC
 
/DeviceGray {} cs
 
[0.6] sc
 
74.4094 188.8581 m
 
74.4094 188.8581 l
 
74.4094 0 l
 
S
 
Q
 
q
 
2.2677 w
 
-49.6063 0 m
 
-49.6063 0 l
 
99.2126 0 l
 
S
 
Q
 
q
 
q
 
[1 0 0 1 106.2992 0] cm
 
q
 
[1 0 0 1 0 0] Tm
 
0 0 Td
 
[1 0 0 1 0 0] Tm
 
0 0 Td
 
/F3_0 9.9626 Tf
 
(\036) 5.9361 Tj
 
[1 0 0 1 8.7034 0] Tm
 
0 0 Td
 
/F6_0 9.9626 Tf
 
(=) 7.7487 Tj
 
[1 0 0 1 19.2195 0] Tm
 
0 0 Td
 
/F6_0 9.9626 Tf
 
(0) 4.9813 Tj
 
Q
 
Q
 
Q
 
q
 
2.2677 w
 
-49.6063 240.794 m
 
-49.6063 240.794 l
 
99.2126 240.794 l
 
S
 
Q
 
q
 
q
 
[1 0 0 1 106.2992 240.794] cm
 
q
 
[1 0 0 1 0 0] Tm
 
0 0 Td
 
[1 0 0 1 0 0] Tm
 
0 0 Td
 
/F3_0 9.9626 Tf
 
(\036) 5.9361 Tj
 
[1 0 0 1 8.7034 0] Tm
 
0 0 Td
 
/F6_0 9.9626 Tf
 
(=) 7.7487 Tj
 
[1 0 0 1 19.2195 0] Tm
 
0 0 Td
 
/F3_0 9.9626 Tf
 
(\036) 5.9361 Tj
 
[1 0 0 1 25.1556 -1.4944] Tm
 
0 0 Td
 
/F9_0 6.9738 Tf
 
(0) 3.9712 Tj
 
Q
 
Q
 
Q
 
q
 
1.1339 w
 
1 J
 
[0 4 4 4] 0 d
 
/DeviceGray {} CS
 
[0.4] SC
 
/DeviceGray {} cs
 
[0.4] sc
 
0 0 m
 
0 0 l
 
0 240.794 l
 
S
 
Q
 
-8.2677 240.794 m
 
-8.2677 240.794 l
 
-8.2677 203.0224 l
 
S
 
-8.2677 203.0224 m
 
-8.2677 203.0224 l
 
-8.2677 193.5795 -4.1339 190.4319 0 188.8581 c
 
S
 
8.2677 240.794 m
 
8.2677 240.794 l
 
8.2677 203.0224 l
 
S
 
8.2677 203.0224 m
 
8.2677 203.0224 l
 
8.2677 193.5795 4.1339 190.4319 0 188.8581 c
 
S
 
q
 
0.4009 w
 
0 193.5795 m
 
0 193.5795 l
 
49.6063 193.5795 l
 
S
 
Q
 
q
 
0.2835 w
 
49.6063 211.285 m
 
49.6063 196.7153 l
 
S
 
q
 
q
 
0 J
 
[] 0 d
 
51.2299 197.4992 m
 
49.6063 193.5795 l
 
47.9827 197.4992 l
 
49.6063 196.7153 l
 
51.2299 197.4992 l
 
h
 
f
 
Q
 
Q
 
Q
 
q
 
0.4009 w
 
0 240.794 m
 
0 240.794 l
 
49.6063 240.794 l
 
S
 
Q
 
q
 
0.2835 w
 
49.6063 223.0886 m
 
49.6063 237.6583 l
 
S
 
q
 
q
 
0 J
 
[] 0 d
 
47.9827 236.8743 m
 
49.6063 240.794 l
 
51.2299 236.8743 l
 
49.6063 237.6583 l
 
47.9827 236.8743 l
 
h
 
f
 
Q
 
Q
 
Q
 
q
 
q
 
[1 0 0 1 49.6063 217.1868] cm
 
q
 
[1 0 0 1 0 0] Tm
 
0 0 Td
 
[1 0 0 1 -15.1251 0] Tm
 
0 0 Td
 
/F3_0 9.9626 Tf
 
(L) 6.7801 Tj
 
[1 0 0 1 -8.3449 -1.4944] Tm
 
0 0 Td
 
/F12_0 6.9738 Tf
 
(needl) 19.1515 Tj
 
[1 0 0 1 10.847 -1.4944] Tm
 
0 0 Td
 
/F12_0 6.9738 Tf
 
(e) 3.7799 Tj
 
Q
 
Q
 
Q
 
q
 
0.4009 w
 
0 188.8581 m
 
0 188.8581 l
 
-31.8898 188.8581 l
 
S
 
Q
 
q
 
0.2835 w
 
-31.8898 179.4152 m
 
-31.8898 185.7223 l
 
S
 
q
 
q
 
0 J
 
[] 0 d
 
-33.5134 184.9384 m
 
-31.8898 188.8581 l
 
-30.2662 184.9384 l
 
-31.8898 185.7223 l
 
-33.5134 184.9384 l
 
h
 
f
 
Q
 
Q
 
Q
 
q
 
0.4009 w
 
0 193.5795 m
 
0 193.5795 l
 
-31.8898 193.5795 l
 
S
 
Q
 
q
 
0.2835 w
 
-31.8898 203.0224 m
 
-31.8898 196.7153 l
 
S
 
q
 
q
 
0 J
 
[] 0 d
 
-30.2662 197.4992 m
 
-31.8898 193.5795 l
 
-33.5134 197.4992 l
 
-31.8898 196.7153 l
 
-30.2662 197.4992 l
 
h
 
f
 
Q
 
Q
 
Q
 
q
 
q
 
[1 0 0 1 -31.8898 207.8413] cm
 
q
 
[1 0 0 1 0 0] Tm
 
0 0 Td
 
[1 0 0 1 -15.5173 0] Tm
 
0 0 Td
 
/F3_0 9.9626 Tf
 
(R) 7.5645 Tj
 
[1 0 0 1 -7.9527 -1.4944] Tm
 
0 0 Td
 
/F12_0 6.9738 Tf
 
(needl) 19.1515 Tj
 
[1 0 0 1 11.2392 -1.4944] Tm
 
0 0 Td
 
/F12_0 6.9738 Tf
 
(e) 3.7799 Tj
 
Q
 
Q
 
Q
 
1.4173 188.8581 m
 
1.4173 188.8581 l
 
1.4173 188.8605 l
 
1.4167 189.2362 1.2669 189.5963 1.0009 189.8616 c
 
0.7349 190.1269 0.3744 190.2757 -0.0012 190.2754 c
 
-0.3769 190.2751 -0.7371 190.1256 -1.0026 189.8598 c
 
-1.2682 189.5941 -1.4173 189.2337 -1.4173 188.8581 c
 
-1.4173 188.4824 -1.2682 188.1221 -1.0026 187.8563 c
 
-0.7371 187.5905 -0.3769 187.4411 -0.0012 187.4407 c
 
0.3744 187.4404 0.7349 187.5893 1.0009 187.8546 c
 
1.2669 188.1199 1.4167 188.4799 1.4173 188.8556 c
 
1.4173 188.8581 l
 
h
 
f
 
q
 
q
 
[1 0 0 1 2.8346 180.3541] cm
 
q
 
[1 0 0 1 0 0] Tm
 
0 0 Td
 
[1 0 0 1 0 0] Tm
 
0 0 Td
 
/F3_0 9.9626 Tf
 
(P) 6.3961 Tj
 
Q
 
Q
 
Q
 
1.4173 193.5795 m
 
1.4173 193.5795 l
 
1.4173 193.582 l
 
1.4167 193.9577 1.2669 194.3177 1.0009 194.583 c
 
0.7349 194.8483 0.3744 194.9972 -0.0012 194.9968 c
 
-0.3769 194.9965 -0.7371 194.847 -1.0026 194.5813 c
 
-1.2682 194.3155 -1.4173 193.9552 -1.4173 193.5795 c
 
-1.4173 193.2038 -1.2682 192.8435 -1.0026 192.5778 c
 
-0.7371 192.312 -0.3769 192.1625 -0.0012 192.1622 c
 
0.3744 192.1619 0.7349 192.3107 1.0009 192.576 c
 
1.2669 192.8413 1.4167 193.2014 1.4173 193.577 c
 
1.4173 193.5795 l
 
h
 
f
 
q
 
q
 
[1 0 0 1 -8.5039 197.8315] cm
 
q
 
[1 0 0 1 0 0] Tm
 
0 0 Td
 
[1 0 0 1 0 0] Tm
 
0 0 Td
 
/F3_0 9.9626 Tf
 
(Q) 7.876 Tj
 
Q
 
Q
 
Q
 
Q
 
Q
 
showpage
 
%%PageTrailer
 
pdfEndPage
 
%%Trailer
 
end
 
%%DocumentSuppliedResources:
 
%%+ font CMR7
 
%%+ font CMMI10
 
%%+ font CMR10
 
%%+ font CMMI7
 
%%EOF
doc/figures/grids.eps
Show inline comments
 
new file 100644
 
%!PS-Adobe-3.0 EPSF-3.0
 
%%Title: grids2.fig
 
%%Creator: fig2dev Version 3.2 Patchlevel 5d
 
%%CreationDate: Wed Apr 10 13:51:09 2013
 
%%For: greta@mario.sen.cwi.nl (Margreet Nool)
 
%%BoundingBox: 0 0 367 579
 
%Magnification: 1.0000
 
%%EndComments
 
%%BeginProlog
 
/$F2psDict 200 dict def
 
$F2psDict begin
 
$F2psDict /mtrx matrix put
 
/col-1 {0 setgray} bind def
 
/col0 {0.000 0.000 0.000 srgb} bind def
 
/col1 {0.000 0.000 1.000 srgb} bind def
 
/col2 {0.000 1.000 0.000 srgb} bind def
 
/col3 {0.000 1.000 1.000 srgb} bind def
 
/col4 {1.000 0.000 0.000 srgb} bind def
 
/col5 {1.000 0.000 1.000 srgb} bind def
 
/col6 {1.000 1.000 0.000 srgb} bind def
 
/col7 {1.000 1.000 1.000 srgb} bind def
 
/col8 {0.000 0.000 0.560 srgb} bind def
 
/col9 {0.000 0.000 0.690 srgb} bind def
 
/col10 {0.000 0.000 0.820 srgb} bind def
 
/col11 {0.530 0.810 1.000 srgb} bind def
 
/col12 {0.000 0.560 0.000 srgb} bind def
 
/col13 {0.000 0.690 0.000 srgb} bind def
 
/col14 {0.000 0.820 0.000 srgb} bind def
 
/col15 {0.000 0.560 0.560 srgb} bind def
 
/col16 {0.000 0.690 0.690 srgb} bind def
 
/col17 {0.000 0.820 0.820 srgb} bind def
 
/col18 {0.560 0.000 0.000 srgb} bind def
 
/col19 {0.690 0.000 0.000 srgb} bind def
 
/col20 {0.820 0.000 0.000 srgb} bind def
 
/col21 {0.560 0.000 0.560 srgb} bind def
 
/col22 {0.690 0.000 0.690 srgb} bind def
 
/col23 {0.820 0.000 0.820 srgb} bind def
 
/col24 {0.500 0.190 0.000 srgb} bind def
 
/col25 {0.630 0.250 0.000 srgb} bind def
 
/col26 {0.750 0.380 0.000 srgb} bind def
 
/col27 {1.000 0.500 0.500 srgb} bind def
 
/col28 {1.000 0.630 0.630 srgb} bind def
 
/col29 {1.000 0.750 0.750 srgb} bind def
 
/col30 {1.000 0.880 0.880 srgb} bind def
 
/col31 {1.000 0.840 0.000 srgb} bind def
 

	
 
end
 

	
 
/cp {closepath} bind def
 
/ef {eofill} bind def
 
/gr {grestore} bind def
 
/gs {gsave} bind def
 
/sa {save} bind def
 
/rs {restore} bind def
 
/l {lineto} bind def
 
/m {moveto} bind def
 
/rm {rmoveto} bind def
 
/n {newpath} bind def
 
/s {stroke} bind def
 
/sh {show} bind def
 
/slc {setlinecap} bind def
 
/slj {setlinejoin} bind def
 
/slw {setlinewidth} bind def
 
/srgb {setrgbcolor} bind def
 
/rot {rotate} bind def
 
/sc {scale} bind def
 
/sd {setdash} bind def
 
/ff {findfont} bind def
 
/sf {setfont} bind def
 
/scf {scalefont} bind def
 
/sw {stringwidth} bind def
 
/tr {translate} bind def
 
/tnt {dup dup currentrgbcolor
 
  4 -2 roll dup 1 exch sub 3 -1 roll mul add
 
  4 -2 roll dup 1 exch sub 3 -1 roll mul add
 
  4 -2 roll dup 1 exch sub 3 -1 roll mul add srgb}
 
  bind def
 
/shd {dup dup currentrgbcolor 4 -2 roll mul 4 -2 roll mul
 
  4 -2 roll mul srgb} bind def
 
/$F2psBegin {$F2psDict begin /$F2psEnteredState save def} def
 
/$F2psEnd {$F2psEnteredState restore end} def
 

	
 
/pageheader {
 
save
 
newpath 0 579 moveto 0 0 lineto 367 0 lineto 367 579 lineto closepath clip newpath
 
-214.7 613.3 translate
 
1 -1 scale
 
$F2psBegin
 
10 setmiterlimit
 
0 slj 0 slc
 
 0.06000 0.06000 sc
 
} bind def
 
/pagefooter {
 
$F2psEnd
 
restore
 
} bind def
 
%%EndProlog
 
pageheader
 
%
 
% Fig objects follow
 
%
 
% 
 
% here starts figure with depth 50
 
% Polyline
 
0 slj
 
0 slc
 
7.500 slw
 
 [60] 0 sd
 
n 6000 600 m
 
 6000 10200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 7200 600 m
 
 7200 10200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 7800 600 m
 
 7800 10200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
15.000 slw
 
n 4200 1200 m 9000 1200 l 9000 4200 l 4200 4200 l
 
 cp gs col0 s gr 
 
% Polyline
 
7.500 slw
 
 [60] 0 sd
 
n 6600 600 m
 
 6600 10200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 9000 600 m
 
 9000 10200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 9600 600 m
 
 9600 10200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 1200 m
 
 9600 1200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 3600 m
 
 9600 3600 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 4200 m
 
 9600 4200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 4800 m
 
 9600 4800 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 5400 m
 
 9600 5400 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 6000 m
 
 9600 6000 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3675 6600 m
 
 9675 6600 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 7200 m
 
 9600 7200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 7800 m
 
 9600 7800 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 8400 m
 
 9600 8400 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 9000 m
 
 9600 9000 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 9600 m
 
 9600 9600 l gs col1 s gr  [] 0 sd
 
% Polyline
 
15.000 slw
 
n 3600 600 m 9600 600 l 9600 10200 l 3600 10200 l
 
 cp gs col0 s gr 
 
% Polyline
 
n 4800 4200 m 8400 4200 l 8400 7200 l 4800 7200 l
 
 cp gs col0 s gr 
 
% Polyline
 
7.500 slw
 
 [60] 0 sd
 
n 4200 600 m
 
 4200 10200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
15.000 slw
 
n 5400 1500 m 7800 1500 l 7800 2700 l 5400 2700 l
 
 cp gs col0 s gr 
 
% Polyline
 
7.500 slw
 
 [60] 0 sd
 
n 6300 1200 m
 
 6300 4200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 6900 1200 m
 
 6900 4200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 8700 1200 m
 
 8700 4200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 5100 4200 m
 
 5100 7200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 5700 4200 m
 
 5700 7200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 6300 4200 m
 
 6300 7200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 6900 4200 m
 
 6900 7200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 7500 4200 m
 
 7500 7200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
n 8546 3900 m 8554 3900 l gs col0 s gr
 
% Polyline
 
 [60] 0 sd
 
n 8100 1200 m
 
 8100 4200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4200 3300 m
 
 9000 3300 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4200 2100 m
 
 9000 2100 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 8700 1200 m
 
 8700 4200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4200 1500 m
 
 9000 1500 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 8100 4200 m
 
 8100 7200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4800 5100 m
 
 8400 5100 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 5400 m
 
 9600 5400 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4800 5700 m
 
 8400 5700 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4800 6300 m
 
 8400 6300 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4875 6900 m
 
 8475 6900 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4800 4500 m
 
 8400 4500 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 5400 600 m
 
 5400 10200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4800 600 m
 
 4800 10200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 7500 1200 m
 
 7500 4200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
15.000 slw
 
n 7800 1800 m 8400 1800 l 8400 3000 l 7800 3000 l
 
 cp gs col0 s gr 
 
% Polyline
 
7.500 slw
 
 [60] 0 sd
 
n 8400 600 m
 
 8400 10200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4800 1950 m
 
 8400 1950 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4800 2250 m
 
 8400 2250 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4800 2550 m
 
 8400 2550 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 5100 1200 m
 
 5100 4200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 7800 2850 m
 
 8400 2850 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 5400 1650 m
 
 7800 1650 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 1800 m
 
 9600 1800 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4200 2700 m
 
 9000 2700 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 5700 1200 m
 
 5700 4200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4200 3900 m
 
 9000 3900 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4500 1200 m
 
 4500 4200 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 2400 m
 
 9600 2400 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 3600 3000 m
 
 9600 3000 l gs col1 s gr  [] 0 sd
 
% Polyline
 
15.000 slw
 
n 5400 1800 m 4800 1800 l 4800 3000 l 5400 3000 l
 
 cp gs col0 s gr 
 
% Polyline
 
7.500 slw
 
 [60] 0 sd
 
n 4800 2850 m
 
 5400 2850 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 4950 1800 m
 
 4950 3000 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 5250 1800 m
 
 5250 3000 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 7950 1800 m
 
 7950 3000 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 8250 1800 m
 
 8250 3000 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 7650 1500 m
 
 7650 2700 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 7050 1500 m
 
 7050 2700 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 6750 1500 m
 
 6750 2700 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 6450 1500 m
 
 6450 2700 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 6150 1500 m
 
 6150 2700 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 5850 1500 m
 
 5850 2700 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 5550 1500 m
 
 5550 2700 l gs col1 s gr  [] 0 sd
 
% Polyline
 
 [60] 0 sd
 
n 7350 1500 m
 
 7350 2700 l gs col1 s gr  [] 0 sd
 
/Times-Roman ff 300.00 scf sf
 
3975 9975 m
 
gs 1 -1 sc (a) col0 sh gr
 
/Times-Roman ff 300.00 scf sf
 
5100 6600 m
 
gs 1 -1 sc (ab) col0 sh gr
 
/Times-Roman ff 300.00 scf sf
 
4500 3825 m
 
gs 1 -1 sc (ac) col0 sh gr
 
/Times-Roman ff 300.00 scf sf
 
4875 2775 m
 
gs 1 -1 sc (aca) col0 sh gr
 
/Times-Roman ff 300.00 scf sf
 
5700 2400 m
 
gs 1 -1 sc (acb) col0 sh gr
 
/Times-Roman ff 300.00 scf sf
 
7850 2775 m
 
gs 1 -1 sc (acc) col0 sh gr
 
% here ends figure;
 
pagefooter
 
showpage
 
%%Trailer
 
%EOF
doc/figures/grids.fig
Show inline comments
 
new file 100644
 
#FIG 3.2  Produced by xfig version 3.2.5b
 
Landscape
 
Center
 
Inches
 
Letter  
 
100.00
 
Single
 
-2
 
1200 2
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 6000 600 6000 10200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 7200 600 7200 10200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 7800 600 7800 10200
 
2 2 0 2 0 7 50 -1 -1 0.000 0 0 -1 0 0 5
 
	 4200 1200 9000 1200 9000 4200 4200 4200 4200 1200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 6600 600 6600 10200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 9000 600 9000 10200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 9600 600 9600 10200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 1200 9600 1200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 3600 9600 3600
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 4200 9600 4200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 4800 9600 4800
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 5400 9600 5400
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 6000 9600 6000
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3675 6600 9675 6600
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 7200 9600 7200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 7800 9600 7800
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 8400 9600 8400
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 9000 9600 9000
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 9600 9600 9600
 
2 2 0 2 0 7 50 -1 -1 0.000 0 0 -1 0 0 5
 
	 3600 600 9600 600 9600 10200 3600 10200 3600 600
 
2 2 0 2 0 7 50 -1 -1 0.000 0 0 -1 0 0 5
 
	 4800 4200 8400 4200 8400 7200 4800 7200 4800 4200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4200 600 4200 10200
 
2 2 0 2 0 7 50 -1 -1 0.000 0 0 -1 0 0 5
 
	 5400 1500 7800 1500 7800 2700 5400 2700 5400 1500
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 6300 1200 6300 4200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 6900 1200 6900 4200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 8700 1200 8700 4200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 5100 4200 5100 7200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 5700 4200 5700 7200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 6300 4200 6300 7200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 6900 4200 6900 7200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 7500 4200 7500 7200
 
2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 1
 
	 8550 3900
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 8100 1200 8100 4200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4200 3300 9000 3300
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4200 2100 9000 2100
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 8700 1200 8700 4200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4200 1500 9000 1500
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 8100 4200 8100 7200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4800 5100 8400 5100
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 5400 9600 5400
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4800 5700 8400 5700
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4800 6300 8400 6300
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4875 6900 8475 6900
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4800 4500 8400 4500
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 5400 600 5400 10200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4800 600 4800 10200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 7500 1200 7500 4200
 
2 2 0 2 0 7 50 -1 -1 0.000 0 0 -1 0 0 5
 
	 7800 1800 8400 1800 8400 3000 7800 3000 7800 1800
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 8400 600 8400 10200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4800 1950 8400 1950
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4800 2250 8400 2250
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4800 2550 8400 2550
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 5100 1200 5100 4200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 7800 2850 8400 2850
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 5400 1650 7800 1650
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 1800 9600 1800
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4200 2700 9000 2700
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 5700 1200 5700 4200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4200 3900 9000 3900
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4500 1200 4500 4200
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 2400 9600 2400
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 3600 3000 9600 3000
 
2 2 0 2 0 7 50 -1 -1 0.000 0 0 -1 0 0 5
 
	 5400 1800 4800 1800 4800 3000 5400 3000 5400 1800
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4800 2850 5400 2850
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 4950 1800 4950 3000
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 5250 1800 5250 3000
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 7950 1800 7950 3000
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 8250 1800 8250 3000
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 7650 1500 7650 2700
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 7050 1500 7050 2700
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 6750 1500 6750 2700
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 6450 1500 6450 2700
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 6150 1500 6150 2700
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 5850 1500 5850 2700
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 5550 1500 5550 2700
 
2 1 1 1 1 7 50 -1 -1 4.000 0 0 -1 0 0 2
 
	 7350 1500 7350 2700
 
4 0 0 50 -1 0 18 0.0000 2 135 135 3975 9975 a\001
 
4 0 0 50 -1 0 18 0.0000 2 195 270 5100 6600 ab\001
 
4 0 0 50 -1 0 18 0.0000 2 135 255 4500 3825 ac\001
 
4 0 0 50 -1 0 18 0.0000 2 135 390 4875 2775 aca\001
 
4 0 0 50 -1 0 18 0.0000 2 195 390 5700 2400 acb\001
 
4 0 0 50 -1 0 18 0.0000 2 135 375 7850 2775 acc\001
doc/figures/grids.png
Show inline comments
 
new file 100644
 
binary diff not shown
Show images

Changeset was too big and was cut off... Show full diff anyway

0 comments (0 inline, 0 general)