From d6faa5ffcedf7544563836f105e382418a3366e5 2014-07-04 17:10:21 From: Margreet Nool Date: 2014-07-04 17:10:21 Subject: [PATCH] install arcos --- diff --git a/Makefile b/Makefile new file mode 100644 index 0000000000000000000000000000000000000000..6b20ccf9cfad96ae61429e1da5053484ef3f6687 --- /dev/null +++ b/Makefile @@ -0,0 +1,27 @@ +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 + + diff --git a/Makefile.config b/Makefile.config new file mode 100644 index 0000000000000000000000000000000000000000..89a15685bbd549a2e0749077b7beda62ec91db0f --- /dev/null +++ b/Makefile.config @@ -0,0 +1,38 @@ +# 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 + diff --git a/Makefile.inc b/Makefile.inc new file mode 100644 index 0000000000000000000000000000000000000000..0d7ffd36e27bae7c9d394095c9ec58e519d85ef5 --- /dev/null +++ b/Makefile.inc @@ -0,0 +1,43 @@ +# 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) + diff --git a/README b/README new file mode 100644 index 0000000000000000000000000000000000000000..979575645f17e000c710a79151e7d5168032c603 --- /dev/null +++ b/README @@ -0,0 +1,19 @@ +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:///????? diff --git a/arcos_f90/src/Makefile b/arcos_f90/src/Makefile new file mode 100644 index 0000000000000000000000000000000000000000..9e890d614bb55c4824a1f88c1d17c1dea67f8816 --- /dev/null +++ b/arcos_f90/src/Makefile @@ -0,0 +1,28 @@ + +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) *~ diff --git a/arcos_f90/src/cdr_advect_diffu_vec.f90 b/arcos_f90/src/cdr_advect_diffu_vec.f90 new file mode 100644 index 0000000000000000000000000000000000000000..691d4b3470a69a2b0d22070d385a99bbe732e3ec --- /dev/null +++ b/arcos_f90/src/cdr_advect_diffu_vec.f90 @@ -0,0 +1,414 @@ +!> @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 + + ! + d_iso0 = diffusion_coeff / mass + ! + + 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= 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= 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 diff --git a/arcos_f90/src/cdr_advect_diffu_wrap.c b/arcos_f90/src/cdr_advect_diffu_wrap.c new file mode 100644 index 0000000000000000000000000000000000000000..fafb06ba677a043afb5a31d2bd5a4e95a2587634 --- /dev/null +++ b/arcos_f90/src/cdr_advect_diffu_wrap.c @@ -0,0 +1,42 @@ +/** @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; + +} + diff --git a/doc/README b/doc/README new file mode 100644 index 0000000000000000000000000000000000000000..63a738232383c685cdbf942a47220a1ec2b5e6dc --- /dev/null +++ b/doc/README @@ -0,0 +1,3 @@ +Use jannis versie van doxygen: + +/ufs/teunisse/progs/doxygen-1.8.2/bin/doxygen diff --git a/doc/doxygen_config_file b/doc/doxygen_config_file new file mode 100644 index 0000000000000000000000000000000000000000..db5dbac88c81707e85c0d1b50906ab4d9d23e316 --- /dev/null +++ b/doc/doxygen_config_file @@ -0,0 +1,1624 @@ +# 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 , where is the value of +# the FILE_VERSION_FILTER tag, and 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 , where +# is the value of the INPUT_FILTER tag, and 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 +# +# Qt Help Project / Custom Filters. + +QHP_CUST_FILTER_ATTRS = + +# The QHP_SECT_FILTER_ATTRS tag specifies the list of the attributes this +# project's +# filter section matches. +# +# Qt Help Project / Filter Attributes. + +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 diff --git a/doc/figures/figure2.eps b/doc/figures/figure2.eps new file mode 100644 index 0000000000000000000000000000000000000000..178dcff66edca5014536b2f2e5991f6bce4a7c9b --- /dev/null +++ b/doc/figures/figure2.eps @@ -0,0 +1,1921 @@ +%!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: (), 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\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: (), 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\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: (), 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\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: (), 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\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 diff --git a/doc/figures/grids.eps b/doc/figures/grids.eps new file mode 100644 index 0000000000000000000000000000000000000000..702a60dc9c3f0626d9a668e3fb634fa2dedfbb8d --- /dev/null +++ b/doc/figures/grids.eps @@ -0,0 +1,435 @@ +%!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 diff --git a/doc/figures/grids.fig b/doc/figures/grids.fig new file mode 100644 index 0000000000000000000000000000000000000000..7493527f5040419b343cdbfb81dcbb1bd49897c1 --- /dev/null +++ b/doc/figures/grids.fig @@ -0,0 +1,167 @@ +#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 diff --git a/doc/figures/grids.png b/doc/figures/grids.png new file mode 100644 index 0000000000000000000000000000000000000000..56194e7a75aab56cfc2e5a1816629914f62e0c13 GIT binary patch literal 5100 zcmb_Adpy(Y|4$c3rP4W_=;C(jTa-kup)3xe5~-9+RBlPy5M$Vir0CE|2s1(np-{_Z z9Lg;=w^$mJ>)eOU7#rVblk+;i-|zeT=lA+OukG`BKkw)Le%|-@vu6)2&KPgnuyX?d zV3Vndp(OyTkN~Xyecc*}VL3T-;A^d`zL`D%Z==L`S4H4_mA9p_0m!9D4a13?qlu*% z0GNFM+_?w9JVf0Y0>DQFfRQTz=sW{J5``~5dld2|TAV&_w6wGYX@uhfTmt}7E{`Sv zAT=EO0f02{vvCEG10W3mJOBp)KtX9x2mq-d}3 zcsT&1g)F&3V)$@h0pR=dKVS&12S6SGs&EG{05pYDs9}dt+*tsiGvWR<0Q3rN4+X$f zXg=hHs_t6Z?TQe86M%0*mZtz%0AMFHP*$iXBz^(_5rAs|+y}r(sA`7rX#l`sp@`E$ z(?C^91=I;VxNUjn98fDElQRq(GBVKJ4|abtbZP(I{i(IRr-%NzmC;s%@EOFUF=&Id z);zoK4Du8)(v8y^#z^G&%yF2^vC%j#w{L1{a4utx%}#ciVEw%Nf<;zW{Daw9mmVUu z@E&TmCXX2xW!DpeO?KndbJ(+!&EsWdW#3E2JijtVIra0Rw*sL~tFE0g zHUtkuq)p&tJ<7z|8@>gw2{=*bt_Q%DOQweU=l#BoCq=~VG1^g85>P{#peTOKeGps^ zR(}pw_;B-A$=hdtHfz{eu+<_^Wp%i+MId6zWASE5G~3C7fM&<>}7~ z=eDk&46#WeO1xlmZjNW}7R99wq!44zon&g_owcXv>CU950GBF)aX-6^dXd{r$eFp& z|6TN*6uaH)4fo^^M9VZfvYKamk}<-dl(x+x7p0lcqc`1zj0Ug zOYeCmDJO?LU680w%OLx^@}y+u(Y8YE$Kb6=|#G3cAk3I zDvD~(A~dDE8)P+($SSt0l+A_|GZsB23QXR8$g=x|Q}ES2sIzv^?rqbXPnaEvd=HHe zUStE=HA5tn^9;s8<0NfUZYT12)Lm8V7V+pP)t#xc)2Li6YIMOR{>;6Z>4THl-6YY&Zk*;h#^PIR5fB$+sWYkXf}ZM?VSWh|chyTtr<1s}d|zj+`_JKj~H z!`zuChsis|^av@43@2g=><{HM+VJYSI$XottBdk-##lzSHE%o6uM6p=bsgl72G(fLl4be`A6N@trWeC zz!Npxv2)cjO|8{3kK@T)yg;UT+#K!FYwxK|j);Mln*;HQr%2LC7j=@AWmx!|k&=r} z#qG$Xg_OQTx`Tp@_apiYl~yT!hSbI>64z;Ti4l0?1*@v}aASOlB(~{(Yf;Rx>5s{$ zYYOIzN;n}y9yQjDGoPXw&AEhRjJ}X% zWS3r6o|1RHOZRD|?JnPnYx`>MkMc#lV7+_9O0DS7m{!eZ+%B^}Iym<;f~EU9&KK51 zgEZ+_JET@4R~9w~HTmz)p8KZx6kRZJVS{Q=4s!+>Zj{bggy4R`bf6gDWQG9@wuB zc|)xaQsUM1Vr1{@mv0jZ%dF%ZvJ}P{(~~G`rRD{xr684|eHiiltB=@`VIj`%U_vP# zb!a;_lHuNe<;Z?RH-zW>;;l(;RvR}OwLR*nDf+7!LHd*9lC-?!^uC4Yw&5gu?MnM! z*$%@#eIG0OS(K@ibgzgD?Wx2x-kHEI=)eZ}g^uLG3nXzsZxM}is}F|8Ys8&@~;FOzZKEi#W3MXxryw_!>B3ttP4GmD4Ku#AIQW1=BG zRy&78C0pt)RN0d1n0OIxQgKdPKbqH?IEya34}mTi*&}@^M3;%|mVo>&nbYrS8I5Zk zW(d+#ZY942N#(_LDJ)(sE}HiB=hGZ<1q z(<0F3{nZInxr93AGw<2`uw)C6T63r_tErYJ7q+Bl6p{i z2n^jUIk~5QHtltKpSJW>o!(d7gu<9QX1d~nQ%R6JFL3A2)|0cz7p-c=*UUfIe z)OOpFbOSfsL&sNn=FoOE4AlYooAE=RhAwNICZkuXi&?$R?vD;C)6pO2K8uzp?IwRd zVC9&L!iLTKLK3SHmU=TcON5Co$PaIOrWk0y6&Fmu5m~^ajCSzRShr3bW2ApkH)php zf7)9soAIe!m2-zc=vs5bKcRcrLG`_PL--`o=_cG2+c;DshHFXLfT5Zpjb|NSn^uV- zzB89m|7$N>;6i0EPC+Lr;;FA`+ygw*L+}K7+CuBqdp>m;J8-ML!TMmiH}YZmrqKcG@8(Slq}6$C?hmjE4wmTV_jKR12bL(M0`?VOSr?orqpCBHm$3e^SC=R5jsa$QDjWK81JFPP!6o27%L8Ji^s99 zJsTF+l1A-%N?p1r7kkXT;89-bk7a0e1l`DWn$6^T_$DV@_exGcW6`WZvMuoz>9Kla zWMX%B@yyMZ(#Pkc2VbPW?cr4fv$E2#H;>@d2NyFsiilDS^t@!B!R^J)_$mj9EM8kM zOUsyl2}LN%^PBLVXm%_sKlM7!yZw4Wc>-qpF6Px2;+Tc(S>MAiatX~NGE~j^r;{O? zud>5DbHp+3gBMOBbLHzt&kbTKF-4_%FrJ(@`4S{_#D1TyHTfMSZ(A}xEk2S}`x5(j^M4?$?PXyy1YEL?pi5jK6^@FMG*|}6@zRsS2Ib4^Wg|pa4s-p)Lrxjf|$(2f-SC;Qi;|KLs%Fscb9bzmi=M{N#XA+x$-m^ zoMx*@`EMIA?uz~BLKr^5!f~WhE%UnK+*S_}(mMfeGgn$^Ia`;BzHPu-*y*uEq?3+6|aA!2IX%)<0!la|uxOEgMl zh%h28E?VX`oI@8Q zXL?I?nagOaV*7p6=qdCC(H?DqQBM(>`Y=yo4sa`U&L8L(b-%lTTVZntMn({-isb8x zLpj1c6GTDw%a160H!l=Krj*P~XQU%O)HG{y^a-80QjA{Q`v^oHZRmHbv5qqDp|7Bl zB)QTh!t_GC5~P=974J;UazI~MVly_!92h{4Sp1NLvOi}FOG08!U#XO|M8RokX{9NA zGf7DDWR)v?Gfns-JwZLdlvO6eD0aZdX3WBN|0v?>$D;lnjAL5!A2{-;Y1n!r-4W~L zWpnv*wP6sN?$Ie<1E(xqxQJ->YO<~OOzOTHEl%Z1KNjbuz=jq&%G-<&gjNY|EwEjG z@Biq7742UmOvit+%YOO6zKXlthx$p2WtxWme;hmjEI3aioU@5=jL`ZD$->{6mo7Q6ro zz~zntH5TB0cuvrn%nO$r(0?}X|6=!#JEFEg7HRpqC~OCRiQf?7mM^8yEq`~9dV#e+ zbowC?5(|v`j|*pCqY;q{qcYAx7O&7+;o<>3b8lVU&9`ZXjyfZ^tj)O_=a{!UW4U;D zE7#Z?op~#Jbo*^J5=|m+y}V>7BdFMzFIQRm!JrwlV{;!Mbv-v>`W;zUDT667_><0W zpFA^r-R~%-<^9l>Gl#+(-C+fSCGu=YTmKJd&aL!ALAX~U0JCK|$M7Rv5#gQ}YCEPL z^<8hssq-geH~woou5BI{wO;H7_SD2h_-Di3+eVjeJ6*l)tmEkA3|~N1<*=HPil&mP z=J~@KI;ux>4r?f?sOqSwyhNS8{9hP6kWOwc{{K4zRf*jL8Ds?#P~JKwZkEp821uV< zPHwkc4Um37O;gKHLrYsxMNy?_JPZCg1f+hDo_6+iz6tc5kk_1*)DEf08Cje=ApkZc SqDuN89WXUIW0-4jCHUXagcm&k literal 0 HcmV?d00001 diff --git a/doc/figures/refinement_cdr.eps b/doc/figures/refinement_cdr.eps new file mode 100644 index 0000000000000000000000000000000000000000..9ed9e7c630cf335203896cfe87c267c568b0b289 --- /dev/null +++ b/doc/figures/refinement_cdr.eps @@ -0,0 +1,3230 @@ +%!PS-Adobe-3.0 EPSF-3.0 +%%Creator: GIMP PostScript file plugin V 1.17 by Peter Kirchgessner +%%Title: refinement_cdr.eps +%%CreationDate: Wed Oct 17 15:54:20 2012 +%%DocumentData: Clean7Bit +%%LanguageLevel: 2 +%%Pages: 1 +%%BoundingBox: 14 14 846 579 +%%EndComments +%%BeginProlog +% Use own dictionary to avoid conflicts +10 dict begin +%%EndProlog +%%Page: 1 1 +% Translate for offset +14.173228346456694 14.173228346456694 translate +% Translate to begin of first scanline +0 563.92625145683508 translate +830.89133858267724 -563.92625145683508 scale +% Image geometry +1108 752 8 +% Transformation matrix +[ 1108 0 0 752 0 0 ] +% Strings to hold RGB-samples per scanline +/rstr 1108 string def +/gstr 1108 string def +/bstr 1108 string def +{currentfile /ASCII85Decode filter /RunLengthDecode filter rstr readstring pop} +{currentfile /ASCII85Decode filter /RunLengthDecode filter gstr readstring pop} +{currentfile /ASCII85Decode filter /RunLengthDecode filter bstr readstring pop} +true 3 +%%BeginData: 151350 ASCII Bytes +colorimage +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[eka8c-hb5_Hkb5_HkJ\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd]R8f"h7bOT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd]R8f"h7bOT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[eka8c-hb5_Hkb5_HkJ\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd]R8f"h7bOT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd]R8f"h7bOT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[eka8c-hb5_Hkb5_HkJ\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd]R8f"h7bOT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd]R8f"h7bOT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[NIZSqSA>.(JUl4"J\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqSA>+(JUl4"J\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqSA>+(JUl4"J\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqSA>.(JUl4"J\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqSA>+(JUl4"J\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqSA>+(JUl4"J\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqSA>.(JUl4"J\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqSA>+(JUl4"J\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqSA>+(JUl4"J\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[eka8c-hb5_Hkb5_HkJ\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd]R8f"h7bOT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd]R8f"h7bOT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[eka8c-hb5_Hkb5_HkJ\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd]R8f"h7bOT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd]R8f"h7bOT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[eka8c-hb5_Hkb5_HkJ\]jPrW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd]R8f"h7bOT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd]R8f"h7bOT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_HkkPtOs +kPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +kPtOskPtOskPtOskPtOskPtOskPtM]OT5:[UAo`~> +YQ'I[NIZSqSA>.(JUi<%W.9a*UAo`~> +YQ'I[NIZSqSA>+(JUi<%W.9a*UAo`~> +YQ'I[NIZSqSA>+(JUi<%W.9a*UAo`~> +YQ'I[NIZSqSA>.(JUi<%W.9a*UAo`~> +YQ'I[NIZSqSA>+(JUi<%W.9a*UAo`~> +YQ'I[NIZSqSA>+(JUi<%W.9a*UAo`~> +YQ'I[NIZSqSA>.(JUi<%W.9a*UAo`~> +YQ'I[NIZSqSA>+(JUi<%W.9a*UAo`~> +YQ'I[NIZSqSA>+(JUi<%W.9a*UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[eka8c-hb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd`/krd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd`/krd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[eka8c-hb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd`/krd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd`/krd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[eka8c-hb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd`/krd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd`/krd`/krd`/krd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNb5_Hkb5_Hkb5_Hk +b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_Hkb5_Hkb5_Hk +b5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[NIZSqSA>.(JUi<%W.=jIOT5:[UAo`~> +YQ+S%OT5:[NIZSqSA>+(JUi<%W.=jIOT5:[UAo`~> +YQ+S%OT5:[NIZSqSA>+(JUi<%W.=jIOT5:[UAo`~> +YQ+S%OT5:[NIZSqSA>.(JUi<%W.=jIOT5:[UAo`~> +YQ+S%OT5:[NIZSqSA>+(JUi<%W.=jIOT5:[UAo`~> +YQ+S%OT5:[NIZSqSA>+(JUi<%W.=jIOT5:[UAo`~> +YQ+S%OT5:[NIZSqSA>.(JUi<%W.=jIOT5:[UAo`~> +YQ+S%OT5:[NIZSqSA>+(JUi<%W.=jIOT5:[UAo`~> +YQ+S%OT5:[NIZSqSA>+(JUi<%W.=jIOT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[eka8c-hJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd]R8f"h98b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd]R8f"h98b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[eka8c-hJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd]R8f"h98b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd]R8f"h98b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[eka8c-hJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd]R8f"h98b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\[ekrW(+@rd]R8f"h98b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOsXoJBNkPtOskPtOskPtOs +kPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtM]b5_HkkPtOskPtOs +kPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[UAo`~> +YQ'.RJH16$XoQLmJ\]jPNIZldUAo`~> +YQ'.RJH16$XoQLmJ\]jPNIZldUAo`~> +YQ'.RJH16$XoQLmJ\]jPNIZldUAo`~> +YQ'.RJH16$XoQLmJ\]jPNIZldUAo`~> +YQ'.RJH16$XoQLmJ\]jPNIZldUAo`~> +YQ'.RJH16$XoQLmJ\]jPNIZldUAo`~> +YQ'.RJH16$XoQLmJ\]jPNIZldUAo`~> +YQ'.RJH16$XoQLmJ\]jPNIZldUAo`~> +YQ'.RJH16$XoQLmJ\]jPNIZldUAo`~> +YQ+S%OT5:[OT5<1OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5<1OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5<1OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[a+/`Vf"d8qrW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[a+/`Vf"d8qrW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[a+/`Vf"d8qrW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[a+/`Vf"d8qrW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[a+/`Vf"d8qrW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[a+/`Vf"d8qrW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[a+/`Vf"d8qrW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[a+/`Vf"d8qrW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[a+/`Vf"d8qrW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkJ\]jPrd`/krd`/krW&&[rW&\mJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[b5_HkkPtOskPtOskPtOskPtOskPtOskPtO3b5_Hkb5_G@OT5:[ +UAo`~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +%%EndData +showpage +%%Trailer +end +%%EOF diff --git a/doc/figures/refinement_poisson.eps b/doc/figures/refinement_poisson.eps new file mode 100644 index 0000000000000000000000000000000000000000..36deedf03ec8868bd315fdfed7fcdf5901523e71 --- /dev/null +++ b/doc/figures/refinement_poisson.eps @@ -0,0 +1,3275 @@ +%!PS-Adobe-3.0 EPSF-3.0 +%%Creator: GIMP PostScript file plugin V 1.17 by Peter Kirchgessner +%%Title: refinement_poisson.eps +%%CreationDate: Wed Oct 17 16:05:37 2012 +%%DocumentData: Clean7Bit +%%LanguageLevel: 2 +%%Pages: 1 +%%BoundingBox: 14 14 846 585 +%%EndComments +%%BeginProlog +% Use own dictionary to avoid conflicts +10 dict begin +%%EndProlog +%%Page: 1 1 +% Translate for offset +14.173228346456694 14.173228346456694 translate +% Translate to begin of first scanline +0 570.67536882799402 translate +830.89133858267724 -570.67536882799402 scale +% Image geometry +1108 761 8 +% Transformation matrix +[ 1108 0 0 761 0 0 ] +% Strings to hold RGB-samples per scanline +/rstr 1108 string def +/gstr 1108 string def +/bstr 1108 string def +{currentfile /ASCII85Decode filter /RunLengthDecode filter rstr readstring pop} +{currentfile /ASCII85Decode filter /RunLengthDecode filter gstr readstring pop} +{currentfile /ASCII85Decode filter /RunLengthDecode filter bstr readstring pop} +true 3 +%%BeginData: 152519 ASCII Bytes +colorimage +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[NIZSqJ\\5"JUj/=rW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqJ\\5"JUj/=rW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqJ\\5"JUj/=rW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqJ\\5"JUj/=rW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqJ\\5"JUj/=rW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqJ\\5"JUj/=rW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqJ\\5"JUj/=rW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqJ\\5"JUj/=rW&&[rW&\mJ,~> +YQ+S%OT5:[NIZSqJ\\5"JUj/=rW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ'I[NIZSqJ\\5"JUj/=M?'CNJ,~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkJ\ZiPW5/C_b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[b5_Hkb5_HkkPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOskPtOs +kPtO3b5_Hkb5_Hkb5_Hkb5_G@OT5:[UAo`~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[JUi<%JUi<%JUksprW&&[rW&\mJ,~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ+S%OT5:[b5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_Hkb5_G@OT5:[ +UAo`~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ+S%OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[OT5:[UAo`~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +YQ'.RJH16$JH16$JH16$h>j;MJ,~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +JcC<$JcC<$JcC<$JcC<$XoEn~> +%%EndData +showpage +%%Trailer +end +%%EOF diff --git a/doc/figures/structure.eps b/doc/figures/structure.eps new file mode 100644 index 0000000000000000000000000000000000000000..1060783b09965d9648cf40cdb1c8f01987f64790 --- /dev/null +++ b/doc/figures/structure.eps @@ -0,0 +1,255 @@ +%!PS-Adobe-3.0 EPSF-3.0 +%%Title: structure.fig +%%Creator: fig2dev Version 3.2 Patchlevel 5d +%%CreationDate: Tue Jul 9 11:13:13 2013 +%%For: greta@timor.sen.cwi.nl (Margreet Nool) +%%BoundingBox: 0 0 560 308 +%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 308 moveto 0 0 lineto 560 0 lineto 560 308 lineto closepath clip newpath +-71.3 252.7 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 +n 3000 3600 m 5100 3600 l 5100 4200 l 3000 4200 l + cp gs col0 s gr +/Times-Roman ff 300.00 scf sf +3300 3975 m +gs 1 -1 sc (doc) col0 sh gr +% Polyline +n 2400 2700 m 4500 2700 l 4500 3300 l 2400 3300 l + cp gs col0 s gr +/Times-Roman ff 300.00 scf sf +2700 3075 m +gs 1 -1 sc (python) col0 sh gr +% Polyline +n 6600 3600 m 8700 3600 l 8700 4200 l 6600 4200 l + cp gs col0 s gr +/Times-Roman ff 300.00 scf sf +6900 3975 m +gs 1 -1 sc (input) col0 sh gr +% Polyline +gs clippath +3434 820 m 3275 876 l 3295 933 l 3454 877 l 3454 877 l 3331 889 l 3434 820 l cp +eoclip +n 5850 0 m + 3300 900 l gs col0 s gr gr + +% arrowhead +15.000 slw +n 3434 820 m 3331 889 l 3454 877 l 3434 820 l cp gs 0.00 setgray ef gr col0 s +% Polyline +7.500 slw +gs clippath +3991 1674 m 3868 1788 l 3909 1832 l 4032 1718 l 4032 1718 l 3924 1778 l 3991 1674 l cp +eoclip +n 5850 0 m + 3900 1800 l gs col0 s gr gr + +% arrowhead +15.000 slw +n 3991 1674 m 3924 1778 l 4032 1718 l 3991 1674 l cp gs 0.00 setgray ef gr col0 s +% Polyline +7.500 slw +gs clippath +4540 2550 m 4466 2700 l 4520 2726 l 4594 2577 l 4594 2577 l 4514 2671 l 4540 2550 l cp +eoclip +n 5850 0 m + 4500 2700 l gs col0 s gr gr + +% arrowhead +15.000 slw +n 4540 2550 m 4514 2671 l 4594 2577 l 4540 2550 l cp gs 0.00 setgray ef gr col0 s +% Polyline +7.500 slw +gs clippath +5102 3444 m 5067 3608 l 5126 3620 l 5160 3456 l 5160 3456 l 5107 3568 l 5102 3444 l cp +eoclip +n 5850 0 m + 5100 3600 l gs col0 s gr gr + +% arrowhead +15.000 slw +n 5102 3444 m 5107 3568 l 5160 3456 l 5102 3444 l cp gs 0.00 setgray ef gr col0 s +% Polyline +7.500 slw +gs clippath +8245 877 m 8404 933 l 8424 876 l 8265 820 l 8265 820 l 8369 889 l 8245 877 l cp +eoclip +n 5850 0 m + 8400 900 l gs col0 s gr gr + +% arrowhead +15.000 slw +n 8245 877 m 8369 889 l 8265 820 l 8245 877 l cp gs 0.00 setgray ef gr col0 s +% Polyline +7.500 slw +gs clippath +7667 1718 m 7790 1832 l 7831 1788 l 7708 1674 l 7708 1674 l 7776 1778 l 7667 1718 l cp +eoclip +n 5850 0 m + 7800 1800 l gs col0 s gr gr + +% arrowhead +15.000 slw +n 7667 1718 m 7776 1778 l 7708 1674 l 7667 1718 l cp gs 0.00 setgray ef gr col0 s +% Polyline +7.500 slw +gs clippath +7112 2592 m 7179 2726 l 7233 2700 l 7166 2565 l 7166 2565 l 7193 2686 l 7112 2592 l cp +eoclip +n 5850 0 m + 7200 2700 l gs col0 s gr gr + +% arrowhead +n 7112 2592 m 7193 2686 l 7166 2565 l 7112 2592 l cp gs 0.00 setgray ef gr col0 s +% Polyline +gs clippath +6543 3472 m 6573 3620 l 6632 3608 l 6601 3460 l 6601 3460 l 6597 3584 l 6543 3472 l cp +eoclip +n 5850 0 m + 6600 3600 l gs col0 s gr gr + +% arrowhead +n 6543 3472 m 6597 3584 l 6601 3460 l 6543 3472 l cp gs 0.00 setgray ef gr col0 s +% Polyline +n 8400 900 m 10500 900 l 10500 1500 l 8400 1500 l + cp gs col0 s gr +% Polyline +n 7800 1800 m 9900 1800 l 9900 2400 l 7800 2400 l + cp gs col0 s gr +% Polyline +n 7200 2700 m 9300 2700 l 9300 3300 l 7200 3300 l + cp gs col0 s gr +% Polyline +n 4905 -900 m 4800 -900 4800 -105 105 arcto 4 {pop} repeat + 4800 0 6795 0 105 arcto 4 {pop} repeat + 6900 0 6900 -795 105 arcto 4 {pop} repeat + 6900 -900 4905 -900 105 arcto 4 {pop} repeat + cp gs col0 s gr +% Polyline +n 1200 900 m 3300 900 l 3300 1500 l 1200 1500 l + cp gs col0 s gr +% Polyline +n 1800 1800 m 3900 1800 l 3900 2400 l 1800 2400 l + cp gs col0 s gr +/Times-Roman ff 300.00 scf sf +8100 2175 m +gs 1 -1 sc (src) col0 sh gr +/Times-Roman ff 300.00 scf sf +8700 1275 m +gs 1 -1 sc (arcos_f90) col0 sh gr +/Times-Roman ff 300.00 scf sf +5400 -525 m +gs 1 -1 sc (ARCoS) col0 sh gr +/Times-Roman ff 300.00 scf sf +5400 -225 m +gs 1 -1 sc (Makefiles) col0 sh gr +/Times-Roman ff 300.00 scf sf +1500 1275 m +gs 1 -1 sc (FISH90) col0 sh gr +/Times-Roman ff 300.00 scf sf +2100 2175 m +gs 1 -1 sc (output) col0 sh gr +/Times-Roman ff 300.00 scf sf +7500 3075 m +gs 1 -1 sc (include) col0 sh gr +% here ends figure; +pagefooter +showpage +%%Trailer +%EOF diff --git a/doc/figures/structure.fig b/doc/figures/structure.fig new file mode 100644 index 0000000000000000000000000000000000000000..b574dde8bdbd7bfa5daa0c44f479de23a77f5645 --- /dev/null +++ b/doc/figures/structure.fig @@ -0,0 +1,69 @@ +#FIG 3.2 Produced by xfig version 3.2.5b +Landscape +Center +Inches +Letter +100.00 +Single +-2 +1200 2 +6 3000 3600 5100 4200 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 3000 3600 5100 3600 5100 4200 3000 4200 3000 3600 +4 0 0 50 -1 0 18 0.0000 2 210 435 3300 3975 doc\001 +-6 +6 2400 2700 4500 3300 +6 2400 2700 4500 3300 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 2400 2700 4500 2700 4500 3300 2400 3300 2400 2700 +-6 +4 0 0 50 -1 0 18 0.0000 2 270 840 2700 3075 python\001 +-6 +6 6600 3600 8700 4200 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 6600 3600 8700 3600 8700 4200 6600 4200 6600 3600 +4 0 0 50 -1 0 18 0.0000 2 255 630 6900 3975 input\001 +-6 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 2.00 60.00 120.00 + 5850 0 3300 900 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 2.00 60.00 120.00 + 5850 0 3900 1800 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 2.00 60.00 120.00 + 5850 0 4500 2700 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 2.00 60.00 120.00 + 5850 0 5100 3600 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 2.00 60.00 120.00 + 5850 0 8400 900 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 2.00 60.00 120.00 + 5850 0 7800 1800 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 1.00 60.00 120.00 + 5850 0 7200 2700 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 1.00 60.00 120.00 + 5850 0 6600 3600 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 8400 900 10500 900 10500 1500 8400 1500 8400 900 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 7800 1800 9900 1800 9900 2400 7800 2400 7800 1800 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 7200 2700 9300 2700 9300 3300 7200 3300 7200 2700 +2 4 0 1 0 7 50 -1 -1 0.000 0 0 7 0 0 5 + 6900 0 6900 -900 4800 -900 4800 0 6900 0 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 1200 900 3300 900 3300 1500 1200 1500 1200 900 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 1800 1800 3900 1800 3900 2400 1800 2400 1800 1800 +4 0 0 50 -1 0 18 0.0000 2 135 360 8100 2175 src\001 +4 0 0 50 -1 0 18 0.0000 2 240 1200 8700 1275 arcos_f90\001 +4 0 0 50 -1 0 18 0.0000 2 195 930 5400 -525 ARCoS\001 +4 0 0 50 -1 0 18 0.0000 2 210 1230 5400 -225 Makefiles\001 +4 0 0 50 -1 0 18 0.0000 2 195 960 1500 1275 FISH90\001 +4 0 0 50 -1 0 18 0.0000 2 240 780 2100 2175 output\001 +4 0 0 50 -1 0 18 0.0000 2 210 900 7500 3075 include\001 diff --git a/doc/figures/structure.fig.bak b/doc/figures/structure.fig.bak new file mode 100644 index 0000000000000000000000000000000000000000..26ba88dedb96de6f33a8ab21f6394c6f1bf61342 --- /dev/null +++ b/doc/figures/structure.fig.bak @@ -0,0 +1,73 @@ +#FIG 3.2 Produced by xfig version 3.2.5b +Landscape +Center +Inches +Letter +100.00 +Single +-2 +1200 2 +6 1200 900 3300 1500 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 1200 900 3300 900 3300 1500 1200 1500 1200 900 +4 0 0 50 -1 0 18 0.0000 2 195 1470 1500 1275 FISHPACK\001 +-6 +6 3000 3600 5100 4200 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 3000 3600 5100 3600 5100 4200 3000 4200 3000 3600 +4 0 0 50 -1 0 18 0.0000 2 210 435 3300 3975 doc\001 +-6 +6 2400 2700 4500 3300 +6 2400 2700 4500 3300 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 2400 2700 4500 2700 4500 3300 2400 3300 2400 2700 +-6 +4 0 0 50 -1 0 18 0.0000 2 270 840 2700 3075 python\001 +-6 +6 1800 1800 3900 2400 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 1800 1800 3900 1800 3900 2400 1800 2400 1800 1800 +4 0 0 50 -1 0 18 0.0000 2 270 1275 2100 2175 output_dir\001 +-6 +6 6600 3600 8700 4200 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 6600 3600 8700 3600 8700 4200 6600 4200 6600 3600 +4 0 0 50 -1 0 18 0.0000 2 255 630 6900 3975 input\001 +-6 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 2.00 60.00 120.00 + 5850 0 3300 900 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 2.00 60.00 120.00 + 5850 0 3900 1800 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 2.00 60.00 120.00 + 5850 0 4500 2700 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 2.00 60.00 120.00 + 5850 0 5100 3600 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 2.00 60.00 120.00 + 5850 0 8400 900 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 2.00 60.00 120.00 + 5850 0 7800 1800 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 1.00 60.00 120.00 + 5850 0 7200 2700 +2 1 0 1 0 7 50 -1 -1 0.000 0 0 -1 1 0 2 + 1 1 1.00 60.00 120.00 + 5850 0 6600 3600 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 8400 900 10500 900 10500 1500 8400 1500 8400 900 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 7800 1800 9900 1800 9900 2400 7800 2400 7800 1800 +2 2 0 1 0 7 50 -1 -1 0.000 0 0 -1 0 0 5 + 7200 2700 9300 2700 9300 3300 7200 3300 7200 2700 +2 4 0 1 0 7 50 -1 -1 0.000 0 0 7 0 0 5 + 6900 0 6900 -900 4800 -900 4800 0 6900 0 +4 0 0 50 -1 0 18 0.0000 2 210 900 7500 3075 include\001 +4 0 0 50 -1 0 18 0.0000 2 135 360 8100 2175 src\001 +4 0 0 50 -1 0 18 0.0000 2 240 1200 8700 1275 arcos_f90\001 +4 0 0 50 -1 0 18 0.0000 2 195 930 5400 -525 ARCoS\001 +4 0 0 50 -1 0 18 0.0000 2 210 1230 5400 -225 Makefiles\001 diff --git a/doc/figures/structure.pdf b/doc/figures/structure.pdf new file mode 100644 index 0000000000000000000000000000000000000000..78654cafb0a50f6da000f7338437c9afad38f8da GIT binary patch literal 7521 zcmb_B2|QHm+m%vHH!2}2ofeJAoH;WXBl}t+LY6EUGlOBwOtUZ)WvMh}FS|B-DJrCd zkQ)gtmL!qNa<8nVEaf`~ZTH^)_y4}%@6P;wGw=Jn&-Omsd*0{Bn(G@XLKr2K?1TP@ zODJUk3ounhy`d!qjRZj05qhNxKw>AnMt8)YN9w?HkIUs;wPuu zv@yh>75<-WK8FQ0R>^d1n13*)^P<-lnU%)5kxC!7-tXYJjz#AX1k#t}+ojq#_5F5( zCpnp>@QYDRvgVhpoSI!|uWi!rhi;ddyS4X!IeVw_?)`RZ zX(Q83`{4^$jbbasqIV<0KcLi@*YNtQB$c!0Stf_O} zCdS*N`pz*^L9NYYXY#rQ2Ng%OEN{mvZeF~};ofS~1!*74Z}}M*X&0Wes6AtHKjfoq z;V4h0&*OlB>SjWyAU!+q<#`18Mg|CtN;T z4^<25t5mM#9j4sXTPFMFwp6j#yhVYFt3_qkk6?!R(*+?p?O6#+U#11m-;nr)+2^#M z*s!M}Vxx402m3xV^Hk%}Gl9g@FOC7byk9JC@!6YM&h`q|d%wj0gokZ{wpx~om*)b< zy*4H}9p%8JT;JaI;(HdpM*XPZ7GLzFKTFq4b4&&j1fqE<#q>)9k)qtqJy(*lbqF@Q4CPbRFcZ}So*^9GG z9aid;=xrRcfI_up?S|(?9_t#;YnC`+LkPOc+bns5PpXeuSez2q`nV-5%4b*TVAk?m zNrg(sWO#drhrWu1>jjQIjoPkvNY&$kLHH-Gr*F8+I;l+?u50%Pw?{8@N_6SjAU@Kp zcPjaLbN#LKgr&WqH(WY3_`pKX7HL7UkfBk{*xA=YY~}h%XTJusIxAm+hSXYlkMA~J>@-%gsegTR8#J(NQhx=p>WR1GE7^Mn ziylU~ofRqC*RwZqBoO%2{&g}ZNl0vAV!sRo<-h#V=3J1>IKb=KHnW280EbLGTf zT-DGJL_bfXcGvY4H%Ud{x+HlYK0e4jRhv{*RaqWl=$M zk{cB?rBY}lT_zu}$HL3XDp&xIRdqzci)<=`3*eE=M}Zbp4wJ_wQ#o)=FlRH#mQ=1i z2v-dNw4(C4FuDPsYh=lV>jD5Fd|(noCQJ@NGZVN>fO_y8=Ewn%@?wF4L33&$B4*1C z%njBHm{E)afV*iF4q%T$)V4r50x$<2!ty6lg!^2jnx)huaY=Nh+cy?-+M80jBnrF& zK(l}!vI)O3_^}NXXl8B-K$@C!O3v(RPLu@!h0t02U^BDLZ>y>()n8YU>D;0&i9JVRAkc7r0z+W|0uBe`sHh-&fIY5^L<$1K;}Pp1UsY8^I2Oj8 z#hb;MUHkPH<_=>iDIq>Wei3QN|12+Lh9e-`|8;~=ArLs$V3~MW8iF+oL7?ym2`L7A z!q6CQ@b(xw3=Zx4+>+VbyfPH-1!3R-}c zAPFRc6p#wKg6<#<^aSZ317y$`RFDa>KsLw$xgZbZF(_0vhs+A!-&*wk9zn`6< z_w9iJ4=Jf?YJPt-@Uo`aTDrZ^gtiPGOjS(yEyKM+Rovc&`^SRPhP1LBo zojYxXLUJPWN>;>b?_99u#!hYXG`fe5RbyBFoBaJ(+l5m+{R%A0a&36sNj*a)Q}JRc zgA)Odrid-X9*x06=XwGLCIe(d-W7y)u~cg>;cljnuid=5wT9g=D*SsyWsbxBoGzD5 z=cn7IFt6n0bApT4fp5B~PHxs1v!TFTr{HTg_dd&4y<-WI{B&0nWqlL+q!xW;%0#FR zH&1+A`*pf5wzJcD`b_k+{cs1muE8X3a&aEPINKyDM)9m<|BxuDEVc$`HlA5)%*Ks; ziLtay&pzk%qy|Teo&IWK=ej3cw{P0D+WxD(kkBnU1#AnaxMr^Io-7M}IUTy`xz-~s z-9#t3-Sv~7#08hE2ci^o*&|~;l2g})oY^(mmDx}8PlrCL-fqWo0SvBYgj>9BT-ylA zNAKTlu=hdstt@ws^#yT))UmxuS>_&EyrXJ6zX<%|{E|?qB9^(9#n~-c`?d?tNXn*b z_Dn^S54^p#v!M6TweU%|+%>s7)Ildu>uByfErZM_>(!1j4y?<2UPP&ju8|$x{VY~O z(f_`cZ$l|=Nqg%pN8obiJIp~J6w>prYl*lw7Q$2 z+_sh;U7HubSmbN(M00Y6L(aic}T%N>7{$iHw*Vk5v3GJUDe%s}mkZ(*`Z6NCLZ zFI8L%@}9i3@T|%&wp)+hSg^#XR~b5+FO6F#m*LbdIN`1up;^?}sutQ;!)Vo68ntO% z#=a^)O=I4LB4I~`b7>bBeo;Q?Y8GU|>pl8;HzntkLQSL5S;2EH>6eeJ37LcTc}Hp& z;bXRJ(GqnqyMKRha^BGV^O@5^E<^28LgNYgS60-wJDFLpe06BCcV-4JLQYoD_tb1y zW8#E@&%nu&9)joA_@2${RHO#ftMr%EYS&nfm_D>{T#2dlxOoS+a4UX$<89wHH~XyKhQG_IvL$T1r_fyk=0;U#4E?wb%h21N=?n=MHTlNsxbO4a?$2 zWZ=-!63v(T%NAIf2QD1sU1%@Zukcl4x&7l~&)SbeCY8~H_m(x^yK?b}on%71kNVz` zB?*6oE8z3@%CF36Q|v!4b!W<%EqQS%f#FkK6M8Y=IzgRuWo)fv&nS^0HhSkVgK^EP zifhK9T?&a`8LliX+V|XJ&HCP>cJJ;HXma{OZ!Al~>coYw6q%BhTe0o$-F-ym9TRFs zg8UCg51Jb|a!Geo?#3%VQSJ|E-Rmxc@t&Ca{KzJ<{H8#&2tA`Le>>d1 zJgmgUw#E(Wx4Ol=cPHW z<22XSqY=yHt6vijl#}!F7K$BSHBYH5{dfARwY4Tx!(b)(ZKe6q66(!sO@9}(9Ngzs za63`rFgwhlhdF3=M}zoMLqo24|5;yoy^Rv-*@upRfuEu}hs_R0+)2R_=S!v}A5jlZ zaC3-Uuu@m4;?vb;Bh&ntWCg>B)7BayzVqLD2M-WrfCl1|0mG|dXXmHg`;9n!-a3A0 znu|JVC^P?+fCUZad-iL7>UP#jvfmM-C7aWU?!6i(J9LI_5Tql1$Fj-e-gTuX8*{QA zyMG`a!#S#CSl+CU*tPKeknGaO7ep`jdn9Ye2ta=9sYP`js^k~>xOdC8_Ekt+{l(vBG1S4jmZ^PQZI19fj!UUQ= z5^g(Mklwa^1mK>3{qdlm%)x}F6>_IVO&cQaaXT;O&eJG6IQZwrB+aV^Pi@`za?d1} zU%Hu6e=Xs$Lfab`!BfjE*G~$B_-NCBukW^YI!V)Z5Vj1w_Z}PT$S9fi87~w3p5Ux@ z?qJW6y2J7gq139JX9H7l@t;)kTmowH52>^T8y0ehL*HT=qbxGQjk*Nm9ahh|e6S=> z4hupvHsUvBR6df+^H5x)~J#ed!f&#D37;R-XcAD zl=tUD-R;us~~^P=06d*}=wb#>okyeRv6PNiGFuZN@-CkXa>4D_Zudmn!tB zxPF{25}tR08JJmdz4pudL9*Xvw1$;#*9uMN$1?bm{>}&XCK6Limk;+2*0gjiHLKT3 z1dbt6YL(_WfWY`peQsx zkaUnY6s@)Y!0)L2>iqcqn0e~?bVDIeC;E|413b^%(A76D3=Fjkbvw7D-MV(kU2g>% zIR{59u}zLlBJDp=7j!7R?nw5Vpk=XIqvKtzxpsuf9U=VVg1Wux%C*tWYW7}u30|3d zxJQWIZxdf+faN0Gyo-0MMhV&rwhEuANDf+X?9$D9?JZ5MJ(%9;n~#bzq~y5}Md{f) z&frq_fD!Q=%BG&+5aR%9pi^#z@FP^C?lR%`G+ONTvMtG3YKje!XSci&<3G^f!avp# zwr;W7!}fBbKcs{^$M8IPcgqap%1L+&haYPF_lwP@{~p~vk;9q6Y+We zL~UF{*~y9coFcTHzk=_A1DVXz%R6o>StkeR9LCh1Ym=x~c^UUkl+7w7p#y!dMVb~A zE_xQM_<~;(6un;S@?~B1n4`^s0uQsM?DwC8mQ<|x9FyAp@XqBs@|?5PF4!d2B1dc2 zrzcM}0X{=wbvUMN%Q7L8rNF6pn6%FV_(jfrnLt2S)g`GHUCM2kUENEgQAwhk2TRMJ{{4HaceR^grMG zzTNhJ+)ZpvO}<@BASD(2_lt?T7N12Tds4Z83vwUQKo1s|p#d6218t*hiZx~FQQc`f z{n%7XzdcrDKTk4|g4WVRscVto4hvP0Phu&;7bmzS$^qaTpvERW3lqal2m)V?@5S*&0fT5@28HXXfwna@2e?co-IK-za2O&6QiSl^0arGBQ}to8 zJpl-#f`(bLDXwZ3@cnF-Aw1JSyK}iLH4yai@xl1uF-*1_2oZ@y5Q_tGI7Jvkk>ktY zlK6@Y&SqHNj3PAK?_>-PW=1Crndt@6Y(WTv1-}XU)`g%k82}=f|utKpRuusAg=Rvr8cChUBeR1a>6!!7dv1L;qgKan!oR&YpYy3*Wm z6sk914Tl)w3p@q~n3K3b0(7ZTqH zo|-ZR75up>~jd#m_k-_WwO0UaG;Y| zEVzY3;=(ou;Q&Qzs>6$18kbJhoJm9-I(K$Jry+@@Mkg`cG|+rS3e}awqjS+n&}o{pgBfD*2Sa#7M#6>3p58l}`jU`}-5Cq|8k{XT0qG2>R`Tq+B zd^4d_<$m$>H}*`n+<#477*~hKb%#;^gOeS8^|HgZZQq;Gd^Xh;Zo5KCD5UhxegG9^ zWxO)r3e3SExIP0jO90~=Ohr}cZ!ic_hFh-4=La4ZK1cor!$NT5{;zndf1`zP1h^Ue zD;|U={EZeO;Qs;d?=m2~(%)!tSOVO%{#AxD{^$L2*(A7$$%bEH0-z<$4}L451b`My zCj9yU>4XB{E`}=;nCXhb9b0|CUY!6b>+9(1>gy{R>JSWx$~wAOq6!|bqNHP}tgNe~ er1{@59FaE@94?8?opBHWtE!5Ul{GLkMEwuewdfrH literal 0 HcmV?d00001 diff --git a/doc/figures/structure.png b/doc/figures/structure.png new file mode 100644 index 0000000000000000000000000000000000000000..20f0b133b2b0b1ab60e9caf928ec1ca90f9e03fb GIT binary patch literal 9633 zcmb7qcT`l*v*$2?1c`%W$pexZf*?6b9?3b!At%XSkf2B$avHLd5dj4x4ag`N29Tgg zRx(OPa(dU_@9pl}vv1GY{bSCZuI{d`d%NmWRb3sgtF1;#%s>nRfk-vfAM1laU>FF5 zBSwe^P*72yynzRvv*Hs)5a@l%-77nMppE0Fucid58@;~;G*}(f^`C%1|8Rjok3WDo#@_1LyUO%)uY35eczu;ol%_Z{ zm4&buG7c#cqBxP2I!!vf;enJ)vOwDmi^WY5Hyo5 z2r}`&jz7(RGaXi>l~Dq+{p0hCb^upj>b8Lgf@a+Nk;0DJ}dd(dL9Gub?KIq3!GtDU}ptghf*Uj8J_d2A{2IXRFrD11^r z!Jx1o!hJq!a2Dm9NZ}YVX1f#Kl(^8{oN=De(>gT+vhinW^GfOVXkzuqek}ibPniY| z1e~!JsTTG;s(k=@R@f<&45pBO3 zDS}dNO{XdhcY;1WFAPv=K!MZQQl4i0!=IwaJh0N6o3k3V)6Dlo1-~L|fGWfa+0l6O zHK*UcXW+M%uPM*%onkrj-y9*NXQ+-(HCNANz#;tgM~sjAt*b408C2Xj*SlF`oP)E- z-xk~uF0IlZJqXOosSLXvce^F(LRe=D9XMR^A=X80t!d8i=Ynd)XsJ;rhg=b2N|1f>0Me%(+F+Be~AEQ$dF@*cEKP>n>Q^teh4esKJ_fm4}HnZQ7%YG(p8#h}j}vaa zU2w1M529kxeJA+IwzSMcx?qmWTb@1)N6{fG-$CF7t@nQNCyWE!{2PXkj#+3_ZqaPf zF~z3lcJbI{=rs)-eGc89#yR7=s{P=6Biu!J2s*1f=LzXq5@&(kGAUT&SZ7rpX4W5I zjpw(5B!rquuO!Z&gebVF@z5qng;*qom`Qc0G2`CyP$&0_%0CbqH2BzRe3ilX`2hFo zz%1a&BFWIl=}{(63Fqn{&)k?A1n}rCI+BAkhgKwEYqA zA}S|1;nTiUN-&0zZgHKc-XS>2BpA1QBN#(PvbW!Z;aL1+dnS@XBD4IE#Af|{lv)^l zw|hqqhqaFTJb!Utbue}^WVO03bh=a{_V~`G-aanhj#l=a9MbCh+dN0ySyl4^UYQ#Q zGMfu;fiZQ;Iaq(BmbLg{`rd-ke`g;h+*z-||EJmfx8ypP4F(PkeyekxBkPZe^{}7v zN7;Z<`rU>YiMK;7`|@Yn zegeWcFcI82Ps2PUF|vW`Af6B<0;5WeiyS-3xUx|7M^T{MDN^EmtX2O4m!3HAAGA5* zq-+oN6L@w*TMRSUdYY&+P@DTH;odQJDsV2V0(ghFtdwkwxW#a5B_$a@(&b6vX-Mim zEQ`*R30{rm)&jhgEt>$<9j$RtYIJTJ{+8d9X&Jm!!4^b2kMKJmf)sIgJwa+}RN_V| zx4J|UjfT2<$|I`=kq>qgw`~i}rt9|QzFaE!>(3>{-{uZ$A-bYrEK=p-BynoR`3r*9 zNuoTwFxsJikS@+dDbZ2%if&yfMvZK*`8HBNQ+u(|vMP)v-JEcVY`L+c@`Yu7uD^lC z;Ap_c3yyNphPC?4n z%dc5;1x^bnv%92|dV_2W=LZ{w^mFV&)<*kp#b5rK)=@NW1=YvE^wbqV#QH?SZ%&S0 zT^|3~(oAo?Ef(MvW^i_s1{^fI4bo-IJt(ewK72+1HYW}j=iF9O6lKlo*J2oV`s<+MGez0D?buNUFS9nXpFh4#VQo)83-_*NJLsBxDY!ZB;0obB7> z8|d2QkJ>KUYVhpdK3u)$me`kT9!-p#%sg_MXR^1xusI=3wasBcga?{r>qm*Z7F1JL zVIFCQOny5Vu{E0&ip4{;koxhzWDS}V8(n?$>xFN!fx~0z-{ymlW`hwwBP55iS?*x4 zt8C9C4ea4U0hU@eD{!w88l-Xo6(GaXjpe4%C1;PknBk0P_v)ZN?-%1FQOS5>B**Fq z2e0l5TZq{~SEN536Fg~tD|WDGI9DmPaU^eSm5vvdv~fi@K58x@k}O_i_1;F|VoNiS z!0k74RgGc%;B1{Qml}XRu&>Y3$OzJ>cXGM~7vJ{aFjklXFB1CYQ3h@mMl9Ve7TmvH z?eSfRx$s!#S7H4YGqDz}4%@&pA>g}<@xn+;v2^1_d>&5sJ!QIFyYBlQ2+l4@LfO7* zAlF47(o>`QbOV8nF-i^}pWdN0wc^kcx#5pdvC%07e`YwxBcYTkOhEGR z@W~ae&<1VbMi`2-(urqH?I<@dju`1gBV3aIi-SEKCe3SikgXnk?j~WNc%^LPE}E9l z%gN=5FX4)W1I$4FagIstFKXMqjV$bUmC=0irQIv>c%aj<)xlp54tnd$^}7mVis|!z zAJ(WRel5g0{#2sO(nOM%dCifBy45d9)a)^Sh4Gsd%AJm1i^$TXrxqt#;k0|pH_5ZG zV=ZJ~?)Gc20o8F&+=->+#&pPB_@L;ZS7TTaj&81*CjM-NZ^f)$RCUzhQ5>%;3UfpGt>-!To8yRix2HK*fa+!59#R$GIH^`j^Nas!;fEq z4Je;%VpOv0<{i2`c49J1E9S-FMt|AA@vTVEi{dG)K>g@7?ptu`+Fm5(QL}3EM7bFd zK5a2sfdhzXz#eG-ICS1IZ&gn$6tyMLqlKSmhYZ`sQljyvx!W2CAleRhdvL|;tyoC$p{uP_s zRZ<6RLG8q&NdOD(mGJ<^Tq|vd7?itQlZoQ->i(|IHn1R)Bw84EVf%El3{c#YH7sBw zMmN_f3Hk%%xK2CehWPFBlhsxD880e&<4&3m%4}|NPqgaFMaaKdeUEvcRc`p|8G|!# zG%=RaW1W)PWv%+KVfyxIm_*tA540!Uj`fWwrPRw&1{qy12rrB;uBDmAlLN5EIV;u` zmzAv0ogA6J?{bUB$Q5eU&3PvfeL-Ho6%<7$+wdYzBA(<97;@1Q+&q_Avw+h*X|AdM z^v8@Bk>`<4?MpJIxjm23Y*qg)h;zz~5KB<$(v)8nKCYuOl4aQ}yl^RS_>Zjf&4A)1 z=d_o)WSwsb>15`;=j^rki$5wuVnXGnEQRz(z8kl4-GAIMI5+cxrC}lOxqy!Lb*GGd zSM<@+s;EV91E~Y6V0XfsgUS71fy*O-4-OM6^mAZm#)DOpkSywgvq?a4+?NqN>JzQYx-sBGpOSmRgczrLdEkhr`JxgoPj{SxT6?f3J@7P>qsLmrmJ zvoC$+&9M8$%JtGrIj;1`=J4oP*`Zf>UCwBxZ-iLt*uI~h^7Eai zPE*T0)3LF8OkLR1_51SJtK+lgr6a1jT@Mz%jYXkFf)#d7EJSiUA}SKH!C$-*J7^uD zZ1Vijylm zs3T7l+@3vYxD^Pvl`|U)6kncC#y*;i!4Vaecnq0de7Z(rXj`BNhSX^dY{S+a#o+}NN3oC0AEaFC(*rED5j2boo;pX z0y~*as__TdtVAB)%QV4BKL~?_+pzR)Z@t)cqZs2IY_z*M;(c=x6~5|Kt;##+vqXAg z+=Q@AQPb?4I7->iYXwgZ;#x#vCF)q2a*XAN)wX_5m>+jxdB(^yzJAN&=RDY8Rs|6$ zJU=hgcz02tRRD!8@0hN>Ch#}t&(Ed4us?eTp-I{re?iU2)iXzupZ8(waH7{crz11X zw@I(G@Enci9*=R=$xeqpR^YcvO-9mdVN-?U9y|lvZrZQD{r=n_iUeoBWg!v)ore0y zts+L+51e>ZrNvB@AY4aF#s|51JOgp2>+W%QJ_9@4R?7yoVs2bn+dilx+4Oe_lCT<7 zb!Pj?$J{|>spYn|y0PbEd*Y(16Zn37Y_K&Id)t8|`Y4i3^_AvtvZ}&&5%zUhYVx4` z*^2(l&7YGt2D9{~z3*@CG7RX(^vpN>DeTGht|V{|&sFZ~G(dQsk>(q`?6~*NW@xl@ zQKecOuGNr<@b7)G7Bq~+V&^rR_Tv|xuH|)Ls`bkFo1=33{fvhe9M(THP^-)u%`Jzd zgvQL+(dbnNo6LM=AZoQqdEEB<=YuMH-}117(k4fNAhTZCqBcSkm7u)SOKOK!o3Q%q zrA$YgCGQ(w?R&1>F_aNria_445&N(=zV)HW)+Yh$^;mkQnlX4QIA+&E*a?Uorp$Y8 z^;3!~92xIej_HfY)}c}dPVU1hbE>%Ax%ND^PGlYU=k2z>Z7a?ajbtt&rYXIjC1mCL zyvWhs_sbbFE*@c$htxAi@knGhRek-*&q;(Gu=GWLSRc8!{zCp>!GgRJ8YL|Hxp$5t z-JD6<;LgcdXC`X!aM-B=iRyYS0pA>8uY-PayT?~M{-?FqFT~3^gkFvDnC89Bn}S}n zHoiD=(o9o0vdwNX=01!g%~UBq&dT2rNID=+)@fOu9|<*JbPy%nXE9JHbiOhGGBH+k zN)l|gCC5g2?cdX;Z_y(gwDqlarly~6w{gT$7P3p9kqX1Q{mFS)C(}MG5AjYXuV{bL zcX(+-0zDR}v-+yE7+vYDYNF_VcwxJ%L8zfl(lc+jS++-x6GR6;au(QYKb`pKIFnBa zF+LTipr8p_E4uwTy{~8ZK*%l){nqb6uiq)dBVE52`h>)tm!VzKc!Ilc6zqrQf&~KL z#_pf9WJJq^)jz*&h=1O@PWbf^hCfset2si|=IerPc0!+qhtBVuw=*LHhDILER-wOK zSsl0^Vag1bV{u0G-N<-h**vlfC4{gYtSHt#V5Ra9lNB14`i9Lw8prD?G2@L8# zWuT_x%WUo+XCs~!GTH_PyLr-m>CD_N0Xsyw0pV<&-h6m9LZWQN(5*Z2x0$9_DcC?d z%jtftLD+S>W}vc^_OUo}?%#A#BS60_*Y4eF8KK#jDxWg;ZSiwf0#RC){^=vB#~k05 zMzom3k-O!N1k@-79>0{*7t@lT!mIrO_EWaqo7S4*!P#lh4U^LQl@rL)0By6<*253M z!d9kj@s7DD>r21g=HB8^o{p@okw+{6V0z+ugo+9O27uf4;}B<`lVm%Uwf(d zSC7Sv^Os-fMpbA20vv2z(3@-h2!HA>DHrwIT#?wLqHH+9YBzWIxRNaqsvy6 z2u9V$%s0SUlp!>I>>J9rX>{wzMoH`L!|hk$jELNF==-ZTJD1*!<(?KLk-=dJL4%1` zf!B@pV|lmwm-@K`ZRLJSZ@SG;Y1lJ?#bF63kWzaqQ-#@H2Hc0sS(I$deD7k7G6|;5Ky$D#@TR9)&%Tm!x=$GzV|-M zInI$mK&aR#R^F`uW7``ee4FaMkrU~BUMU6Vy$eLesj0<3Ypz<~i*lTFTx}uRf^jUu z=|n~4hZ8%7Sk^W?yKp@f@hk32S>^{#qb6FPcLRaMyPvT**r}^~dn-C_?2eL|G!-8= z1JH|O1Onl`I%Zv7QH2Ys$p+I5LDKcIKQ+V8pL24-Oq`62mSs@OHB}$*HMR$bXHF7p zfl&^2a#-T7puy|5j&{I@NNv>FIJ*KWXqr!6nhE4UlbJsv-nRh$oB!M{^H4X+m+`^$ z(n#VgY_}A=0^67q$_`SN0>_SXCl`etnD%*dSWA)!^z|yH$E32xWDX`vYwq6H1=ei zYNIrF%3O(X?E!YtwTUzXEuTv%*-UP|RbBfk4a{LpNh)MK3r8N+jZa(&?VkBCxOX?b zmN$y0j!IMbe2pj%CduIy#EBF7`O)Ux@kD6-dhJL18+C9h<`a$q&xw}bUsKQUL?zuc zjhk?OUkYk*o87ENkG87rfH{i(5Je`F^x_h&YR9k^J+_D9D9MCrKr>B&Q}ow5#nSQQ zIdZ`tuzhLj7xPq+{*G8v`xxX-=kj-P}W5^SmB@l$EKn$5^+A zZYrhqJ~m8MXvd3o9Sfo{m{3e_oDa56XIt66wF~Sk8>=m#wDxueRQ$oh>*UPLh5}KWK z?pSxs80<}qJ$nRs4lmm4Gc!W4qPO0BDG{~Birc;9c!^TWe(qu z>+VtW7K+%as&#Bne+sdvn7ZO1z`xVtfx;1m#B*lG1#`GRYozr)ox%~lfJ8<6Gorl? z^?tFiTZ!6pr$G~)K8IpD=Y?^?;v<2&8thP0+L*hFXH){S;|!PYH>y}YD(%}9rIpj^BDwmr|X+^IF7kWamP zzBZ04i&oxk8?Yf?-t3-^)15FxDec~`YOmD*XHvj#ypBK59c- z1|9rM0n8i~z`ZX|1?OHYXA&7uDCS)*HDZ!C%JJz5lI5~HKngz~wqCiCFT z2U|@WUbAszX?bw`1CAU30+KK6@{)<+4%OV@t2g|M0aN6YE{3*wS`PuI6-(>(J!%#< zqKaSf+EDzqcMv!&C=rLh0Lo6hMk7lB;af*f00~5Z4rOl|5cOmL5R${Jv*iY>fi{HU*YqsNDT=gjGb(?+SX?;#mAs=^oliZDW1&O&2n z$L|0<@snq1=qO#QPz#3oDRc1Q@-My^VItWNI}EqjdPn3n>Dq2=%r2|EE}HI62;QA0C8fXMj;M5 zI}&gEjZ_4!yUGQvF<1Ou&wrvlTa?Yz@GH!&xR-tq@cH$$cQQ^;Vs(7_(T_V}NlHM^ z*;Ui!C8fp6<=L}c(*Ut$}l%Lt+h;Ys9ipl3Qv3bQ%9uAx+zoZ%aX_S{pj8*wkw~%@-NH?mD#9Thn#FdMd z14jFCHw^e-QY;71riB=-AMALl>}{p)Xli5EHT_)Yal5MA>93PdqcnDCL|e~rp4S*&UgHsJFUt zvDA#4`KK?C_2lmNRv01B?5!qqF^n)&(!n59$%mqN}fX4>ZD4dFmTfDGx_!p_w|CgnO%eeY{`EL ziNPvNtGLU$Q<1mGpC)}QFNm82X9$C@-b(i@XFT9WyUl9bxpPj_B-PKgGwO4CgzuUy z>1&tcgB>bTRW$xl;6EVB7@EDJ_So@K|Jpdwl9}NWg;7_((0Y+O!NKL|^G5~uTPN9qdSDG;DCXg)=3&A6g3Z(JdGytfHpitIKIw%)3m7*2Vqsy)_;nc_ZpK$yT zG=qS?!hO8FcR4R{VNBkdBh3{lM49-}=~9~^We4_c(5{cIPa&=)Bzz|=CE^vC5UHW~ zS`|B1U7`QvS=$No?yiNIZm93B&(hQ5#bG&yR!5Z>eB%@@Lp>aNl%0&0f66 zN$sD5r>!%;>;haL$v!q$VQ~`=C6Tkali!TfJz7b0;$G(Bv4NMOBnti1o#oxY|`VF7u<<7wZl1#JMu|N$Q>GP zYM@>?E?J#m?Vny~58%Q{3Aof0fPl`bM3eVG0Qj$x*`&U|1hgE;x0I=0Z$rRe+}tKc=oqyztp$@QUPF$ z@78*Uww!45FZiP9vKqU&rh?C2l(7?O@6 z(Hs3KVVR6p5C)-`z(siBmW8^s03LqAJw#k(+!Kh1T zELkv_(`*Xf1Ri`aT5X4O&*i%c!#y{J(`zg?topC zN58a$+vh+Ts-pMi@&C&mn*W0G|LexhY<{8`WI^?b9{Cx6{!3FITY>` o=;Q%Xbo91&5)c)Hv8w1AsQ&#!obQ8P0mgweRJ0%0DcL^%4`~P ... +\newenvironment{DoxyPre}{% + \small% + \begin{alltt}% +}{% + \end{alltt}% + \normalsize% +} + +% Used by @code ... @endcode +\newenvironment{DoxyCode}{% + + +\begin{scriptsize}\begin{alltt}% +}{% +\end{alltt}\end{scriptsize}% +} + +% Used by @example, @include, @includelineno and @dontinclude +\newenvironment{DoxyCodeInclude}{% + \DoxyCode% +}{% + \endDoxyCode% +} + +% Used by @verbatim ... @endverbatim +\newenvironment{DoxyVerb}{% + \footnotesize% + \verbatim% +}{% + \endverbatim% + \normalsize% +} + +% Used by @verbinclude +\newenvironment{DoxyVerbInclude}{% + \DoxyVerb% +}{% + \endDoxyVerb% +} + +% Used by numbered lists (using '-#' or
    ...
) +\newenvironment{DoxyEnumerate}{% + \enumerate% +}{% + \endenumerate% +} + +% Used by bullet lists (using '-', @li, @arg, or
    ...
) +\newenvironment{DoxyItemize}{% + \itemize% +}{% + \enditemize% +} + +% Used by description lists (using
...
) +\newenvironment{DoxyDescription}{% + \description% +}{% + \enddescription% +} + +% Used by @image, @dotfile, and @dot ... @enddot +% (only if caption is specified) +\newenvironment{DoxyImage}{% + \begin{figure}[H]% + \begin{center}% +}{% + \end{center}% + \end{figure}% +} + +% Used by @image, @dotfile, @dot ... @enddot, and @msc ... @endmsc +% (only if no caption is specified) +\newenvironment{DoxyImageNoCaption}{% +}{% +} + +% Used by @attention +\newenvironment{DoxyAttention}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @author and @authors +\newenvironment{DoxyAuthor}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @date +\newenvironment{DoxyDate}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @invariant +\newenvironment{DoxyInvariant}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @note +\newenvironment{DoxyNote}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @post +\newenvironment{DoxyPostcond}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @pre +\newenvironment{DoxyPrecond}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @copyright +\newenvironment{DoxyCopyright}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @remark +\newenvironment{DoxyRemark}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @return +\newenvironment{DoxyReturn}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @since +\newenvironment{DoxySince}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @see +\newenvironment{DoxySeeAlso}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @version +\newenvironment{DoxyVersion}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @warning +\newenvironment{DoxyWarning}[1]{% + \begin{DoxyDesc}{#1}% +}{% + \end{DoxyDesc}% +} + +% Used by @internal +\newenvironment{DoxyInternal}[1]{% + \paragraph*{#1}% +}{% +} + +% Used by @par and @paragraph +\newenvironment{DoxyParagraph}[1]{% + \begin{list}{}% + {% + \settowidth{\labelwidth}{40pt}% + \setlength{\leftmargin}{\labelwidth}% + \setlength{\parsep}{0pt}% + \setlength{\itemsep}{-4pt}% + \renewcommand{\makelabel}{\entrylabel}% + }% + \item[#1]% +}{% + \end{list}% +} + +% Used by parameter lists +\newenvironment{DoxyParams}[2][]{% + \begin{DoxyDesc}{#2}% + \item[] \hspace{\fill} \vspace{-40pt}% + \settowidth{\labelwidth}{40pt}% + \setlength{\LTleft}{0pt}% + \setlength{\tabcolsep}{0.01\textwidth}% + \ifthenelse{\equal{#1}{}}% + {\begin{longtable}{|>{\raggedleft\hspace{0pt}}p{0.15\textwidth}|% + p{0.815\textwidth}|}}% + {\ifthenelse{\equal{#1}{1}}% + {\begin{longtable}{|>{\centering}p{0.10\textwidth}|% + >{\raggedleft\hspace{0pt}}p{0.15\textwidth}|% + p{0.685\textwidth}|}}% + {\begin{longtable}{|>{\centering}p{0.10\textwidth}|% + >{\centering\hspace{0pt}}p{0.15\textwidth}|% + >{\raggedleft\hspace{0pt}}p{0.15\textwidth}|% + p{0.515\textwidth}|}}% + }\hline% +}{% + \end{longtable}% + \end{DoxyDesc}% +} + +% Used for fields of simple structs +\newenvironment{DoxyFields}[1]{% + \begin{DoxyDesc}{#1}% + \item[] \hspace{\fill} \vspace{-40pt}% + \settowidth{\labelwidth}{40pt}% + \setlength{\LTleft}{0pt}% + \setlength{\tabcolsep}{0.01\textwidth}% + \begin{longtable}{|>{\raggedleft\hspace{0pt}}p{0.15\textwidth}|% + p{0.15\textwidth}|% + p{0.635\textwidth}|}% + \hline% +}{% + \end{longtable}% + \end{DoxyDesc}% +} + +% is used for parameters within a detailed function description +\newenvironment{DoxyParamCaption}{% + \renewcommand{\item}[2][]{##1 {\em ##2}}% + }{% +} + +% Used by return value lists +\newenvironment{DoxyRetVals}[1]{% + \begin{DoxyDesc}{#1}% + \begin{description}% + \item[] \hspace{\fill} \vspace{-25pt}% + \setlength{\tabcolsep}{0.01\textwidth}% + \begin{longtable}{|>{\raggedleft\hspace{0pt}}p{0.25\textwidth}|% + p{0.77\textwidth}|}% + \hline% +}{% + \end{longtable}% + \end{description}% + \end{DoxyDesc}% +} + +% Used by exception lists +\newenvironment{DoxyExceptions}[1]{% + \begin{DoxyDesc}{#1}% + \begin{description}% + \item[] \hspace{\fill} \vspace{-25pt}% + \definecolor{tableShade}{HTML}{F8F8F8}% + \rowcolors{1}{white}{tableShade}% + \arrayrulecolor{gray}% + \setlength{\tabcolsep}{0.01\textwidth}% + \begin{longtable}{|>{\raggedleft\hspace{0pt}}p{0.25\textwidth}|% + p{0.77\textwidth}|}% + \hline% +}{% + \end{longtable}% + \end{description}% + \end{DoxyDesc}% +} + +% Used by template parameter lists +\newenvironment{DoxyTemplParams}[1]{% + \begin{DoxyDesc}{#1}% + \begin{description}% + \item[] \hspace{\fill} \vspace{-25pt}% + \definecolor{tableShade}{HTML}{F8F8F8}% + \rowcolors{1}{white}{tableShade}% + \arrayrulecolor{gray}% + \setlength{\tabcolsep}{0.01\textwidth}% + \begin{longtable}{|>{\raggedleft\hspace{0pt}}p{0.25\textwidth}|% + p{0.77\textwidth}|}% + \hline% +}{% + \end{longtable}% + \end{description}% + \end{DoxyDesc}% +} + +\newcommand{\doxyref}[3]{\textbf{#1} (\textnormal{#2}\,\pageref{#3})} +\newenvironment{DoxyCompactList} +{\begin{list}{}{ + \setlength{\leftmargin}{0.5cm} + \setlength{\itemsep}{0pt} + \setlength{\parsep}{0pt} + \setlength{\topsep}{0pt} + \renewcommand{\makelabel}{\hfill}}} +{\end{list}} +\newenvironment{DoxyCompactItemize} +{ + \begin{itemize} + \setlength{\itemsep}{-3pt} + \setlength{\parsep}{0pt} + \setlength{\topsep}{0pt} + \setlength{\partopsep}{0pt} +} +{\end{itemize}} +\newcommand{\PBS}[1]{\let\temp=\\#1\let\\=\temp} +\newlength{\tmplength} +\newenvironment{TabularC}[1] +{ +\setlength{\tmplength} + {\linewidth/(#1)-\tabcolsep*2-\arrayrulewidth*(#1+1)/(#1)} + \par\begin{xtabular*}{\linewidth} + {*{#1}{|>{\PBS\raggedright\hspace{0pt}}p{\the\tmplength}}|} +} +{\end{xtabular*}\par} +\newcommand{\entrylabel}[1]{ + {\parbox[b]{\labelwidth-4pt}{\makebox[0pt][l]{% + \usefont{OT1}{phv}{bc}{n}\color{darkgray}#1}\vspace{1.5\baselineskip}}}} +\newenvironment{Desc} +{\begin{list}{} + { + \settowidth{\labelwidth}{40pt} + \setlength{\leftmargin}{\labelwidth} + \setlength{\parsep}{0pt} + \setlength{\itemsep}{-4pt} + \renewcommand{\makelabel}{\entrylabel} + } +} +{\end{list}} +\newsavebox{\xrefbox} +\newlength{\xreflength} +\newcommand{\xreflabel}[1]{% + \sbox{\xrefbox}{#1}% + \setlength{\xreflength}{\wd\xrefbox}% + \ifthenelse{\xreflength>\labelwidth}{% + \begin{minipage}{\textwidth}% + \setlength{\parindent}{0pt}% + \hangindent=15pt\bfseries #1\vspace{1.2\itemsep}% + \end{minipage}% + }{% + \parbox[b]{\labelwidth}{\makebox[0pt][l]{\textbf{#1}}}% + }}% +\newenvironment{DoxyRefList}{% + \begin{list}{}{% + \setlength{\labelwidth}{10pt}% + \setlength{\leftmargin}{\labelwidth}% + \addtolength{\leftmargin}{\labelsep}% + \renewcommand{\makelabel}{\xreflabel}% + }% + }% +{\end{list}} +\newenvironment{DoxyRefDesc}[1] +{\begin{list}{}{% + \renewcommand\makelabel[1]{\textbf{##1}} + \settowidth\labelwidth{\makelabel{#1}} + \setlength\leftmargin{\labelwidth+\labelsep}}} +{\end{list}} +\newenvironment{Indent} + {\begin{list}{}{\setlength{\leftmargin}{0.5cm}} + \item[]\ignorespaces} + {\unskip\end{list}} +\setlength{\parindent}{0cm} +\setlength{\parskip}{0.2cm} +\addtocounter{secnumdepth}{2} +\usepackage[T1]{fontenc} +\makeatletter +\renewcommand{\paragraph}{\@startsection{paragraph}{4}{0ex}% + {-1.0ex}% + {1.0ex}% + {\usefont{OT1}{phv}{bc}{n}\color{darkgray}}} +\renewcommand{\subparagraph}{\@startsection{subparagraph}{5}{0ex}% + {-1.0ex}% + {1.0ex}% + {\usefont{OT1}{phv}{bc}{n}\color{darkgray}}} +\makeatother +\allsectionsfont{\usefont{OT1}{phv}{bc}{n}\selectfont\color{darkgray}} +\stepcounter{secnumdepth} +\stepcounter{tocdepth} +\definecolor{comment}{rgb}{0.5,0.0,0.0} +\definecolor{keyword}{rgb}{0.0,0.5,0.0} +\definecolor{keywordtype}{rgb}{0.38,0.25,0.125} +\definecolor{keywordflow}{rgb}{0.88,0.5,0.0} +\definecolor{preprocessor}{rgb}{0.5,0.38,0.125} +\definecolor{stringliteral}{rgb}{0.0,0.125,0.25} +\definecolor{charliteral}{rgb}{0.0,0.5,0.5} +\definecolor{vhdldigit}{rgb}{1.0,0.0,1.0} +\definecolor{vhdlkeyword}{rgb}{0.43,0.0,0.43} +\definecolor{vhdllogic}{rgb}{1.0,0.0,0.0} +\definecolor{vhdlchar}{rgb}{0.0,0.0,0.0} diff --git a/doc/latex_sty/sectsty.sty b/doc/latex_sty/sectsty.sty new file mode 100644 index 0000000000000000000000000000000000000000..9f7ecab2660a2546c8b38abe877a9133c31015af --- /dev/null +++ b/doc/latex_sty/sectsty.sty @@ -0,0 +1,601 @@ + +%% +%% This is file `sectsty.sty', +%% generated with the docstrip utility. +%% +%% The original source files were: +%% +%% sectsty.dtx (with options: `package') +%% +%% IMPORTANT NOTICE: +%% +%% For the copyright see the source file. +%% +%% You are *not* allowed to modify this file. +%% +%% You are *not* allowed to distribute this file. +%% For distribution of the original source see the terms +%% for copying and modification in the file sectsty.dtx. +%% +%% +%% \CheckSum{1463} +%% \CharacterTable +%% {Upper-case \A\B\C\D\E\F\G\H\I\J\K\L\M\N\O\P\Q\R\S\T\U\V\W\X\Y\Z +%% Lower-case \a\b\c\d\e\f\g\h\i\j\k\l\m\n\o\p\q\r\s\t\u\v\w\x\y\z +%% Digits \0\1\2\3\4\5\6\7\8\9 +%% Exclamation \! Double quote \" Hash (number) \# +%% Dollar \$ Percent \% Ampersand \& +%% Acute accent \' Left paren \( Right paren \) +%% Asterisk \* Plus \+ Comma \, +%% Minus \- Point \. Solidus \/ +%% Colon \: Semicolon \; Less than \< +%% Equals \= Greater than \> Question mark \? +%% Commercial at \@ Left bracket \[ Backslash \\ +%% Right bracket \] Circumflex \^ Underscore \_ +%% Grave accent \` Left brace \{ Vertical bar \| +%% Right brace \} Tilde \~} +\ProvidesPackage{sectsty}[1999/04/12 v2.0.1 Commands to change all +sectional heading styles] +\NeedsTeXFormat{LaTeX2e}[1998/06/01] +\long\def\SS@ocl#1#2#3{\ifnum #1>\SS@chatlevel #2\else #3\fi} +\def\SS@oclto#1#2{\SS@ocl{#1}{\typeout{#2}}{}} +\def\SS@chatlevel{3} +\DeclareOption{garrulous}{\def\SS@chatlevel{0}} +\DeclareOption{chatty}{\def\SS@chatlevel{1}} +\DeclareOption{taciturn}{\def\SS@chatlevel{2}} +\DeclareOption{yorkshire}{\def\SS@chatlevel{3}} +\ProcessOptions +\let\@svsec\relax +\newcommand{\nohang}{\let\@hangfrom\@empty} +\let\SS@origunderline\underline +\CheckCommand*{\underbar}[1]% + {\underline{\sbox\tw@{#1}\dp\tw@\z@\box\tw@}} +\newcommand*{\SS@ulemsectuline}[2]{% + \ifhmode% run-in head + \begingroup% + \def\hskip##1\relax##2\@@par{\endgroup\@@hskip##1\relax#1{##2}}% + \else% stand alone head + % \ifx\\\@centercr\let\@hangfrom\@empty\fi% deal with \@hangfrom prob + \protected@edef\@svsec{\noexpand#1{\@svsec\strut}}% added strut + \def\interlinepenalty##1##2\@@par{\@@interlinepenalty##1#1{##2}\@@par}% + \fi% + #2\@@par}% added strut here then removed it (stupid boy) +\let\@@hskip\hskip +\let\@@interlinepenalty\interlinepenalty +\CheckCommand*{\underline}[1]{% + \relax + \ifmmode\@@underline{#1}% + \else $\@@underline{\hbox{#1}}\m@th$\relax\fi} +\def\SS@underline#1{% + \relax + \ifmmode\@@underline{\strut#1}% + \else $\@@underline{\hbox{\strut#1}}\m@th$\relax\fi} + +\def\SS@ulemheadingchapfudge#1#2{% + \ifSS@komascript% + \ifnum\SSsectlevel=1% chapter level + \ifx\SS@headingpart\SS@nopartid% + \SS@oclto{1}{Koma-script chapter number part}% + \let\SS@savechapterformat\chapterformat% + \def\chapterformat{#1{\SS@savechapterformat}}% + \def\@tempcmda{#2}% + \else% + \SS@oclto{1}{Koma-script chapter title part}% + \def\@tempcmda{#1{#2}}% + \fi% + \else% + \SS@oclto{1}{Koma-script not chapter}% + \def\@tempcmda{#1{#2}}% + \fi% + \else% + \SS@oclto{1}{Not Koma-script}% + \def\@tempcmda{#1{#2}}% + \fi% + \@tempcmda +}% + +\AtBeginDocument{% + \@ifundefined{UL@box}% + {% if ulem has not been loaded + \SS@oclto{1}{ulem not loaded; underlining setup}% + \def\SS@makeulinesect{% + \def\underbar##1{\SS@origunderline{\sbox\tw@{##1}\dp\tw@\z@\box\tw@}}% + \def\underline{\SS@ulemsectuline{\SS@underline}}% + \def\ulemheading##1{\SS@ulemsectuline{\SS@underline}}}% + \def\SS@makeulinepartchap{% + \def\underbar##1{\SS@origunderline{\sbox\tw@{##1}\dp\tw@\z@\box\tw@}}% + \def\underline##1{\SS@ulemheadingchapfudge{\SS@underline}{##1}}% + \def\ulemheading##1##2{\SS@ulemheadingchapfudge{\SS@underline}{##2}}}% + }% endif ulem has not been loaded + {% If ulem has been loaded + \SS@oclto{1}{ulem loaded; underlining setup}% + \def\SS@makeulinesect{% + \def\underbar##1{\SS@origunderline{\sbox\tw@{##1}\dp\tw@\z@\box\tw@}}% + \def\underline{\SS@ulemsectuline{\uline}}% + \def\ulemheading##1##2{\SS@ulemsectuline{##1}{##2}}}% + \def\SS@makeulinepartchap{% + \def\underbar##1{\SS@origunderline{\sbox\tw@{##1}\dp\tw@\z@\box\tw@}}% + \def\underline##1{\SS@ulemheadingchapfudge{\uline}{##1}}% + \let\ulemheading\SS@ulemheadingchapfudge} + }% endif ulem has been loaded +}% end \AtBeginDocument +\def\SS@rr{\def\raggedright{% + \let\\\@centercr\@rightskip\@flushglue \rightskip\@rightskip}} +\newif\ifSS@komascript +\SS@komascriptfalse +\@ifclassloaded{scrartcl}{\SS@komascripttrue}{} +\@ifclassloaded{scrreprt}{\SS@komascripttrue}{} +\@ifclassloaded{scrbook} {\SS@komascripttrue}{} + +\newcommand{\SS@sectid}[1]{\gdef\SSsectlevel{#1}} +\newcommand{\SS@nopart}{\global\let\SS@headingpart\SS@nopartid} +\newcommand{\SS@titlepart}{\global\let\SS@headingpart\SS@titlepartid} +\newcommand{\SS@nopartid}{number part} +\newcommand{\SS@titlepartid}{title part} +\newcommand{\SSifnumberpart}{% + \ifx\SS@headingpart\SS@nopartid + \expandafter\@firstoftwo + \else + \expandafter\@secondoftwo + \fi} +\newcommand{\SSiftitlepart}{% + \ifx\SS@headingpart\SS@titlepartid + \expandafter\@firstoftwo + \else + \expandafter\@secondoftwo + \fi} +\def\ifraggedleft#1#2{% + \edef\@tempcmda{\the\rightskip}% + \edef\@tempcmdb{\the\z@skip}% + \ifx\@tempcmda\@tempcmdb\@tempswatrue\else\@tempswafalse\fi + \edef\@tempcmda{\the\leftskip}% + \edef\@tempcmdb{\the\@flushglue}% + \if@tempswa + \ifx\@tempcmda\@tempcmdb\@tempswatrue\else\@tempswafalse\fi + \fi + \if@tempswa#1\else#2\fi} +\def\ifcentering{% + \edef\@tempcmda{\the\rightskip}% + \edef\@tempcmdb{\the\@flushglue}% + \ifx\@tempcmda\@tempcmdb\@tempswatrue\else\@tempswafalse\fi + \edef\@tempcmda{\the\leftskip}% + \edef\@tempcmdb{\the\@flushglue}% + \if@tempswa + \ifx\@tempcmda\@tempcmdb\@tempswatrue\else\@tempswafalse\fi + \fi + \if@tempswa\expandafter\@firstoftwo\else\expandafter\@secondoftwo\fi} +\newcommand{\sectionrule}[5]{% + \ifcentering{% + \PackageError{sectsty}% + {Can't use \protect\sectionrule\space with \protect\centering}% + {The \protect\sectionrule\space command doesn't work properly + with sectional headings that\MessageBreak are centred, so I'll + carry on as if you'd not used the \protect\sectionrule\space + command.}#5}% + {\ifSS@komascript + \ifnum\SSsectlevel>1 + \SS@oclto{1}{KOMA-script; normal section rule}% + \SS@sectionrule{#1}{#2}{#3}{#4}{#5}% + \else + \SS@oclto{1}{KOMA-script; part/chap section rule}% + \SS@komapartchaprule{#1}{#2}{#3}{#4}{#5}% + \fi + \else + \SS@oclto{1}{No KOMA-script; normal section rule}% + \SS@sectionrule{#1}{#2}{#3}{#4}{#5}% + \fi}} +\def\SS@sectionrule#1#2#3#4#5{% + \ifraggedleft + {\SS@rlsectionrule{#1}{#2}{#3}{#4}{#5}}% + {\SS@normsectionrule{#1}{#2}{#3}{#4}{#5}}} +\def\SS@normsectionrule#1#2#3#4#5{% + \let\SS@@par\@@par\let\@@par\relax% very dodgy + \noindent\makebox[0pt][l]{\rule[#1]{\hsize}{#2}}% + #5\hfill\makebox[0pt][r]{\rule[#3]{\hsize}{#4}}% + \let\@@par\SS@@par\@@par} +\def\SS@rlsectionrule#1#2#3#4#5{% + \let\SS@@par\@@par\let\@@par\relax% very dodgy + \noindent\makebox[0pt][l]{\rule[#1]{\hsize}{#2}}\hfill% + #5\makebox[0pt][r]{\rule[#3]{\hsize}{#4}}% + \let\@@par\SS@@par\@@par} +\newif\ifSS@starform +\def\secdef#1#2{\@ifstar{\SS@starformtrue#2}{\SS@starformfalse\@dblarg{#1}}} +\def\SS@komapartchaprule#1#2#3#4#5{% + \ifraggedleft + {\SS@rlkomapartchaprule{#1}{#2}{#3}{#4}{#5}}% + {\SS@normkomapartchaprule{#1}{#2}{#3}{#4}{#5}}% +} +\def\SS@normkomapartchaprule#1#2#3#4#5{% + \SS@oclto{1}{SS@normkomapartchaprule}% + \ifSS@starform + \SS@normsectionrule{#1}{#2}{#3}{#4}{#5}% + \else + \SSifnumberpart + {\noindent\makebox[0pt][l]{\rule[#1]{\hsize}{#2}}#5}% + {#5\hfill\makebox[0pt][r]{\rule[#3]{\hsize}{#4}}}% + \fi +} +\def\SS@rlkomapartchaprule#1#2#3#4#5{% + \SS@oclto{1}{SS@rlkomapartchaprule}% + \ifSS@starform + \SS@rlsectionrule{#1}{#2}{#3}{#4}{#5}% + \else + \SSifnumberpart + {\noindent\makebox[0pt][l]{\rule[#1]{\hsize}{#2}}\hfill#5}% + {#5\makebox[0pt][r]{\rule[#3]{\hsize}{#4}}}% + \fi +} +\newcommand*{\partfont} [1] + {\gdef\SS@partnumberfont{\SS@sectid{0}\SS@nopart\SS@makeulinepartchap#1} + \gdef\SS@parttitlefont{\SS@sectid{0}\SS@titlepart\SS@makeulinepartchap#1}} +\newcommand*{\partnumberfont} [1] + {\gdef\SS@partnumberfont{\SS@sectid{0}\SS@nopart\SS@makeulinepartchap#1}} +\newcommand*{\parttitlefont} [1] + {\gdef\SS@parttitlefont{\SS@sectid{0}\SS@titlepart\SS@makeulinepartchap#1}} +\newcommand*{\chapterfont} [1] + {\gdef\SS@chapnumfont{\SS@sectid{1}\SS@nopart\SS@makeulinepartchap#1} + \gdef\SS@chaptitlefont{\SS@sectid{1}\SS@titlepart\SS@makeulinepartchap#1}} +\newcommand*{\chapternumberfont} [1] + {\gdef\SS@chapnumfont{\SS@sectid{1}\SS@nopart\SS@makeulinepartchap#1}} +\newcommand*{\chaptertitlefont} [1] + {\gdef\SS@chaptitlefont{\SS@sectid{1}\SS@titlepart\SS@makeulinepartchap#1}} +\newcommand*{\sectionfont} [1] + {\gdef\SS@sectfont{\SS@sectid{2}\SS@rr\SS@makeulinesect#1}} +\newcommand*{\subsectionfont} [1] + {\gdef\SS@subsectfont{\SS@sectid{3}\SS@rr\SS@makeulinesect#1}} +\newcommand*{\subsubsectionfont} [1] + {\gdef\SS@subsubsectfont{\SS@sectid{4}\SS@rr\SS@makeulinesect#1}} +\newcommand*{\paragraphfont} [1] + {\gdef\SS@parafont{\SS@sectid{5}\SS@rr\SS@makeulinesect#1}} +\newcommand*{\subparagraphfont} [1] + {\gdef\SS@subparafont{\SS@sectid{6}\SS@rr\SS@makeulinesect#1}} +\newcommand*{\minisecfont} [1] + {\gdef\SS@minisecfont{\SS@sectid{7}\SS@rr\SS@makeulinepartchap#1}} +\newcommand*{\allsectionsfont} [1] {\partfont{#1} + \chapterfont{#1} + \sectionfont{#1} + \subsectionfont{#1} + \subsubsectionfont{#1} + \paragraphfont{#1} + \subparagraphfont{#1} + \minisecfont{#1}} +\allsectionsfont{\relax} +\@tempswafalse +\@ifclassloaded{article} {\@tempswatrue\SS@oclto{1}{article detected}} {} +\@ifclassloaded{report} {\@tempswatrue\SS@oclto{1}{report detected}} {} +\@ifclassloaded{book} {\@tempswatrue\SS@oclto{1}{book detected}} {} +\@ifclassloaded{letter} {} {} +\@ifclassloaded{slides} {} {} +\@ifclassloaded{scrartcl}{\@tempswatrue\SS@oclto{1}{scrartcl detected}} {} +\@ifclassloaded{scrreprt}{\@tempswatrue\SS@oclto{1}{scrreprt detected}} {} +\@ifclassloaded{scrbook} {\@tempswatrue\SS@oclto{1}{scrbook detected}} {} + +\if@tempswa\else + \PackageError{sectsty}% + {The sectsty package doesn't work with\MessageBreak + this document class}% + {The sectsty package only works with the following classes: + \MessageBreak + the standard LaTeX document classes\MessageBreak + article, report, and book; and\MessageBreak + the KOMA-Script classes\MessageBreak + scrartcl, scrbook, and scrreprt.} +\fi +\@tempswafalse +\@ifclassloaded{article} {\@tempswatrue\SS@oclto{1}{article detected}} {} +\@ifclassloaded{report} {\@tempswatrue\SS@oclto{1}{report detected}} {} +\@ifclassloaded{book} {\@tempswatrue\SS@oclto{1}{book detected}} {} +\@ifclassloaded{letter} {} {} +\@ifclassloaded{slides} {} {} +\@ifclassloaded{scrartcl}{} {} +\@ifclassloaded{scrreprt}{} {} +\@ifclassloaded{scrbook} {} {} +\if@tempswa +\SS@oclto{1}{section->subparagraph modifications for article, report, +and book classes}% +\renewcommand\section{\@startsection {section}{1}{\z@}% + {-3.5ex \@plus -1ex \@minus -.2ex}% + {2.3ex \@plus.2ex}% + {\normalfont\Large\bfseries\SS@sectfont}} +\renewcommand\subsection{\@startsection{subsection}{2}{\z@}% + {-3.25ex\@plus -1ex \@minus -.2ex}% + {1.5ex \@plus .2ex}% + {\normalfont\large\bfseries\SS@subsectfont}} +\renewcommand\subsubsection{\@startsection{subsubsection}{3}{\z@}% + {-3.25ex\@plus -1ex \@minus -.2ex}% + {1.5ex \@plus .2ex}% + {\normalfont\normalsize\bfseries\SS@subsubsectfont}} +\renewcommand\paragraph{\@startsection{paragraph}{4}{\z@}% + {3.25ex \@plus1ex \@minus.2ex}% + {-1em}% + {\normalfont\normalsize\bfseries\SS@parafont}} +\renewcommand\subparagraph{\@startsection{subparagraph}{5}{\parindent}% + {3.25ex \@plus1ex \@minus .2ex}% + {-1em}% + {\normalfont\normalsize\bfseries\SS@subparafont}} +\fi +\@tempswafalse +\@ifclassloaded{article} {} {} +\@ifclassloaded{report} {} {} +\@ifclassloaded{book} {} {} +\@ifclassloaded{letter} {} {} +\@ifclassloaded{slides} {} {} +\@ifclassloaded{scrartcl}{\@tempswatrue\SS@oclto{1}{scrartcl detected}} {} +\@ifclassloaded{scrreprt}{\@tempswatrue\SS@oclto{1}{scrreprt detected}} {} +\@ifclassloaded{scrbook} {\@tempswatrue\SS@oclto{1}{scrbook detected}} {} +\if@tempswa +\SS@oclto{1}{section->minisec modifications for scrartcl, scrreprt, +and scrbook classes}% +\renewcommand\section{\@startsection{section}{1}{\z@}% + {-3.5ex \@plus -1ex \@minus -.2ex}% + {2.3ex \@plus.2ex}% + {\raggedsection\normalfont\size@section\sectfont\SS@sectfont}} +\renewcommand\subsection{\@startsection{subsection}{2}{\z@}% + {-3.25ex\@plus -1ex \@minus -.2ex}% + {1.5ex \@plus .2ex}% + {\raggedsection\normalfont\size@subsection\sectfont\SS@subsectfont}} +\renewcommand\subsubsection{\@startsection{subsubsection}{3}{\z@}% + {-3.25ex\@plus -1ex \@minus -.2ex}% + {1.5ex \@plus .2ex}% + {\raggedsection\normalfont\size@subsubsection\sectfont\SS@subsubsectfont}} +\renewcommand\paragraph{\@startsection{paragraph}{4}{\z@}% + {3.25ex \@plus1ex \@minus.2ex}% + {-1em}% + {\raggedsection\normalfont\size@paragraph\sectfont\SS@parafont}} +\renewcommand\subparagraph{\@startsection{subparagraph}{5}{\parindent}% + {3.25ex \@plus1ex \@minus .2ex}% + {-1em}% + {\raggedsection\normalfont\size@subparagraph\sectfont\SS@subparafont}} +\renewcommand\minisec[1]{\@afterindentfalse \vskip 1.5ex + {\parindent \z@ \raggedsection\sectfont\SS@minisecfont {#1}\par\nobreak}% + \@afterheading}% + \fi +%% Code from |report.cls| June 1996 +\@ifclassloaded{report}{% +\SS@oclto{1}{chapter modifications for report class}% +\def\@makechapterhead#1{% + \vspace*{50\p@}% + {\parindent \z@ \raggedright \normalfont + \ifnum \c@secnumdepth >\m@ne + \huge\bfseries\SS@chapnumfont{\@chapapp\space \thechapter}% + \par\nobreak + \vskip 20\p@ + \fi + \interlinepenalty\@M + \raggedright \normalfont + \Huge \bfseries \SS@chaptitlefont {#1}\par\nobreak + \vskip 40\p@ + }} +\def\@makeschapterhead#1{% + \vspace*{50\p@}% + {\parindent \z@ \raggedright + \normalfont + \interlinepenalty\@M + \Huge \bfseries \SS@chaptitlefont {#1}\par\nobreak + \vskip 40\p@ + }}% +}{} +%% End code re-defining chapter stuff for report class +%% Chapter code from |book.cls| 1997/10/10 v1.3x +\@ifclassloaded{book}{% +\SS@oclto{1}{chapter modifications for book class}% +\def\@makechapterhead#1{% + \vspace*{50\p@}% + {\parindent \z@ \raggedright \normalfont + \ifnum \c@secnumdepth >\m@ne + \if@mainmatter + \huge\bfseries\SS@chapnumfont {\@chapapp\space \thechapter}% + \par\nobreak + \vskip 20\p@ + \fi + \fi + \interlinepenalty\@M + \raggedright \normalfont + \Huge \bfseries \SS@chaptitlefont {#1}\par\nobreak + \vskip 40\p@ + }} +\def\@makeschapterhead#1{% + \vspace*{50\p@}% + {\parindent \z@ \raggedright + \normalfont + \interlinepenalty\@M + \Huge \bfseries \SS@chaptitlefont {#1}\par\nobreak + \vskip 40\p@ + }}% +}{} +%% End code redefining chapter stuff from book.cls +%% Begin code redefining chapter stuff from scrreprt.cls +\@ifclassloaded{scrreprt}{% +\SS@oclto{1}{chapter modifications for scrreprt class}% +\def\@makechapterhead#1{\chapterheadstartvskip% + {\size@chapter{\sectfont\SS@chapnumfont + \@hangfrom{\ifnum \c@secnumdepth >\m@ne% + \chapterformat\fi}% + {\raggedsection \interlinepenalty \@M \SS@chaptitlefont {#1}\par}}% + \nobreak\chapterheadendvskip + }} +\def\@makeschapterhead#1{\chapterheadstartvskip% + {\parindent \z@ \raggedsection + \normalfont + \size@chapter\sectfont\SS@chaptitlefont {#1}\par + \nobreak\chapterheadendvskip + }} +}{} +%% End code redefining chapter stuff from scrreprt.cls +%% Begin code redefining chapter stuff from scrbook.cls +\@ifclassloaded{scrbook}{% +\SS@oclto{1}{chapter modifications for scrbook class}% +\def\@makechapterhead#1{\chapterheadstartvskip% + {\size@chapter{\sectfont\SS@chapnumfont + \@hangfrom{\ifnum \c@secnumdepth >\m@ne% + \if@mainmatter \chapterformat\fi\fi}% + {\raggedsection \interlinepenalty \@M \SS@chaptitlefont {#1}\par}}% + \nobreak\chapterheadendvskip + }} +\def\@makeschapterhead#1{\chapterheadstartvskip% + {\parindent \z@ \raggedsection + \normalfont + \size@chapter\sectfont\SS@chaptitlefont {#1}\par + \nobreak\chapterheadendvskip + }}% + }{} + % \end{macrocode} +%% End code redefining chapter stuff from scrbook.cls +%% Part code from book.cls 1997/10/10 v1.3x +\@ifclassloaded{book}{% +\SS@oclto{1}{part modifications for book class}% +\def\@part[#1]#2{% + \ifnum \c@secnumdepth >-2\relax + \refstepcounter{part}% + \addcontentsline{toc}{part}{\thepart\hspace{1em}#1}% + \else + \addcontentsline{toc}{part}{#1}% + \fi + \markboth{}{}% + {\centering + \interlinepenalty \@M + \normalfont + \ifnum \c@secnumdepth >-2\relax + \huge\bfseries\SS@partnumberfont {\partname~\thepart}% + \par + \vskip 20\p@ + \fi + \centering \normalfont + \Huge \bfseries \SS@parttitlefont {#2}\par}% + \@endpart} +\def\@spart#1{% + {\centering + \interlinepenalty \@M + \normalfont \Huge \bfseries \SS@parttitlefont {#1}\par}% + \@endpart} +}{} +%% End code redefining part stuff from |book.cls| +%% Part code from |article.cls| 1997/10/10 v1.3x +\@ifclassloaded{article}{% +\SS@oclto{1}{part modifications for article class}% +\def\@part[#1]#2{% + \ifnum \c@secnumdepth >\m@ne + \refstepcounter{part}% + \addcontentsline{toc}{part}{\thepart\hspace{1em}#1}% + \else + \addcontentsline{toc}{part}{#1}% + \fi + {\parindent \z@ \raggedright + \interlinepenalty \@M + \normalfont + \ifnum \c@secnumdepth >\m@ne + \Large\bfseries\SS@partnumberfont {\partname~\thepart}% + \par\nobreak + \fi + \raggedright \normalfont + \huge \bfseries \SS@parttitlefont {#2}% + \markboth{}{}\par}% + \nobreak + \vskip 3ex + \@afterheading} +\def\@spart#1{% + {\parindent \z@ \raggedright + \interlinepenalty \@M + \normalfont + \huge \bfseries \SS@parttitlefont {#1}\par}% + \nobreak + \vskip 3ex + \@afterheading} +}{} +%% End code redefining part stuff from |article.cls| +%% Part code from |report.cls| 1997/10/10 v1.3x +\@ifclassloaded{report}{% +\SS@oclto{1}{part modifications for report class}% +\def\@part[#1]#2{% + \ifnum \c@secnumdepth >-2\relax + \refstepcounter{part}% + \addcontentsline{toc}{part}{\thepart\hspace{1em}#1}% + \else + \addcontentsline{toc}{part}{#1}% + \fi + \markboth{}{}% + {\centering + \interlinepenalty \@M + \normalfont + \ifnum \c@secnumdepth >-2\relax + \huge\bfseries\SS@partnumberfont {\partname~\thepart}% + \par + \vskip 20\p@ + \fi + \centering \normalfont + \Huge \bfseries \SS@parttitlefont {#2}\par}% + \@endpart} +\def\@spart#1{% + {\centering + \interlinepenalty \@M + \normalfont + \Huge \bfseries \SS@parttitlefont {#1}\par}% + \@endpart} +}{} +%% End code redefining part stuff from report.cls +\@tempswafalse +\@ifclassloaded{scrreprt}{\@tempswatrue}{} +\@ifclassloaded{scrbook} {\@tempswatrue}{} +%% Part code from |scrbook.cls| 1998/07/17 v2.5e +\if@tempswa% +\SS@oclto{1}{part modifications for scrreprt and scrbook classes}% +\def\@part[#1]#2{% + \ifnum \c@secnumdepth >-2\relax + \refstepcounter{part}\@maybeasf% + \addcontentsline{toc}{part}{\protect\numberline{\thepart}#1}% + \else + \addcontentsline{toc}{part}{#1}% + \fi + \chaptermark{} + {\centering + \interlinepenalty \@M + \normalfont + \ifnum \c@secnumdepth >-2\relax + \size@partnumber\sectfont\SS@partnumberfont\partformat + \par + \vskip 20\p@ + \fi + \size@part\sectfont\SS@parttitlefont {#2}\par}% + \@endpart} +\def\@spart#1{% + {\centering + \interlinepenalty \@M + \normalfont + \size@part\sectfont\SS@parttitlefont {#1}\chaptermark{}\par}% + \@endpart}% + \fi +%% End part code from |scrbook.cls| 1998/07/17 v2.5e +%% Part code from |scrartcl.cls| 1998/07/17 v2.5e +\@ifclassloaded{scrartcl}{% +\SS@oclto{1}{part modifications for scrartcl classes}% +\def\@part[#1]#2{% + \ifnum \c@secnumdepth >\m@ne + \refstepcounter{part}\@maybeasf% + \addcontentsline{toc}{part}{\protect\numberline{\thepart}#1}% + \else + \addcontentsline{toc}{part}{#1}% + \fi + {\parindent \z@ \raggedright + \interlinepenalty \@M + \normalfont + \ifnum \c@secnumdepth >\m@ne + \size@partnumber\sectfont\SS@partnumberfont\partformat + \par\nobreak + \fi + \size@part\sectfont\SS@parttitlefont {#2}% + \sectionmark{}\par}% + \nobreak + \vskip 3ex + \@afterheading} +\def\@spart#1{% + {\parindent \z@ \raggedright + \interlinepenalty \@M + \normalfont + \size@part\sectfont\SS@parttitlefont {#1}\sectionmark{}\par}% + \nobreak + \vskip 3ex + \@afterheading}% + }{} +\endinput +%% +%% End of file `sectsty.sty'. diff --git a/doc/latex_sty/stdclsdv.sty b/doc/latex_sty/stdclsdv.sty new file mode 100644 index 0000000000000000000000000000000000000000..9eb86645028600a37705ebf03aa913172c728394 --- /dev/null +++ b/doc/latex_sty/stdclsdv.sty @@ -0,0 +1,75 @@ +%% +%% This is file `stdclsdv.sty', +%% generated with the docstrip utility. +%% +%% The original source files were: +%% +%% stdclsdv.dtx (with options: `usc') +%% +%% Copyright 1999 Peter R. Wilson +%% +%% This program is provided under the terms of the +%% LaTeX Project Public License distributed from CTAN +%% archives in directory macros/latex/base/lppl.txt. +%% +%% Author: Peter Wilson (CUA and NIST) +%% now at: peter.r.wilson@boeing.com +%% +\NeedsTeXFormat{LaTeX2e} +\ProvidesPackage{stdclsdv}[1999/01/18 v1.0 Sectional divisions] +\newif\ifSCDknownclass\SCDknownclassfalse +\newif\ifSCDpart\SCDparttrue +\newif\ifSCDchapter\SCDchapterfalse +\newif\ifSCDsection\SCDsectiontrue +\newif\ifSCDnodivs\SCDnodivsfalse +\@ifclassloaded{book}{\SCDknownclasstrue\SCDchaptertrue}{} +\@ifclassloaded{report}{\SCDknownclasstrue\SCDchaptertrue}{} +\@ifclassloaded{article}{\SCDknownclasstrue}{} +\@ifclassloaded{proc}{\SCDknownclasstrue}{} +\@ifclassloaded{ltxdoc}{\SCDknownclasstrue}{} +\@ifclassloaded{slides}{\SCDknownclasstrue + \SCDnodivstrue\SCDpartfalse\SCDsectionfalse}{} +\@ifclassloaded{letter}{\SCDknownclasstrue + \SCDnodivstrue\SCDpartfalse\SCDsectionfalse}{} +\ifSCDknownclass\else + \SCDnodivstrue + \ifx\part\undefined + \SCDpartfalse + \else + \SCDnodivsfalse + \fi + \ifx\chapter\undefined\else + \SCDchaptertrue \SCDnodivsfalse + \fi + \ifx\section\undefined + \SCDsectionfalse + \else + \SCDnodivsfalse + \fi +\fi +\newcommand{\SCDquit}{} +\newif\ifSCDSameDefinition +\def\SCDCheckCommand{\@star@or@long% + \SCDSameDefinitiontrue% changed from CheckCommand + \@SCD@check@command} + \@onlypreamble\SCDCheckCommand +\def\@SCD@check@command#1#2#{\@SCD@check@c#1{#2}} + \@onlypreamble\@SCD@check@command +\long\def\@SCD@check@c#1#2#3{% + \expandafter\let\csname\string\reserved@a\endcsname\relax + \renew@command\reserved@a#2{#3}% + \@ifundefined{\string\reserved@a}% + {\@SCD@check@eq#1\reserved@a}% + {\expandafter\@SCD@check@eq + \csname\string#1\expandafter\endcsname + \csname\string\reserved@a\endcsname}} + \@onlypreamble\@SCD@check@c +\def\@SCD@check@eq#1#2{% + \ifx#1#2\else + \SCDSameDefinitionfalse % changed from CheckCommand + \fi} + \@onlypreamble\@SCD@check@eq +\endinput +%% +%% End of file `stdclsdv.sty'. + diff --git a/doc/latex_sty/tocloft.sty b/doc/latex_sty/tocloft.sty new file mode 100644 index 0000000000000000000000000000000000000000..d3978f433061321478ecc1ab37b1a313695fd6af --- /dev/null +++ b/doc/latex_sty/tocloft.sty @@ -0,0 +1,737 @@ + +%% +%% This is file `tocloft.sty', +%% generated with the docstrip utility. +%% +%% The original source files were: +%% +%% tocloft.dtx (with options: `usc') +%% +%% Copyright 1998, 1999 Peter R. Wilson +%% +%% This program is provided under the terms of the +%% LaTeX Project Public License distributed from CTAN +%% archives in directory macros/latex/base/lppl.txt. +%% +%% Author: Peter Wilson (CUA and NIST) +%% now at: peter.r.wilson@boeing.com +%% +\NeedsTeXFormat{LaTeX2e} +\ProvidesPackage{tocloft}[2000/02/11 v1.1 parameterised ToC, etc., typesetting] +\RequirePackage{stdclsdv} +\providecommand{\PRWPackageNote}[2]{% + \GenericWarning{% + (#1)\@spaces\@spaces\@spaces\@spaces + }{% + Package #1 Note: #2% + }% +} +\providecommand{\PRWPackageNoteNoLine}[2]{% + \PRWPackageNote{#1}{#2\@gobble}% +} +\ifSCDnodivs + \PackageWarning{tocloft}% + {I don't recognize any sectional divisions so I'll do nothing} + \renewcommand{\SCDquit}{\endinput} +\fi +\SCDquit +\ifSCDknownclass\else + \PackageWarning{tocloft}% + {I don't recognize the class but I'll do my best} + \ifSCDnodivs + \PackageWarning{tocloft}% + {I don't recognize any sectional divisions so I'll do nothing} + \renewcommand{\SCDquit}{\endinput} + \else + \ifSCDchapter + \PRWPackageNoteNoLine{tocloft}{The document class has chapter divisions} + \else + \ifSCDsection + \PRWPackageNoteNoLine{tocloft}{The document class has section divisions} + \else + \PackageWarning{tocloft}% + {The class has neither chapters nor sections, so I'll do nothing} + \renewcommand{\SCDquit}{\endinput} + \fi + \fi + \fi +\fi +\SCDquit +\newif\if@cfttocbibind +\AtBeginDocument{% + \@ifpackageloaded{tocbibind}{\@cfttocbibindtrue}{\@cfttocbibindfalse} + \if@cfttocbibind + \@ifpackagelater{tocbibind}{1998/11/16}{}{% + \PackageWarning{tocloft}{% +You are using a version of the tocbibind package\MessageBreak +that is not compatible with tocloft.\MessageBreak +The results may be surprising.\MessageBreak +Consider installing the current version of tocbibind.}} + \fi +} +\newif\if@cftnctoc\@cftnctocfalse +\DeclareOption{titles}{\@cftnctoctrue} + %% \ProcessOptions\relax +\newcommand{\cftmarktoc}{% + \@mkboth{\MakeUppercase\contentsname}{\MakeUppercase\contentsname}} +\newcommand{\cftmarklof}{% + \@mkboth{\MakeUppercase\listfigurename}{\MakeUppercase\listfigurename}} +\newcommand{\cftmarklot}{% + \@mkboth{\MakeUppercase\listtablename}{\MakeUppercase\listtablename}} +\newcommand{\@cfttocstart}{% + \ifSCDchapter + \if@twocolumn + \@restonecoltrue\onecolumn + \else + \@restonecolfalse + \fi + \fi} +\newcommand{\@cfttocfinish}{% + \ifSCDchapter + \if@restonecol\twocolumn\fi + \fi} +\newcommand{\@cftdobibtoc}{% + \if@dotoctoc + \if@bibchapter + \addcontentsline{toc}{chapter}{\contentsname} + \else + \addcontentsline{toc}{\@tocextra}{\contentsname} + \fi + \fi} +\AtBeginDocument{% +\if@cftnctoc\else + \renewcommand{\tableofcontents}{% + \@cfttocstart + \par + \begingroup + \parindent\z@ \parskip\z@ + \@cftmaketoctitle + \if@cfttocbibind + \@cftdobibtoc + \fi + \@starttoc{toc}% + \endgroup + \@cfttocfinish} +\fi +} +\newcommand{\@cftmaketoctitle}{% + \vspace*{\cftbeforetoctitleskip} + \interlinepenalty\@M + {\cfttoctitlefont\contentsname}{\cftaftertoctitle} + \cftmarktoc + \par\nobreak + \vskip \cftaftertoctitleskip + \@afterheading} +\newlength{\cftbeforetoctitleskip} +\newlength{\cftaftertoctitleskip} +\ifSCDchapter + \setlength{\cftbeforetoctitleskip}{50pt} + \setlength{\cftaftertoctitleskip}{40pt} +\else + \setlength{\cftbeforetoctitleskip}{3.5ex \@plus 1ex \@minus .2ex} + \setlength{\cftaftertoctitleskip}{2.3ex \@plus.2ex} +\fi +\ifSCDchapter + \newcommand{\cfttoctitlefont}{\normalfont\Huge\bfseries} +\else + \newcommand{\cfttoctitlefont}{\normalfont\Large\bfseries} +\fi +\newcommand{\cftaftertoctitle}{} +\newcommand{\cftsetpnumwidth}[1]{\renewcommand{\@pnumwidth}{#1}} +\newcommand{\cftsetrmarg}[1]{\renewcommand{\@tocrmarg}{#1}} +\newcommand{\cftdot}{.} +\newcommand{\cftdotfill}[1]{% + \leaders\hbox{$\m@th\mkern #1 mu\hbox{\cftdot}\mkern #1 mu$}\hfill} +\newcommand{\cftdotsep}{4.5} +\newcommand{\cftnodots}{10000} +\newcommand{\cftparfillskip}{\parfillskip=0pt plus1fil} +\renewcommand{\numberline}[1]{% + \hb@xt@\@tempdima{\@cftbsnum #1\@cftasnum\hfil}\@cftasnumb} +\newcommand{\@cftbsnum}{} +\newcommand{\@cftasnum}{} +\newcommand{\@cftasnumb}{} +\newif\if@cftdopart +\ifSCDpart +\renewcommand*{\l@part}[2]{% + \@cftdopartfalse + \ifnum \c@tocdepth >-2\relax + \ifSCDchapter + \@cftdoparttrue + \fi + \ifnum \c@tocdepth >\m@ne + \ifSCDchapter\else + \@cftdoparttrue + \fi + \fi + \fi + \if@cftdopart + \ifSCDchapter + \addpenalty{-\@highpenalty}% + \else + \addpenalty\@secpenalty + \fi + \addvspace{\cftbeforepartskip}% + \@tempdima \cftpartnumwidth\relax + \let\@cftbsnum \cftpartpresnum + \let\@cftasnum \cftpartaftersnum + \let\@cftasnumb \cftpartaftersnumb + \begingroup + \parindent \z@ \rightskip \@pnumwidth + \parfillskip -\@pnumwidth + {\leavevmode + {\cftpartfont #1}{\cftpartleader} + {\hb@xt@\@pnumwidth{\hss {\cftpartpagefont #2}}}\cftpartafterpnum}\par + \nobreak + \ifSCDchapter + \global\@nobreaktrue + \everypar{\global\@nobreakfalse\everypar{}}% + \else + \if@compatibility + \global\@nobreaktrue + \everypar{\global\@nobreakfalse\everypar{}}% + \fi + \fi + \endgroup + \fi} +\fi +\newlength{\cftbeforepartskip} + \setlength{\cftbeforepartskip}{2.25em \@plus\p@} +\newlength{\cftpartnumwidth} + \setlength{\cftpartnumwidth}{3em} +\newcommand{\cftpartfont}{\large\bfseries} +\newcommand{\cftpartpresnum}{} +\newcommand{\cftpartaftersnum}{} +\newcommand{\cftpartaftersnumb}{} +\newcommand{\cftpartleader}{\large\bfseries\cftdotfill{\cftpartdotsep}} +\newcommand{\cftpartdotsep}{\cftnodots} +\newcommand{\cftpartpagefont}{\large\bfseries} +\newcommand{\cftpartafterpnum}{} +\ifSCDchapter +\renewcommand*{\l@chapter}[2]{% + \ifnum \c@tocdepth >\m@ne + \addpenalty{-\@highpenalty}% + \vskip \cftbeforechapskip + {\leftskip \cftchapindent\relax + \rightskip \@tocrmarg + \parfillskip -\rightskip + \parindent \cftchapindent\relax\@afterindenttrue + \interlinepenalty\@M + \leavevmode + \@tempdima \cftchapnumwidth\relax + \let\@cftbsnum \cftchappresnum + \let\@cftasnum \cftchapaftersnum + \let\@cftasnumb \cftchapaftersnumb + \advance\leftskip \@tempdima \null\nobreak\hskip -\leftskip + {\cftchapfont #1}\nobreak + {\cftchapleader} + \nobreak + \hb@xt@\@pnumwidth{\hfil\cftchappagefont #2}\cftchapafterpnum\par}% + \fi} +\fi +\newlength{\cftbeforechapskip} + \setlength{\cftbeforechapskip}{1.0em \@plus\p@} +\newlength{\cftchapindent} + \setlength{\cftchapindent}{0em} +\newlength{\cftchapnumwidth} + \setlength{\cftchapnumwidth}{1.5em} +\newcommand{\cftchapfont}{\bfseries} +\newcommand{\cftchappresnum}{} +\newcommand{\cftchapaftersnum}{} +\newcommand{\cftchapaftersnumb}{} +\newcommand{\cftchapleader}{\bfseries\cftdotfill{\cftchapdotsep}} +\newcommand{\cftchapdotsep}{\cftnodots} +\newcommand{\cftchappagefont}{\bfseries} +\newcommand{\cftchapafterpnum}{} +\renewcommand*{\l@section}[2]{% + \ifnum \c@tocdepth >\z@ + \ifSCDchapter + \vskip \cftbeforesecskip + \else + \addpenalty\@secpenalty + \addvspace{\cftbeforesecskip} + \fi + {\leftskip \cftsecindent\relax + \rightskip \@tocrmarg + \parfillskip -\rightskip + \parindent \cftsecindent\relax\@afterindenttrue + \interlinepenalty\@M + \leavevmode + \@tempdima \cftsecnumwidth\relax + \let\@cftbsnum \cftsecpresnum + \let\@cftasnum \cftsecaftersnum + \let\@cftasnumb \cftsecaftersnumb + \advance\leftskip \@tempdima \null\nobreak\hskip -\leftskip + {\cftsecfont #1}\nobreak + {\cftsecleader} + \nobreak + \hb@xt@\@pnumwidth{\hfil\cftsecpagefont #2}\cftsecafterpnum\par}% + \fi} +\newlength{\cftbeforesecskip} +\ifSCDchapter + \setlength{\cftbeforesecskip}{\z@ \@plus.2\p@} +\else + \setlength{\cftbeforesecskip}{1.0em \@plus\p@} +\fi +\newlength{\cftsecindent} +\ifSCDchapter + \setlength{\cftsecindent}{1.5em} +\else + \setlength{\cftsecindent}{0em} +\fi +\newlength{\cftsecnumwidth} +\ifSCDchapter + \setlength{\cftsecnumwidth}{2.3em} +\else + \setlength{\cftsecnumwidth}{1.5em} +\fi +\ifSCDchapter + \newcommand{\cftsecfont}{\normalfont} +\else + \newcommand{\cftsecfont}{\bfseries} +\fi +\newcommand{\cftsecpresnum}{} +\newcommand{\cftsecaftersnum}{} +\newcommand{\cftsecaftersnumb}{} +\ifSCDchapter + \newcommand{\cftsecleader}{\normalfont\cftdotfill{\cftsecdotsep}} +\else + \newcommand{\cftsecleader}{\bfseries\cftdotfill{\cftsecdotsep}} +\fi +\ifSCDchapter + \newcommand{\cftsecdotsep}{\cftdotsep} +\else + \newcommand{\cftsecdotsep}{\cftnodots} +\fi +\ifSCDchapter + \newcommand{\cftsecpagefont}{\normalfont} +\else + \newcommand{\cftsecpagefont}{\bfseries} +\fi +\newcommand{\cftsecafterpnum}{} +\renewcommand*{\l@subsection}[2]{% + \ifnum \c@tocdepth >\@ne + \vskip \cftbeforesubsecskip + {\leftskip \cftsubsecindent\relax + \rightskip \@tocrmarg + \parfillskip -\rightskip + \parindent \cftsubsecindent\relax\@afterindenttrue + \interlinepenalty\@M + \leavevmode + \@tempdima \cftsubsecnumwidth\relax + \let\@cftbsnum \cftsubsecpresnum + \let\@cftasnum \cftsubsecaftersnum + \let\@cftasnumb \cftsubsecaftersnumb + \advance\leftskip \@tempdima \null\nobreak\hskip -\leftskip + {\cftsubsecfont #1}\nobreak + {\cftsubsecleader} + \nobreak + \hb@xt@\@pnumwidth{\hfil\cftsubsecpagefont #2}\cftsubsecafterpnum\par}% + \fi} +\newlength{\cftbeforesubsecskip} + \setlength{\cftbeforesubsecskip}{\z@ \@plus.2\p@} +\newlength{\cftsubsecindent} +\ifSCDchapter + \setlength{\cftsubsecindent}{3.8em} +\else + \setlength{\cftsubsecindent}{1.5em} +\fi +\newlength{\cftsubsecnumwidth} +\ifSCDchapter + \setlength{\cftsubsecnumwidth}{3.2em} +\else + \setlength{\cftsubsecnumwidth}{2.3em} +\fi +\newcommand{\cftsubsecfont}{\normalfont} +\newcommand{\cftsubsecpresnum}{} +\newcommand{\cftsubsecaftersnum}{} +\newcommand{\cftsubsecaftersnumb}{} +\newcommand{\cftsubsecleader}{\normalfont\cftdotfill{\cftsubsecdotsep}} +\newcommand{\cftsubsecdotsep}{\cftdotsep} +\newcommand{\cftsubsecpagefont}{\normalfont} +\newcommand{\cftsubsecafterpnum}{} +\renewcommand*{\l@subsubsection}[2]{% + \ifnum \c@tocdepth >\tw@ + \vskip \cftbeforesubsubsecskip + {\leftskip \cftsubsubsecindent\relax + \rightskip \@tocrmarg + \parfillskip -\rightskip + \parindent \cftsubsubsecindent\relax\@afterindenttrue + \interlinepenalty\@M + \leavevmode + \@tempdima \cftsubsubsecnumwidth\relax + \let\@cftbsnum \cftsubsubsecpresnum + \let\@cftasnum \cftsubsubsecaftersnum + \let\@cftasnumb \cftsubsubsecaftersnumb + \advance\leftskip \@tempdima \null\nobreak\hskip -\leftskip + {\cftsubsubsecfont #1}\nobreak + {\cftsubsubsecleader} + \nobreak + \hb@xt@\@pnumwidth{\hfil\cftsubsubsecpagefont #2}\cftsubsubsecafterpnum\par}% + \fi} +\newlength{\cftbeforesubsubsecskip} + \setlength{\cftbeforesubsubsecskip}{\z@ \@plus.2\p@} +\newlength{\cftsubsubsecindent} +\ifSCDchapter + \setlength{\cftsubsubsecindent}{7.0em} +\else + \setlength{\cftsubsubsecindent}{3.8em} +\fi +\newlength{\cftsubsubsecnumwidth} +\ifSCDchapter + \setlength{\cftsubsubsecnumwidth}{4.1em} +\else + \setlength{\cftsubsubsecnumwidth}{3.2em} +\fi +\newcommand{\cftsubsubsecfont}{\normalfont} +\newcommand{\cftsubsubsecpresnum}{} +\newcommand{\cftsubsubsecaftersnum}{} +\newcommand{\cftsubsubsecaftersnumb}{} +\newcommand{\cftsubsubsecleader}{\normalfont\cftdotfill{\cftsubsubsecdotsep}} +\newcommand{\cftsubsubsecdotsep}{\cftdotsep} +\newcommand{\cftsubsubsecpagefont}{\normalfont} +\newcommand{\cftsubsubsecafterpnum}{} +\renewcommand*{\l@paragraph}[2]{% + \ifnum \c@tocdepth >3\relax + \vskip \cftbeforeparaskip + {\leftskip \cftparaindent\relax + \rightskip \@tocrmarg + \parfillskip -\rightskip + \parindent \cftparaindent\relax\@afterindenttrue + \interlinepenalty\@M + \leavevmode + \@tempdima \cftparanumwidth\relax + \let\@cftbsnum \cftparapresnum + \let\@cftasnum \cftparaaftersnum + \let\@cftasnumb \cftparaaftersnumb + \advance\leftskip \@tempdima \null\nobreak\hskip -\leftskip + {\cftparafont #1}\nobreak + {\cftparaleader} + \nobreak + \hb@xt@\@pnumwidth{\hfil\cftparapagefont #2}\cftparaafterpnum\par}% + \fi} +\newlength{\cftbeforeparaskip} + \setlength{\cftbeforeparaskip}{\z@ \@plus.2\p@} +\newlength{\cftparaindent} +\ifSCDchapter + \setlength{\cftparaindent}{10em} +\else + \setlength{\cftparaindent}{7.0em} +\fi +\newlength{\cftparanumwidth} +\ifSCDchapter + \setlength{\cftparanumwidth}{5em} +\else + \setlength{\cftparanumwidth}{4.1em} +\fi +\newcommand{\cftparafont}{\normalfont} +\newcommand{\cftparapresnum}{} +\newcommand{\cftparaaftersnum}{} +\newcommand{\cftparaaftersnumb}{} +\newcommand{\cftparaleader}{\normalfont\cftdotfill{\cftparadotsep}} +\newcommand{\cftparadotsep}{\cftdotsep} +\newcommand{\cftparapagefont}{\normalfont} +\newcommand{\cftparaafterpnum}{} +\renewcommand*{\l@subparagraph}[2]{% + \ifnum \c@tocdepth >4\relax + \vskip \cftbeforesubparaskip + {\leftskip \cftsubparaindent\relax + \rightskip \@tocrmarg + \parfillskip -\rightskip + \parindent \cftsubparaindent\relax\@afterindenttrue + \interlinepenalty\@M + \leavevmode + \@tempdima \cftsubparanumwidth\relax + \let\@cftbsnum \cftsubparapresnum + \let\@cftasnum \cftsubparaaftersnum + \let\@cftasnumb \cftsubparaaftersnumb + \advance\leftskip \@tempdima \null\nobreak\hskip -\leftskip + {\cftsubparafont #1}\nobreak + {\cftsubparaleader} + \nobreak + \hb@xt@\@pnumwidth{\hfil\cftsubparapagefont #2}\cftsubparaafterpnum\par}% + \fi} +\newlength{\cftbeforesubparaskip} + \setlength{\cftbeforesubparaskip}{\z@ \@plus.2\p@} +\newlength{\cftsubparaindent} +\ifSCDchapter + \setlength{\cftsubparaindent}{12em} +\else + \setlength{\cftsubparaindent}{10em} +\fi +\newlength{\cftsubparanumwidth} +\ifSCDchapter + \setlength{\cftsubparanumwidth}{6em} +\else + \setlength{\cftsubparanumwidth}{5em} +\fi +\newcommand{\cftsubparafont}{\normalfont} +\newcommand{\cftsubparapresnum}{} +\newcommand{\cftsubparaaftersnum}{} +\newcommand{\cftsubparaaftersnumb}{} +\newcommand{\cftsubparaleader}{\normalfont\cftdotfill{\cftsubparadotsep}} +\newcommand{\cftsubparadotsep}{\cftdotsep} +\newcommand{\cftsubparapagefont}{\normalfont} +\newcommand{\cftsubparaafterpnum}{} +\newcommand{\@cftdobiblof}{% + \if@dotoclof + \if@bibchapter + \addcontentsline{toc}{chapter}{\listfigurename} + \else + \addcontentsline{toc}{\@tocextra}{\listfigurename} + \fi + \fi} +\AtBeginDocument{ +\if@cftnctoc\else +\renewcommand{\listoffigures}{% + \@cfttocstart + \par + \begingroup + \parindent\z@ \parskip\z@ + \@cftmakeloftitle + \if@cfttocbibind + \@cftdobiblof + \fi + \@starttoc{lof}% + \endgroup + \@cfttocfinish} +\fi +} +\newcommand{\@cftmakeloftitle}{% + \vspace*{\cftbeforeloftitleskip} + \interlinepenalty\@M + {\cftloftitlefont\listfigurename}{\cftafterloftitle} + \cftmarklof + \par\nobreak + \vskip \cftafterloftitleskip + \@afterheading} +\newlength{\cftbeforeloftitleskip} +\newlength{\cftafterloftitleskip} +\ifSCDchapter + \setlength{\cftbeforeloftitleskip}{50pt} + \setlength{\cftafterloftitleskip}{40pt} +\else + \setlength{\cftbeforeloftitleskip}{3.5ex \@plus 1ex \@minus .2ex} + \setlength{\cftafterloftitleskip}{2.3ex \@plus.2ex} +\fi +\ifSCDchapter + \newcommand{\cftloftitlefont}{\normalfont\Huge\bfseries} +\else + \newcommand{\cftloftitlefont}{\normalfont\Large\bfseries} +\fi +\newcommand{\cftafterloftitle}{} +\renewcommand*{\l@figure}[2]{% + \vskip \cftbeforefigskip + {\leftskip \cftfigindent\relax + \rightskip \@tocrmarg + \parfillskip -\rightskip + \parindent \cftfigindent\relax\@afterindenttrue + \interlinepenalty\@M + \leavevmode + \@tempdima \cftfignumwidth\relax + \let\@cftbsnum \cftfigpresnum + \let\@cftasnum \cftfigaftersnum + \let\@cftasnumb \cftfigaftersnumb + \advance\leftskip \@tempdima \null\nobreak\hskip -\leftskip + {\cftfigfont #1}\nobreak + {\cftfigleader} + \nobreak + \hb@xt@\@pnumwidth{\hfil\cftfigpagefont #2}\cftfigafterpnum\par}% + } +\newlength{\cftbeforefigskip} + \setlength{\cftbeforefigskip}{\z@ \@plus.2\p@} +\newlength{\cftfigindent} + \setlength{\cftfigindent}{1.5em} +\newlength{\cftfignumwidth} + \setlength{\cftfignumwidth}{2.3em} +\newcommand{\cftfigfont}{\normalfont} +\newcommand{\cftfigpresnum}{} +\newcommand{\cftfigaftersnum}{} +\newcommand{\cftfigaftersnumb}{} +\newcommand{\cftfigleader}{\normalfont\cftdotfill{\cftfigdotsep}} +\newcommand{\cftfigdotsep}{\cftdotsep} +\newcommand{\cftfigpagefont}{\normalfont} +\newcommand{\cftfigafterpnum}{} +\newcommand{\@cftdobiblot}{% + \if@dotoclot + \if@bibchapter + \addcontentsline{toc}{chapter}{\listtablename} + \else + \addcontentsline{toc}{\@tocextra}{\listtablename} + \fi + \fi} +\AtBeginDocument{ +\if@cftnctoc\else +\renewcommand{\listoftables}{% + \@cfttocstart + \par + \begingroup + \parindent\z@ \parskip\z@ + \@cftmakelottitle + \if@cfttocbibind + \@cftdobiblot + \fi + \@starttoc{lot}% + \endgroup + \@cfttocfinish} +\fi +} +\newcommand{\@cftmakelottitle}{% + \vspace*{\cftbeforelottitleskip} + \interlinepenalty\@M + {\cftlottitlefont\listtablename}{\cftafterlottitle} + \cftmarklot + \par\nobreak + \vskip \cftafterlottitleskip + \@afterheading} +\newlength{\cftbeforelottitleskip} +\newlength{\cftafterlottitleskip} +\ifSCDchapter + \setlength{\cftbeforelottitleskip}{50pt} + \setlength{\cftafterlottitleskip}{40pt} +\else + \setlength{\cftbeforelottitleskip}{3.5ex \@plus 1ex \@minus .2ex} + \setlength{\cftafterlottitleskip}{2.3ex \@plus.2ex} +\fi +\ifSCDchapter + \newcommand{\cftlottitlefont}{\normalfont\Huge\bfseries} +\else + \newcommand{\cftlottitlefont}{\normalfont\Large\bfseries} +\fi +\newcommand{\cftafterlottitle}{} +\renewcommand*{\l@table}[2]{% + \vskip \cftbeforetabskip + {\leftskip \cfttabindent\relax + \rightskip \@tocrmarg + \parfillskip -\rightskip + \parindent \cfttabindent\relax\@afterindenttrue + \interlinepenalty\@M + \leavevmode + \@tempdima \cfttabnumwidth\relax + \let\@cftbsnum \cfttabpresnum + \let\@cftasnum \cfttabaftersnum + \let\@cftasnumb \cfttabaftersnumb + \advance\leftskip \@tempdima \null\nobreak\hskip -\leftskip + {\cfttabfont #1}\nobreak + {\cfttableader} + \nobreak + \hb@xt@\@pnumwidth{\hfil\cfttabpagefont #2}\cfttabafterpnum\par}% + } +\newlength{\cftbeforetabskip} + \setlength{\cftbeforetabskip}{\z@ \@plus.2\p@} +\newlength{\cfttabindent} + \setlength{\cfttabindent}{1.5em} +\newlength{\cfttabnumwidth} + \setlength{\cfttabnumwidth}{2.3em} +\newcommand{\cfttabfont}{\normalfont} +\newcommand{\cfttabpresnum}{} +\newcommand{\cfttabaftersnum}{} +\newcommand{\cfttabaftersnumb}{} +\newcommand{\cfttableader}{\normalfont\cftdotfill{\cfttabdotsep}} +\newcommand{\cfttabdotsep}{\cftdotsep} +\newcommand{\cfttabpagefont}{\normalfont} +\newcommand{\cfttabafterpnum}{} +\newcommand{\@cftl@subfig}{ +\renewcommand*{\l@subfigure}[2]{% + \ifnum \c@lofdepth > 1\relax + \vskip \cftbeforesubfigskip + {\leftskip \cftsubfigindent\relax + \rightskip \@tocrmarg + \parfillskip -\rightskip + \parindent \cftsubfigindent\relax\@afterindenttrue + \interlinepenalty\@M + \leavevmode + \@tempdima \cftsubfignumwidth\relax + \let\@cftbsnum \cftsubfigpresnum + \let\@cftasnum \cftsubfigaftersnum + \let\@cftasnumb \cftsubfigaftersnumb + \advance\leftskip \@tempdima \null\nobreak\hskip -\leftskip + {\cftsubfigfont ##1}\nobreak + {\cftsubfigleader} + \nobreak + \hb@xt@\@pnumwidth{\hfil\cftsubfigpagefont ##2}\cftsubfigafterpnum\par}% + \fi + } +} +\newcommand{\@cftsetsubfig}{ +\newlength{\cftbeforesubfigskip} + \setlength{\cftbeforesubfigskip}{\z@ \@plus.2\p@} +\newlength{\cftsubfigindent} + \setlength{\cftsubfigindent}{3.8em} +\newlength{\cftsubfignumwidth} + \setlength{\cftsubfignumwidth}{2.5em} +\newcommand{\cftsubfigfont}{\normalfont} +\newcommand{\cftsubfigpresnum}{} +\newcommand{\cftsubfigaftersnum}{} +\newcommand{\cftsubfigaftersnumb}{} +\newcommand{\cftsubfigleader}{\normalfont\cftdotfill{\cftsubfigdotsep}} +\newcommand{\cftsubfigdotsep}{\cftdotsep} +\newcommand{\cftsubfigpagefont}{\normalfont} +\newcommand{\cftsubfigafterpnum}{} +} + +\newcommand{\@cftl@subtab}{ +\renewcommand*{\l@subtable}[2]{% + \ifnum \c@lotdepth > 1\relax + \vskip \cftbeforesubtabskip + {\leftskip \cftsubtabindent\relax + \rightskip \@tocrmarg + \parfillskip -\rightskip + \parindent \cftsubtabindent\relax\@afterindenttrue + \interlinepenalty\@M + \leavevmode + \@tempdima \cftsubtabnumwidth\relax + \let\@cftbsnum \cftsubtabpresnum + \let\@cftasnum \cftsubtabaftersnum + \let\@cftasnumb \cftsubtabaftersnumb + \advance\leftskip \@tempdima \null\nobreak\hskip -\leftskip + {\cftsubtabfont ##1}\nobreak + {\cftsubtableader} + \nobreak + \hb@xt@\@pnumwidth{\hfil\cftsubtabpagefont ##2}\cftsubtabafterpnum\par}% + \fi + } +} +\newcommand{\@cftsetsubtab}{ +\newlength{\cftbeforesubtabskip} + \setlength{\cftbeforesubtabskip}{\z@ \@plus.2\p@} +\newlength{\cftsubtabindent} + \setlength{\cftsubtabindent}{3.8em} +\newlength{\cftsubtabnumwidth} + \setlength{\cftsubtabnumwidth}{2.5em} +\newcommand{\cftsubtabfont}{\normalfont} +\newcommand{\cftsubtabpresnum}{} +\newcommand{\cftsubtabaftersnum}{} +\newcommand{\cftsubtabaftersnumb}{} +\newcommand{\cftsubtableader}{\normalfont\cftdotfill{\cftsubtabdotsep}} +\newcommand{\cftsubtabdotsep}{\cftdotsep} +\newcommand{\cftsubtabpagefont}{\normalfont} +\newcommand{\cftsubtabafterpnum}{} +} + +\DeclareOption{subfigure}{% + \@cftsetsubfig\@cftsetsubtab + \AtBeginDocument{\@cftl@subfig\@cftl@subtab} +} +\ProcessOptions\relax + +\newcommand{\cftchapterprecis}[1]{% + \cftchapterprecishere{#1} + \cftchapterprecistoc{#1}} +\newcommand{\cftchapterprecishere}[1]{% + \vspace*{-2\baselineskip} + \begin{quote}\textit{#1}\end{quote}} +\newcommand{\cftchapterprecistoc}[1]{\addtocontents{toc}{% + {\leftskip \cftchapindent\relax + \advance\leftskip \cftchapnumwidth\relax + \rightskip \@tocrmarg\relax + \textit{#1}\protect\par}}} +\newcommand{\cftlocalchange}[3]{% + \addtocontents{#1}{\protect\cftsetpnumwidth{#2} \protect\cftsetrmarg{#3}}} +\newcommand{\cftaddtitleline}[4]{% + \addtocontents{#1}{\protect\contentsline{#2}{#3}{#4}}} +\newcommand{\cftaddnumtitleline}[5]{% + \addtocontents{#1}% + {\protect\contentsline{#2}{\protect\numberline{#3}{\protect\ignorespaces #4}}{#5}}} +\endinput +%% +%% End of file `tocloft.sty'. diff --git a/doc/latex_sty/xtab.sty b/doc/latex_sty/xtab.sty new file mode 100644 index 0000000000000000000000000000000000000000..9eb86645028600a37705ebf03aa913172c728394 --- /dev/null +++ b/doc/latex_sty/xtab.sty @@ -0,0 +1,75 @@ +%% +%% This is file `stdclsdv.sty', +%% generated with the docstrip utility. +%% +%% The original source files were: +%% +%% stdclsdv.dtx (with options: `usc') +%% +%% Copyright 1999 Peter R. Wilson +%% +%% This program is provided under the terms of the +%% LaTeX Project Public License distributed from CTAN +%% archives in directory macros/latex/base/lppl.txt. +%% +%% Author: Peter Wilson (CUA and NIST) +%% now at: peter.r.wilson@boeing.com +%% +\NeedsTeXFormat{LaTeX2e} +\ProvidesPackage{stdclsdv}[1999/01/18 v1.0 Sectional divisions] +\newif\ifSCDknownclass\SCDknownclassfalse +\newif\ifSCDpart\SCDparttrue +\newif\ifSCDchapter\SCDchapterfalse +\newif\ifSCDsection\SCDsectiontrue +\newif\ifSCDnodivs\SCDnodivsfalse +\@ifclassloaded{book}{\SCDknownclasstrue\SCDchaptertrue}{} +\@ifclassloaded{report}{\SCDknownclasstrue\SCDchaptertrue}{} +\@ifclassloaded{article}{\SCDknownclasstrue}{} +\@ifclassloaded{proc}{\SCDknownclasstrue}{} +\@ifclassloaded{ltxdoc}{\SCDknownclasstrue}{} +\@ifclassloaded{slides}{\SCDknownclasstrue + \SCDnodivstrue\SCDpartfalse\SCDsectionfalse}{} +\@ifclassloaded{letter}{\SCDknownclasstrue + \SCDnodivstrue\SCDpartfalse\SCDsectionfalse}{} +\ifSCDknownclass\else + \SCDnodivstrue + \ifx\part\undefined + \SCDpartfalse + \else + \SCDnodivsfalse + \fi + \ifx\chapter\undefined\else + \SCDchaptertrue \SCDnodivsfalse + \fi + \ifx\section\undefined + \SCDsectionfalse + \else + \SCDnodivsfalse + \fi +\fi +\newcommand{\SCDquit}{} +\newif\ifSCDSameDefinition +\def\SCDCheckCommand{\@star@or@long% + \SCDSameDefinitiontrue% changed from CheckCommand + \@SCD@check@command} + \@onlypreamble\SCDCheckCommand +\def\@SCD@check@command#1#2#{\@SCD@check@c#1{#2}} + \@onlypreamble\@SCD@check@command +\long\def\@SCD@check@c#1#2#3{% + \expandafter\let\csname\string\reserved@a\endcsname\relax + \renew@command\reserved@a#2{#3}% + \@ifundefined{\string\reserved@a}% + {\@SCD@check@eq#1\reserved@a}% + {\expandafter\@SCD@check@eq + \csname\string#1\expandafter\endcsname + \csname\string\reserved@a\endcsname}} + \@onlypreamble\@SCD@check@c +\def\@SCD@check@eq#1#2{% + \ifx#1#2\else + \SCDSameDefinitionfalse % changed from CheckCommand + \fi} + \@onlypreamble\@SCD@check@eq +\endinput +%% +%% End of file `stdclsdv.sty'. + diff --git a/doc/markdown/MANUAL.md b/doc/markdown/MANUAL.md new file mode 100644 index 0000000000000000000000000000000000000000..d6cf4bb8e20884ba425b1a3c919db9bd91433622 --- /dev/null +++ b/doc/markdown/MANUAL.md @@ -0,0 +1,897 @@ +\section Contents +
    +
  • + \ref sect_fluid_eq +
      +
    • + \ref sect_physical +
        +
      • \ref sect_ddr
      • +
      • \ref sect_elecpotfield
      • +
      • \ref sect_rescaling
      • +
      +
    • +
    • \ref sect_bic
    • +
    • + \ref sect_numeric +
        +
      • \ref sect_dde
      • +
      • \ref sect_dpe
      • +
      +
    • +
    • \ref sect_timestepping
    • +
    +
  • +
  • + \ref sect_refinement +
      +
    • \ref sect_overview
    • +
    • \ref sect_size_refinement
    • +
    • \ref sect_criterion
    • +
    • \ref sect_curvature
    • +
    • \ref sect_fishpack
    • +
    • \ref sect_Conclusions
    • +
    +
  • +
  • + \ref sect_software +
      +
    • \ref sect_ARCoS_overview
    • +
    • + \ref sect_IO +
        +
      • \ref sect_sim
      • +
      • \ref sect_input
      • +
      • \ref sect_parameter
      • +
      • \ref sect_needle
      • +
      • \ref sect_output
      • +
      • \ref sect_structure
      • +
      • \ref sect_source
      • +
      +
    • +
    +
  • +
+ +\section sect_fluid_eq Fluid model + +\subsection sect_physical Physical model + +\subsubsection sect_ddr Drift-diffusion-reaction equations + +[1]: http://homepages.cwi.nl/~ebert/CaroJCP06.pdf "Montijn et al." +[2]: http://homepages.cwi.nl/~ebert/LuqueAPL07.pdf "Luque et al." +[3]: http://homepages.cwi.nl/~ebert/StrBranchLuque2011.pdf "Luque et al.(2011)" +[4]: http://homepages.cwi.nl/~ebert/JCP-Li-12.pdf "Li et al." +[5]: http://arxiv.org/abs/1301.1552 "Teunissen et al.". +[6]: http:// "PhD Thesis Wormeester(to appear in 2013)" +[7]: http://alexandria.tue.nl/repository/books/598717.pdf "PhD Thesis Montijn" +[8]: http://homepages.cwi.nl/~willem/ "Monograph by Hundsdorfer and Verwer" +[9]: http://www2.cisl.ucar.edu/resources/legacy/fishpack "Fishpack" +[10]: http://www2.cisl.ucar.edu/resources/legacy/fishpack90 "Fish90" +[11]: http://www.amazon.com/books/dp/3540194622 "Y. P. Raizer, Gas Discharge Physics" +[12]: http://www.stack.nl/~dimitri/doxygen/manual/index.html "Doxygen" + + +In a fluid model of a streamer, we replace the individual particles in the +system by a density function \f${n}(\mathbf{r},t)\f$. +The temporal evolution of this density function is governed by the physical +processes of the system and this model takes the form of a set of partial +differential equations (PDEs). +The derivation of this so-called classical streamer model starts from the +
continuity equation. For particle species \f$i\f$, we have: +\f[ + \frac{\partial n_i(\mathbf{r},t)}{\partial t} + \nabla \cdot \mathbf{j}_i(\mathbf{r},t) = S_i(\mathbf{r},t). +\f] + +Here \f$S_i(\mathbf{r},t)\f$ represents the total of all sources and sinks of +species \f$i\f$. \f$\mathbf{j}_i(\mathbf{r},t)\f$ is the term for the particle +current density of species \f$i\f$. +Particles can drift and diffuse as described by the following +expression for the particle current density +\f$\mathbf{j}_i\f$: +\f[ + \mathbf{j}_i(\mathbf{r},t) = \mu_i n_i(\mathbf{r},t) \mathbf{E}(\mathbf{r},t) - D_i \nabla n_i (\mathbf{r},t). + +\f] +In the above equation, the first term represents the particle drift due +to the electric field, with \f$\mu_i\f$ the mobility coefficient of species \f$i\f$. +The second term represents the diffusion of particles due to the spatial gradient in particle densities with diffusion coefficient \f$D_i\f$. These equations can be derived from the Boltzmann equation + +On the timescales involved, we consider only electrons to be mobile, while ions and neutrals remain stationary, which means that for heavy species, the [continuity equation](#continuity) is reduced to +\f[ + \frac{\partial n_i(\mathbf{r},t)}{\partial t} = S_i(\mathbf{r},t). +\f] + +The sources and sinks in the first equation play a very important role in the dynamics of the streamer. In this model, the sources and sinks correspond to reactions between the different charged and neutral species present in the gas. The source term due to a single reaction is the product of the densities of the species involved in the reaction and the field-dependent rate coefficient for that reaction. + +As an example, the impact ionization reaction +\f[ + e^- + \mathbf{N}_2 \rightarrow 2 e^- + \mathbf{N}_2^+ +\f] +is modeled by +\f[ + S_{ionization} = k_{ion}(|\mathbf{E}|) n_e [\mathbf{N}_2]. +\f] +Here \f$n_e\f$ is the local electron density, \f$[\mbox{N}_2]\f$ the density of +\f$\mbox{N}_2\f$ and \f$k_{ion}\f$ the reaction coefficient for impact ionization +depending on the magnitude of the local electric field. +The value of \f$k\f$ can be determined in different ways, from experiments, +theoretical calculations or simulations. +The traditional approximation suggested by Townsend +uses an empirical expression for the impact ionization term, see the +[book by Y. P. Raizer, "Gas Discharge Physics"][11]: +\f[ + \frac{dn_e}{dt} = n_e \mu_e |\mathbf{E}| \alpha_0 e^{-E_0 / |\mathbf{E}|}, +\f] +where \f$\mu_e\f$ is the electron mobility coefficient, +\f$\mathbf{E}\f$ is the local electric field and \f$\alpha_0\f$ and \f$E_0\f$ are +parameters that can be determined by fitting experimental data. +In gases that contain an electronegative admixture, such as \f$\mathbf{O}_2\f$, the process of +attachment can provide a sink for the electron density through the following +reactions: +\f[ + e^- + \mathbf{O}_2 \rightarrow \mathbf{O} + \mathbf{O}^- +\f] +\f[ + e^- + \mathbf{O}_2 + \mathbf{O}_2 \rightarrow \mathbf{O}_2^- + \mathbf{O}_2 +\f] +The first attachment process is dissociative attachment, the second an example +of a 3-body attachment (a 3-body attachment can also occur with an oxygen and nitrogen +molecule). +In the case of the 3-body attachment, the reaction rate scales with the square of the oxygen density: +\f[ + S_{3-body-att} = k_{3-body-att}(|\mathbf{E}|) n_e [\mathbf{O}_2]^2. +\f] +Further ionization losses can occur via one or more recombination processes, +but these typically have a timescale that is much longer than the timescale of +streamer development and propagation and are therefore primarily interesting for +the evolution of the charge density after a streamer discharge, +as discussed in [PhD Thesis Wormeester(to appear in 2013)][6], Chapter 5. + + + +In gases with attachment, detachment may occur, resulting in an additional +source of electrons. +In gases that contain both nitrogen and oxygen, the photoionization process +provides a non-local source of electrons. +Since photoionization is non-local, it can not be modelled by simple reaction +equations such as the ones for impact ionization. +Instead, the local contribution of photoionization is calculated by spatially +integrating contributions from the entire domain. +The commonly used model for photoionization and the approximations made to make +this model suitable for simulation are discussed in +[PhD Thesis Wormeester(to appear in 2013)][6], Chapter 3, section Photoionization. + +The reaction model for streamer simulations can be very minimal or very extended, +with many species and reactions, including metastables and various excited states. +The complexity of the reaction model depends on the purpose of the simulations. +For negative streamers in nitrogen, a model containing no more than three species +(\f$\mbox{e}^-\f$, \f$\mbox{N}_2\f$ and \f$\mbox{N}_2^+\f$) and one reaction +(impact ionization) +is sufficient to simulate the dynamics of the streamer head, see [Montijn et al][1]. +For more detailed studies of the streamer chemistry, the reaction model should be +as complete as possible. + + +\subsubsection sect_elecpotfield Electric potential and field + +The streamer evolves under the influence of an electric field, which consists +of an externally applied electric field and the electric field generated by +space charges. +These space charges are present at the head of the streamer as well as on the edge of the streamer channel. +For the further propagation of the streamer, the enhanced electric field in front of the streamer, generated by the space charge in the streamer head is essential. +We compute the net charge density +\f$q(\mathbf{r},t)\f$: +\f[ + q(\mathbf{r},t) = e \sum_i q_i n_i(\mathbf{r},t), +\f] +where for species \f$i\f$, \f$n_i\f$ +denotes the density function of these species and \f$q_i\f$ the charge of +a particle in units of the electron charge \f$e\f$. +From this we compute the potential by solving the Poisson equation +\f[ + \nabla^2 \phi(\mathbf{r},t) = \frac{q(\mathbf{r},t)}{\epsilon_0} +\f] +and the electric field +\f[ + \mathbf{E}(\mathbf{r},t) = -\nabla \phi(\mathbf{r},t). +\f] + +\subsubsection sect_rescaling Rescaling to dimensionless units + +The classical fluid model for streamers can be rescaled to dimensionless units and +it is with these units that the code used in this documentation works. +We refer the interested reader to the +[PhD thesis of Gideon Wormeester (to appear in 2013)][6]. +From the [Townsend](#townsend_ionization) approximation for ionization, +a characteristic field and length scale +emerges: \f$E_0\f$ and \f$l_0 = \alpha_0^{-1}\f$, respectively. +The characteristic velocity follows from the drift velocity of electrons +in the characteristic field, +\f[ + E_0: v_0 = \mu_e E_0. +\f] + +The characteristic number density follows from the [Poisson](#Poisson) equation. +Values for \f$\alpha_0\f$, \f$E_0\f$ and \f$\mu_e\f$ were obtained from +[PhD Thesis Montijn][7] +and are at standard temperature and pressure: +\f{eqnarray*} + \alpha_0 & \simeq & 4332 \quad \mbox{cm}^{-1}\\ + E_0 & \simeq & 2 \times 10^5 \quad \mbox{V} \mbox{cm}^{-1}\\ + \mu_e & \simeq & 380 \quad \mbox{~cm}^2 \mbox{V}^{-1} \mbox{s}^{-1}. +\f} + +When we insert these values in the characteristic scales, we obtain the values with which to rescale the equations: +\f{eqnarray*} + l_0 & \simeq & 2.3 \times 10^{-4} \quad \mbox{~cm}\\ + t_0 & \simeq & 3.0 \times 10^{-12} \quad \mbox{~s}\\ + n_0 & \simeq & 4.7 \times 10^{14} \quad \mbox{~cm}^{-3}\\ + D_0 & \simeq & 1.8 \times 10^{4} \quad \mbox{~cm}^2 \mbox{s}^{-1}. +\f} +We can now make the appropriate substitutions +(\f$t^d = t / t_0\f$ and similarly for the other variables; +the superscript \f${\;}^d\f$ will be used to indicate that a variable is +in dimensionless form, where this is not clear from the context. +For clarity of reading, the superscript \f${\;}^d\f$ will be omitted where it is clear that variables are +dimensionless) to obtain the classical fluid equations in +dimensionless continuity form: +\f[ + \partial_{t} + \nabla \cdot \mathbf{j}_i = S_i, +\f] +where \f$t\f$ is the dimensionless time, \f$\mathbf{j}_i\f$ the dimensionless +particle density current for species \f$i\f$ and \f$S_i\f$ the dimensionless source term +for species \f$i\f$. +\f$S_i\f$ is obtained by rewriting reaction equations such as the +[impact ionization reaction](#reaction_imp_ion) equation in dimensionless form, +where we remark that all rate-coefficients should also be rescaled. +The particle density current \f$\mathbf{j}_i\f$ is obtained by rescaling +[expression](#current_dens) into +equation +\f[ + \mathbf{j}_i = -\mu_i n_i \mathbf{E} - D_i \nabla n_i, +\f] +where \f$\mathbf{E}\f$ is the dimensionless electric field and \f$n_i\f$, +\f$D_i\f$ and \f$\mu_i\f$ are the dimensionless particle density, +diffusion coefficient and mobility respectively of species \f$i\f$. +We find that in dimensionless units \f$\mu_i\f$ is equal to 1 while for heavy particles +\f$\mu_i\f$ is taken as 0, since heavy particles are assumed to be stationary in +this model. +The [dimensionless current density equation](#current_dens_dimless) can therefore be simplified to +\f[ + \mathbf{j}_e = -n_e \mathbf{E} - D_e \nabla n_e +\f] +for electrons and \f$ \mathbf{j}_i = 0 \f$ for heavy particles. +The expression for the [charge density equation](#charge_dens) \f$q\f$, is rescaled to +\f[ + q(\mathbf{r},t) = \sum_i q_i n_i(\mathbf{r},t). +\f] +The [Poisson](#Poisson) equation is rescaled to +\f[ + \nabla^2 \phi = q. +\f] +We remark that although the code +described here internally +works with the dimensionless equations and variables described in this section, +all results are presented in regular units unless otherwise noted. +Input parameters for the simulation code are expected to be in dimensionless units. +Finally we note that the rescaling to dimensionless units does not change +the structure of the equations, it is merely a rescaling to a different +set of units, where the dimensionless units yield a set of equations where some +constants (such as \f$e\f$, \f$\epsilon_0\f$, \f$\mu_e\f$) become unity. + +\subsection sect_bic Boundary and initial conditions + + +We consider a cylindrical computational domain with coordinates: +\f[ +(r,z,\theta) \in (0,L_r) \times (0,L_z) \times (0,2\pi). +\f] +Although the code described here is capable of performing full 3D calculations, +we assume cylindrical symmetry to greatly simplify the computations. +For any spatially dependent function \f$f(r,z,\theta)\f$, we assume: +\f$\partial_{\theta} f(r,z,\theta) = 0\f$. +Consequently, the coordinate system for our computations is limited to +\f$(0,L_r) \times (0,L_z)\f$. +We consider a setup with a powered electrode at \f$z = L_z\f$ and a grounded +electrode at \f$z = 0\f$. +If the powered electrode is a plate, the following boundary conditions are used for +the electric potential \f$\phi(r,z,t)\f$: + +\f[ + \begin{array}{llll} + \forall z \; & \partial_r \phi(0,z,t) & = & 0\\ + \forall r \; & \phi(L_r,z,t) & = & 0\\ + \forall z \; & \phi(r,0,t) & = & 0\\ + \forall r \; & \phi(r,L_z,t) & = & \phi_0 + \end{array} +\f] + +with \f$\phi_0\f$ the potential applied to the powered electrode. +If the powered electrode is a needle protruding from a plate, the needle has the +same potential \f$\phi_0\f$ as the plate. + + +\par Figure 1. Schematic of the computational setup. + +In Figure 1., the shaded rectangle represents the computational domain for +the fluid equations, the thick horizontal lines the two planar electrodes +with the needle and its parameters depicted at the anode. +The area between the two planar electrodes is the computational domain +for the Poisson equation. +The needle is simulated by a single point charge, \f$Q\f$, chosen such +that \f$\phi =\phi_0\f$ in the point \f$P\f$, which is the tip of the needle. +The calculation assumes cylindrical symmetry around the needle axis +represented by the dashed-dotted line. + +For the density equations, we use homogeneous Neumann conditions on all edges: +\f[ + \partial_r n(0,z,t) = \partial_r n(L_r,z,t) = \partial_z n(r,0,t) = \partial_z n(r,L_z,t) = 0, +\f] +where we remark that if the powered electrode is a needle, the computational domain +for the density equations is smaller than the computational domain for the Poisson +equation and the \f$L_z\f$ values for both domains are not equal. +This difference is a requirement of the numerical implementation of the needle +electrode and is further detailed in section \ref sect_needle. + +While the boundary conditions mentioned above are the ones used by Wormeester, +the code that was used can also handle different choices of boundary conditions: +both homogeneous Neumann and homogeneous Dirichlet boundary conditions are available +for the top (\f$z = L_z\f$), bottom (\f$z = 0\f$) and right (\f$r = L_r\f$) +edges of the domain for both the densities and the potential. +The Neumann condition on the central axis of the cylindrical domain is required +for symmetry reasons. + +As initial conditions for particle densities, two types of seeds are implemented in +the code. A homogeneous seed, with a constant density over the entire domain and a +Gaussian seed of the form +\f[ + n(r,z,0) = n_{max} \mbox{exp}(-\frac{r^2 + (z - z_0)^2}{\sigma^2}). +\f] +Here \f$z_0\f$ specifies the \f$z\f$-coordinate of the maximum of the seed +(which is located on the symmetry axis with \f$r = 0\f$), where the density is +\f$n_{max}\f$. \f$\sigma\f$ is a measure of the radius of the seed, it is the distance +at which the density drops to \f$e^{-1}\f$ of the maximum value. + +In typical streamer simulations, a seed of electrons and positive ions is placed at the tip of the needle to initiate the discharge. Other than these Gaussian seeds and the neutral background gas, initial particle densities are zero with the possible exception of added background ionization, a homogeneous density of negative and positive ions. The initial distribution of electrons and ions is charge neutral at every point of the domain. + +\subsection sect_numeric Numerical method + +The physical equations in section \ref sect_fluid_eq are to be solved numerically. +The computational code we have applied for this uses finite volume methods to solve +a discretized version of the physical equations. +Here we give a basic summary of the numerical technique used. +For more details, the reader is referred to the work of [Montijn et al.][1], +upon which the current code is based. + +\subsubsection sect_dde Discretization of density equations + +The [dimensionless continuity ](#continuity_dimless) and the [dimensionless current density](#current_dens_dimless) equations +are discretized using finite volume methods and solved on a uniform rectangular grid with cells: +\f[ + C_{ij} = [(i - 1) \Delta r, i \Delta r] \times [(j - 1) \Delta z, j \Delta z]\left(i = 1 , \cdots , \frac{L_r}{\Delta r}, j = 1 , \cdots , \frac{L_z}{\Delta z}\right), +\f] +where \f$L_r\f$ and \f$L_z\f$ are the \f$r\f$- and \f$z\f$-dimensions of the grid and \f$\Delta r\f$ and \f$\Delta z\f$ the size of a cell in \f$r\f$- and \f$z\f$-direction, respectively. Particle density distributions are represented by their value in the cell center, which can be seen as an average over the cell. For some species \f$n\f$, we use \f$n_{i,j}\f$ to denote the density at the cell center \f$C_{ij}\f$. For sake of clarity of notation we omit the superscript \f$^d\f$ indicating that variables are in dimensionless units. + +The discretized continuity equations in cylindrical coordinates, with cylindrical symmetry (\f$\partial_{\theta} f = 0\f$) assumed, have the following form: +\f[ + \begin{array}{ll} + \frac{d n_{i,j}}{d t} = & \frac{1}{r_i \Delta r} \Big(r_{i - \frac{1}{2}} F^a_{i - \frac{1}{2},j} - r_{i + \frac{1}{2}} F^a_{i + \frac{1}{2},j} + r_{i - \frac{1}{2}} F^d_{i - \frac{1}{2},j} - r_{i + \frac{1}{2}} F^d_{i + \frac{1}{2},j}\Big) + \\ + & \frac{1}{\Delta z} \Big(F^a_{i,j - \frac{1}{2}} - F^a_{i,j + \frac{1}{2}} + F^d_{i,j - \frac{1}{2}} - F^d_{i,j + \frac{1}{2}}\Big) + S_{i,j}. +\end{array} +\f] +Here \f$F^a\f$ and \f$F^d\f$ represent the advective and diffusive fluxes across the cell boundaries. Since we assume ions and neutral particles to be stationary, these terms are nonzero only for electrons. For heavy particles, only the source term \f$S_{ij}\f$ remains. + +The advective flux, \f$F^a\f$ uses an upwind scheme with flux limiting and is defined as follows: +\f[ + \begin{array}{ll} +F^a_{i + \frac{1}{2},j} = & E^+_{r; ~ i + \frac{1}{2},j} \Big[ n_{i,j} + \psi(P_{i,j})(n_{i+1,j} - n_{i,j}) \Big] \\ +& E^-_{r; ~ i + \frac{1}{2},j} \Big[ n_{i + 1,j} + \psi(\frac{1}{P_{i+1,j}})(n_{i,j} - n_{i+1,j}) \Big] +\end{array} +\f] + +\f[ + \begin{array}{ll} + F^a_{i,j + \frac{1}{2}} = & E^+_{z; ~ i,j + \frac{1}{2}} \Big[ n_{i,j} + \psi(Q_{i,j})(n_{i,j+1} - n_{i,j}) \Big] \\ + & E^-_{z; ~ i,j + \frac{1}{2}} \Big[ n_{i,j + 1} + \psi(\frac{1}{Q_{i,j+1}})(n_{i,j} - n_{i,j+1}) \Big], +\end{array} +\f] +where \f$E^+ = max(-E,0)\f$ and \f$E^- = min(-E,0)\f$ are used to distinguish the upwind directions for the components of the electric field, \f$E_r\f$ and \f$E_z\f$, and we have +\f[ +\begin{array}{lll} + P_{i,j} & = & \frac{n_{i,j} - n_{i-1,j}}{n_{i+1,j} - n_{i,j}}\\ + Q_{i,j} & = & \frac{n_{i,j} - n_{i,j-1}}{n_{i,j+1} - n_{i,j}}. +\end{array} +\f] +\f$\psi\f$ is the Koren limiter function: +\f[ + \psi(x) = max(0, min(1, \frac{1}{3} + \frac{x}{6}, x)). +\f] +The diffusive flux \f$F^d\f$ is calculated using a second-order central differences scheme: +\f[ +\begin{array}{lll} + F^d_{i + \frac{1}{2},j} & = & \frac{D}{\Delta r}(n_{i,j} - n_{i+1,j})\\ + F^d_{i,j + \frac{1}{2}} & = & \frac{D}{\Delta z}(n_{i,j} - n_{i,j+1}) +\end{array} +\f] +and the reaction term \f$S_{i,j}\f$ is computed as +\f[ + S_{i,j} = \sum_{A~\in~{reactions}} \Big[ k_A(|\mathbf{E}|_{i,j}) \prod_{s~\in~{Spec(A)}} n_{s; i,j} \Big] +\f] +where \f$k_A\f$ denotes the field-dependent reaction rate coefficient of +reaction \f$A\f$, and \f$Spec(A)\f$ the set of species that appear as an input +for reaction \f$A\f$. + +\subsubsection sect_dpe Discretization of the Poisson equation + +We compute the net charge \f$q_{i,j}\f$ in a cell center by adding up the contributions from the individual charged species: +\f[ + q_{i,j} = \sum_{s~\in~{species}} n_{s; i,j} q_s. +\f] +With this net charge, the electric potential \f$\phi\f$ can be computed in the cell centers through a second-order central approximation of the dimensionless Poisson equation: +\f[ + q_{i,j} = \frac{\phi_{i+1,j} - 2 \phi_{i,j} + \phi_{i-1,j}}{\Delta r^2} + \frac{\phi_{i+1,j} - \phi_{i-1,j}}{2r_{i,j} \Delta r} + \frac{\phi_{i,j+1} - 2 \phi_{i,j} + \phi_{i,j-1}}{\Delta z^2}. +\f] +From the potential we can compute the components of the electric field from \f$\mathbf{E} = - \nabla \phi\f$ in the cell boundaries: +\f[ +\begin{array}{lll} + E_{r; ~ i + \frac{1}{2},j} & = & \frac{\phi_{i,j} - \phi_{i+1,j}}{\Delta r}\\ + E_{z; ~ i,j + \frac{1}{2}} & = & \frac{\phi_{i,j} - \phi_{i,j+1}}{\Delta r}. +\end{array} +\f] +The electric field strength is determined at the cell center, so we have to compute the field components in the center by averaging the values on the boundaries after which we can compute the field strength: +\f[ + |\mathbf{E}|_{i,j} = \sqrt{\left(\frac{E_{r;i - \frac{1}{2},j} + E_{r;i + \frac{1}{2},j}}{2}\right)^2 + \left(\frac{E_{z;i,j - \frac{1}{2}} + E_{z;i,j + \frac{1}{2}}}{2}\right)^2}. +\f] + +\subsection sect_timestepping Time stepping + +The code uses the explicit trapezoidal rule, a second order Runge-Kutta method, +for the temporal discretization with time step \f$\Delta t\f$. +Given some time step \f$t_i = i \Delta t\f$, density distributions +\f$\mathbf{n}_i(r,z) = \mathbf{n}(r,z,t_i)\f$ and electric field +\f$\mathbf{E}_i(r,z) = \mathbf{E}(r,z,t_i)\f$, the densities and field at the next +time step, \f$t_{i+1}\f$ are calculated by first computing an intermediate result +for the densities: +\f[ + \overline{\mathbf{n}}_{i+1} = \mathbf{n}_i + \Delta t F(\mathbf{n}_i, \mathbf{E}_i). +\f] +Using these intermediate densities, the potential can be computed by solving the +Poisson equation, after which we obtain the intermediate electric field +\f$\overline{\mathbf{E}}_{i+1}\f$. +With this, we compute the final values of the densities at \f$t_{i+1}\f$: +\f[ + \mathbf{n}_{i+1} = \mathbf{n}_i + \frac{\Delta t}{2} F(\mathbf{n}_i, \mathbf{E}_i) + \frac{\Delta t}{2} F(\overline{\mathbf{n}}_{i+1}, \overline{\mathbf{E}}_{i+1}). +\f] +Finally, we again compute the potential and electric field, now using the final +values of the densities. + +The size of the time step \f$\Delta t\f$ is determined by using a Courant-Friederichs-Levy (CFL) restriction for stability of the advection part of the equations: +\f[ + \texttt{max} E_r \frac{\Delta t}{\Delta r} + \texttt{max} E_z \frac{\Delta_t}{\Delta_z} < \nu_a. +\f] +There are additional restrictions from other diffusion and reaction parts of the +equations, but they are dominated by the CFL criterior for the advection part, see +[Montijn et al.][1]. +The value of \f$\nu_a\f$ is typically set to 0.25, which is well below the maximum +required for stability. +We refer the interested reader to the [Monograph by Hundsdorfer and Verwer][8]. + +\section sect_refinement Overview of refinement strategies and criteria + +\subsection sect_overview Overview + +The \c ARCoS simulation code contains functions for adaptive grid refinement (also known as adaptive mesh refinement or AMR). Since streamers span different length scales, there is a need to simulate relatively large physical domains while still having high spatial resolution in areas such as the streamer head. To ensure that such large domains can be simulated without giving up resolution and accuracy, the numerical grid is refined adaptively at each time step. The equations are solved on a coarse grid, after which the solution is analyzed using refinement criteria to determine the areas where refinement is needed. The equations are then solved on the refined subgrids after which the process is iterated. Grid generation and grid refinement are performed separately for the density equations and for the Poisson equation. + +There are three main refinement criteria. The first two concern refinement of the density grids: Refinement based on the absolute value of \f$\mathbf{E}\f$ and refinement based on the curvature of densities (both charge density and particle density). The grids used by the [FISHPACK][9] solver use their own refinement scheme where the decision to refine is made if the difference between the solution on a grid and the solution on a finer grid exceeds a threshold. The [FISHPACK][9] solver is used for both the Poisson equation that determines the electric potential of the system and the Helmholtz equations for the photoionization reactions. + +\subsection sect_size_refinement Size of the refined areas of the density grids + +All CDR (Convection-Diffusion-Reaction, CDR is the shorthand term for the density part of the code) refinement criteria are on a per-point basis, which means that the question whether to refine or not is initially answered for every grid cell. This is inconvenient for several reasons, primarily due to the computational cost of such a scheme. The regions containing the streamer head will almost always need to be refined, it is not necessary to evaluate this point-by-point in these regions. + +To ease this problem, a minimal refinement area is defined by two parameters:\n +\c cdr\_brick\_dr and \c cdr\_brick\_dz, see e.g., file default.cfg . The refinement module divides the grid it receives (this can be the coarsest grid covering the entire domain or a refined grid covering only part of the domain, the code and grid structure are recursive) into "bricks" of these dimensions and searches each brick for cells that match the refinement criteria. Once such a cell is found, the entire brick containing that cell is refined. + +For the [FISHPACK][9] module, a different approach is used. The refinement routine scans its input grid, starting at the top (\f$z = z_{min}\f$), going down per "line" (a set of cells with equal \f$z\f$d-coordinate). Once it finds a line with points that meet the refinement criterion it searches for the first line that does not contain any points that meet the criterion. It then refines the smallest rectangular area that contains all the points that meet the criterion. This process is repeated until the bottom (\f$z = z_{max}\f$) of the grid is reached. + + +\par Figure 2. The nested structure of refined density grids + +In Figure 2., +the black squares represent grid cells at the coarsest level (level 0), +the dark gray cells are the first refined sublevel (level 1). Two rectangular +grids are included at this level, their shared border is indicated by the +red line. +The light gray cells show grids at a further refined level (level 2). + + +\par Figure 3. The nested structure of refined Poisson grids + +The black grid, as shown in Figure 3. is the coarsest level, the dark gray cells are the first +refined sublevel, the light gray cells show grids at a further refined level. +Each grid has at most one subgrid. + +The tree of grids for the density equations may contain refined grids that are adjacent to each other. A schematic showing the nested structure of refined density grids is shown in [Figure 2.](#refinement_cdr). The red line in this figure indicates the shared border between two subgrids. For the Poisson-grids, such a structure is not possible and a grid can have at most one refined child-grid as depicted in [Figure 3.](#refinement_poisson). + +\subsection sect_criterion The |E| criterion + +The electric field criterion is the most simple of the three refinement criteria. It is an empirical criterion that is not directly motivated by the underlying numerics. A cell with coordinates \f$(r,z)\f$ qualifies for refinement if: +\f[ +|\mathbf{E}(r,z)| > E_c +\f] +where \f$E_c\f$ is the threshold electric field strength for refinement. \f$E_c\f$ is a user-determined parameter that is provided in the input file for a run. Since this criterion is independent of the grid level or the cell size, once a cell meets the criterion at the coarsest level, it will also do so at every refined level. Because of this property, the user can limit the refinement depth that is reached through this criterion with the \c ref\_level\_eabs input parameter, see e.g., file default.cfg. Setting \c ref\_level\_eabs to 1, for example, restricts the refinement from the coarsest level to the first refined level due to the \f$|\mathbf{E}|\f$ criterion. + +The \f$|\mathbf{E}|\f$ criterion is inflexible in the sense that it requires the user to have advance knowledge of what the field strengths will be. A possible alternative would be to replace the fixed threshold value \f$E_c\f$ by a dimensionless fraction \f$c\f$ and refine if +\f[ +|\mathbf{E}(r,z)| > c E_{max} +\f] +with \f$E_{max}\f$ the maximum electric field strength in the computational domain. Since the electric field criterion is mostly empirical, picking the right value for the refinement threshold may be a trial-and-error process. + +\subsection sect_curvature The curvature criteria + +There are two criteria that use the curvature of density functions in order to determine which areas to refine. If the curvature is large compared to the cell size, the numerics may become unreliable and it is desirable to work with a finer grid. For a density function \f$u(r,z)\f$ and a cell size \f$\triangle r \times \triangle z\f$ the curvature function \f$C_u(r,z)\f$ is a discretization of the second derivative of \f$u\f$ in cylindrical coordinates \f$(r,z)\f$: +\f[ + \begin{array}{ll} + C_u(r,z) = & \frac{1}{r + \frac{\triangle r}{2}}\Big[(r + \triangle r)\big(u(r + \triangle r, z) - u(r,z)\big) - r\big(u(r,z) - u(r - \triangle r,z)\big)\Big] + \\ + & \big[u(r, z + \triangle z) - 2 u(r,z) + u(r, z - \triangle z)\big]. + \end{array} +\f] +Rather than the absolute value of the curvature, the refinement module looks at the curvature relative to the global maximum, \f$Max(u)\f$. The final criterion then reads:\n +\n +\b Refine \f$(r,z)\f$ \b if \f$\frac{C_u(r,z)}{Max(u)} > C_t\f$\n +\n +with \f$C_t\f$ the threshold curvature. This refinement criterion is checked for two density functions \f$u\f$. The first is the (absolute) charge density function. Here an extra condition applies: the absolute value of the charge needs to exceed a certain threshold value (which is hard-coded) before a cell can qualify for refinement based on this criterion. Secondly, the curvature criterion is applied to the particle density functions. Since only mobile particles require a high spatial resolution, any immobile species are not considered in these criteria (which currently excludes all species other than electrons). The computational grids for these immobile species are simply the same as the grids used to solve the density equations for electrons. + +\subsection sect_fishpack FISHPACK refinement + +The [FISHPACK][9] module, for the Poisson equation and the photoionization equations, uses a different set of grids than the CDR module and with it a different refinement scheme. Initially, two grids are set up, one coarse and one fine grid (with the fine grid having twice the spatial resolution in each dimension, so 4 times the number of cells). The Poisson/Helmholtz equation is then solved on both grids and the solution of the coarse grid is interpolated onto the fine grid. A grid cell then qualifies for refinement if the absolute difference between the interpolated coarse solution and the fine solution (this difference is called the error) is more than some user-defined threshold. When refinement is needed, a new set of grids is determined using the strategy mentioned earlier and the process is repeated until either the desired accuracy is reached or the maximum number of allowed refinement levels is reached. Since the [FISHPACK][9] module was originally only used to solve the Poisson equation for the electrostatic problem and the value of the electric field +is defined on the edge of a cell, a cell that does not meet the error-criterion still qualifies for refinement if its neighbor does meet the error-criterion. + +One limitation to this scheme is the limited number of grid cells that the [FISHPACK][9] routine can handle. Since [FISHPACK][9] applies a cyclic reduction scheme, the round-off error increases with the number of grid cells. This places a limit on the size of grids that [FISHPACK][9] can solve. Once the refinement module wants to create a grid that is larger than the so-called [FISHPACK][9] limit, the refinement attempt is rejected and the code relaxes the error threshold by a factor of 2 and again determines the area to refine, using the new threshold. + +To solve the photoionization problem, two Helmholtz equations need to be solved (For details on the implementation of photoionization, the reader is referred to [PhD Thesis Wormeester(to appear in 2013)][6], Chapter 3, section Photoionization +and references therein). Each of the so-called "photo-terms" has its own characteristic absorption length, which depends on the gas density and oxygen ratio. The term with the short absorption length is often dominated by impact ionization in the head of the streamer, while the term with the long absorption length is the main contributor of electrons in front of the streamer head that are required for a positive streamer to propagate. + +The default behavior of the \c ARCoS code is to treat these two photoionization terms in the same manner as the Poisson problem when it comes to refinement: all user-definable parameters were equal. Since the term with the short absorption length gives rise to a solution that benefits strongly from high spatial resolution (due to the steep gradients) it will easily trigger the refinement criterion. However, it is this term that is dominated by impact ionization, see [Luque et al.][2], +which reduces the relevance of accurate computation of this term. The user can therefore specify the refinement criteria for each of the two photoionization terms separately, providing the user with the means to allow the important, long absorption length term to benefit from high spatial resolution, while reducing the computational cost incurred by the less important term. However, in tests it was found that tuning the refinement criteria for the photoionization terms has very little effect on +computational cost or results. + +\subsection sect_Conclusions Conclusion +The adaptive refinement scheme of \c ARCoS allows for the simulation of large domains while maintaining high spatial resolution in regions that require this. A number of refinement parameters influence both the computational performance and the accuracy of the results, which means that the user has to monitor the results carefully. Since the refinement criteria were setup by +[Montijn et al.][1]. +and +[Luque et al.][2]. +for simulations of air and pure nitrogen, application of the code to other gases may require changes to the values of the various thresholds used in the refinement criteria. An example is high-purity oxygen, with a small nitrogen admixture. In such a gas, ionizing photons will have a very short characteristic absorption length and the calculation of the photoionization terms should be done with high accuracy close to the photon source, primarily the streamer head. However, the limitation of the [FISHPACK][9] refinement method does not permit several smaller, adjacent +refined sub-grids, which makes it difficult to properly focus on the streamer head without including too much of the channel. + +\section sect_software ARCoS software + +\subsection sect_ARCoS_overview Basic overview and functionality + +The \c ARCoS simulation software was originally developed by Alejendro Luque as a more flexible version of the adaptive refinement code developed by Carolynne Montijn as described in [PhD Thesis Montijn][7]. +The original code by Montijn has been written in Fortran90, while \c ARCoS has been written in C. +The original [FISHPACK][9] package used for solving the Poisson and Helmholtz equations is written +in Fortran77 and was developed by Adams, Swarztrauber and Sweet. The \c ARCoS code is now compiled +with [FISH90][10], a modernization of the original [FISHPACK][9], employing Fortran90 to slightly +simplify and standardize the interface to some of the routines. + +\c ARCoS solves the fluid equations for streamers, described in section \ref sect_fluid_eq, +on nested Cartesian grids using an adaptive mesh refinement technique. +\c ARCoS allows for the simulation of both positive and negative streamers in the +electrode configurations plate-plate and needle-plate. +The needle-plate electrode geometry is included using a charge simulation method +[Luque et al.][2]. +This method replaces the electrode needle by a single point charge, with the +location and the size of the charge being updated at every time step to ensure the +potential at needle tip remains fixed at the predetermined value. +The limitation of this method is that the potential on the rest of the surface +of the simulated needle will not be accurate. +Consequently, the [continuity](#continuity) equation is only solved on +a smaller grid, not containing the simulated needle. + +The effect of this is that \c ARCoS is not well suited for the study of the +inception of streamers, as the area around the tip of the needle is not +accurately modelled. +However, since inception is often affected by the behavior +of individual particles, the use of a particle code such as described in +[Teunissen et al.][5] and [Li et al.][4]. +is recommended for studying streamer inception. +The purpose of the \c ARCoS code is to study streamer propagation in the phase +after the streamer has formed. +Studies performed by [Luque et al.][2] show that the dynamics of +streamers in later stages hardly depends on initial conditions. + +\c ARCoS allows the user full control over the numerical parameters of the +simulation: grid size, refinement criteria and CFL numbers can be set by the user. +The kinetic model, i.e., the list of particle species, their reactions and +initial densities as well as the diffusion and mobility coefficients can be +specified via a series of input files, allowing the user to fine-tune the properties +of the gas in which the streamer is simulated, see configuration file input/kinetic_example.cfg. + +The \c ARCoS code can be downloaded from the website +\c http://md-wiki.project.cwi.nl/ + +\subsection sect_IO Handling the software, input and output + +\subsubsection sect_sim Starting a simulation + +Two input parameter files governs all details of the simulation: + +\li \b Physical \b parameters such as voltage, electrode configuration, size of the gap, etc. +\li \b Numerical \b parameters such as grid size, refinement criteria, etc. +\li \b Practical \b details like the directory name, where the output files should be stored and the interval at which output should be generated. + +[libconfig](http://www.hyperrealm.com/libconfig/), a free library for processing +structured configuration files, is used for reading, manipulating and writing these files. +The first file, stored as input/default.cfg, must contain the default values for the global variables. +This file is a part of the streamer package distribution. +The second file, say input/user_init.cfg, an example is given by input/example_user_init.cfg, +has a structure analogously to input/default.cfg, and should contain the parameters which differ +from the default values. +The program delivers a configuration file, say input/example_user_continue.cfg with the updated parameters +from input/user_init.cfg completed with the default values of input/default.cfg. + +Since the execution time of a single run will take on the order of several days, it is recommended to +split the time period into smaller pieces, and restart the execution several times from the point +where the previous run stopped. +The easiest way to restart the simulation is + \li to copy the file input/user_continue.cfg into input/default.cfg, to be sure that equal values for the parameters are used, + \li to edit the file input/user_init.cfg, and change the \b \c t_end value, the \b \c restart value and the name of the \b \c load_file. See the end of of this section. + +The use of the configuration files construction has the following advantages: + \li recompilation of the code is not necessary in case of a restart + \li the user always has a clear overview of the parameter values used + \li results of different or continuing runs can be stored in different output directories, + as listed in the configuration file. + \li besides the parameter value also comment coupled to a parameter can be changed in the configuration files written by the user. The length of the comment must be restricted by 100 characters + \li the order of the parameters in the configuration file is free + \li the user has the possibility to control the simulation, many parameter values can be changed. + +It is easy to resume a simulation by using a set of output data as initial conditions. +One has to adapt the parameter file with modified start and end times for the simulation. +To start a \c ARCoS simulation use the following command from +the directory containing the executables: +\n +\code + ./arcos > out.example 2> err.example +\endcode +\n + +The \c ARCoS program starts and it will print out the parameter values used: + \li in \c out.example + \li in input/user_continue.cfg. + +The program will print some extra information to file \c out.example, e.g., the step size and +when a new set of output data has been written, and to which set of file names. +Warnings and errors will be printed in file \c err.example. The program can terminate in three different ways: + + \li The preset end-time is reached. + \li The program is terminated by the user. + \li The time-step (as determined by the Courant criterion for stability, more details to come) has dropped below a preset threshold. This usually points to some form of instability. + +In case the simulation runs on a PC or desktop machine, a convenient approach is to set a very +large value for the end time and, rather than having the program determine when to terminate, +keeping track of the progress of the streamer by checking the output files and manually terminating +the program when the desired output is reached, e.g., the streamer has reached the electrode, or, + it has started to branch. +In other cases, it may be necessary for the program to be able to run for a fixed amount of time. +For example when it needs to exit gracefully, which is required for profiling software to work. +Also in case of batch jobbing with a limited CPU wall clock time, like on most supercomputers, +the end time must be chosen corresponding to the wall clock time. + +Data files with periodical data controlled by \c $output_dt, stored in directory \c $output\_dir, +have names using the format \c variable.C123abc.tsv: + \tparam is a particle species or electric field, e.g. \c charge, \c d_dummyminus, \c d_electrons \n + \tparam <123> is the sequence number of that particular output dataset and \n + \tparam specified the subgrid the output belongs to. + +These files can be used to plot the solution or to restart the simulation. More details on this in the section on output files. To resume the example simulation from output set \c 123, call: +\n +\code +./arcos example C123 +\endcode +\n + +\subsubsection sect_input The input files + + +File and directory handling: + \li \b \c kin\_input - The filename of the [libconfig](http://www.hyperrealm.com/libconfig/) + input file containing the species, seeds and reactions. + By convention, these files have the extension \b .cfg. + \li \b \c output\_dir - The directory where the output files will be stored. + This can be a relative path to the directory with the executable or an absolute + path. When the execution starts, the directory $output_dir must be present and writable. + \li \b \c output\_dt - The interval (in dimensionless units) with which an output dataset is to be saved. + Lower values mean more frequent output, which gives finer grained time-dependent + data at the cost of more disk space. + +Physical parameters: + \li \b \c L\_r - Radius of the physical domain in dimensionless units. + \li \b \c L\_z - Length of the physical domain. Does not include the needle. + \li \b \c has\_photoionization - Whether to enable the photoionization module.\n + So, if \b \c has\_photoionization = 1, photoionization is present,\n + if \b \c has\_photoionization = 0, execution without photoionization.\n + \li \b \c photoionization\_file - Filename of the file containing the photoionization parameters.\n These parameters are further explained in appendix~ref{app:photoionization_parameters}. + +\todo: WRITE APPENDIX + + \li \b \c E0\_z, \b \c E0\_y, \b \c E0\_x - Components of the external electric field in dimensionless units. Since the electrodes are located at the top and bottom of the domain \f$(z = L_z\f$ and \f$z = 0)\f$, only \c E0\_z should be nonzero. Positive values of \c E0\_z will generate an electric field in the \f$^z\f$ direction, with the top electrode (at \f$z = L_z\f$) having a negative charge, generating negative streamers and vice verse. + \li \b \c pois\_inhom - Whether to use a needle-plane geometry or not.\n + If \b \c pois\_inhom = 1 then we have \b \c needle-plane case, \n + otherwise if \b \c pois\_inhom = 0 gives the plane-plane case. \n + See below for additional remarks regarding the needle-plane geometry. + \li \b \c needle\_length and \b \c needle\_radius - The length and radius of the needle in dimensionless units. Only applies when \b \c pois\_inhom = 1. + \li \b \c end\_t - Time at which the simulation will stop, in dimensionless units. + \li \b \c max\_ntheta - Number of azimuthal grid cells. Default \b \c max\_ntheta = 1. \n + \b \c max\_ntheta > 1 will activate the full 3D simulation (without cylindrical symmetry) using a pseudo-spectral method described in more detail in [Luque et al.(2011)][3]. + +Numerical parameters: + \li \b \c gridpoints\_r, \b \c gridpoints\_z - Number of gridpoints in \f$r\f$ and \f$z\f$ direction for the density equations at the coarsest level. + \li \b \c cdr\_max\_level - Maximum number of refinement levels of the grid for the fluid equations. \n + \b \c cdr\_max\_level = 0 means no refinement. + \li \b \c cdr\_bnd\_bottom, \b \c cdr\_bnd\_top, \b \c cdr\_bnd\_right - Boundary condition for the density equations at the bottom \f$(z = 0)\f$, top \f$(z = L_z)\f$ and right \f$(r = L_r)\f$ of the domain. \n + \b \c cdr\_bnd\_xxx = 1 gives homogeneous Neumann boundary conditions, \n + \b \c cdr\_bnd\_xxx = -1 gives homogeneous Dirichlet boundary conditions. + \li \b \c pois\_max\_level - Maximum number of refinement levels of the grid for the Poisson equation. +\b \c pois\_max\_level = 0 means no refinement. + \li \b \c pois\_bnd\_bottom, \b \c pois\_bnd\_top, \b \c pois\_bnd\_right - Boundary condition for the Poisson equation at the bottom \f$(z = 0)\f$, top \f$(z = L_z)\f$ and right \f$(r = L_r)\f$ of the domain. \n +\b \c pois\_bnd\_xxx = 1 gives homogeneous Neumann boundary conditions, \n +\b \c pois\_bnd\_xxx = -1 gives homogeneous Dirichlet. + +\subsubsection sect_parameter The parameter file + +In the parameter file input/default.cfg variables and their values are assigned with the following syntax +\verbatim +{ + type = "type"; /* type can be a "string", a "double", an "int" */ + name = "name"; /* variable name as defined in file include/parameters.h */ + comment = "comment"; /* description of the variable, maximum of 100 characters */ + value = "value"; /* value of type string, double or integer, related to "type" */ +}, + + # <-- this starts a comment-line, which is ignored. + + # White lines are also ignored. + # String-values should be between quotes, numeric values should not + pi=3.14 + # (Note: The above is an approximation) + # Scientific notation can be used: + pi_times_thousand=3.14E3 +\endverbatim + +Non-existent or misspelled parameters are ignored. +Parameters are not required, every parameter has a default value, which can be found +in function \b \c init_parameters of src/cstream.c. + +The following overview lists the parameters generally meant for testing purposes and changing them is not required for streamer simulations. Therefore they are best left at their default value. + +File and directory handling: + \li \b \c cdr\_output\_margin - Number of margin-cells to be added to the output of the density grids. 2 layers of ghost cells are added on the edge of the computational domain for the purpose of enforcing boundary conditions. With this parameter, these can be included in the output. Value must be smaller than or equal to 2. Default \b \c cdr\_output\_margin = 0. + \li \b \c pois\_output - Output the grids used in solving the Poisson equation? The grids used for the Poisson equation are different than those used for the density equations as detailed in section \ref sect_refinement. \b \c pois\_output = 0. Note that the absolute electric field is already saved as a density grid, so it is not required to set this parameter to 1 to obtain this data. + \li \b \c pois\_output\_margin - Number of margin-cells to be added to the output of the Poisson grids. Default \b \c pois\_output\_margin = 0. Note : \b \c pois\_output\_margin <= 2. + +Physical parameters: + \li \b \c start\_t - Initial time. This parameter is used when resuming simulations and is automatically updated in that case. + +Numerical parameters: \n + +The adaptive mesh refinement criteria and the parameters related to them are discussed in more detail in section \ref sect_refinement. + + \li \b \c ref\_threshold\_eabs - Refine grid if \f$|\mathbf{E}|\f$ exceeds this value. + \li \b \c ref\_level\_eabs - Maximum number of refinement levels of the grid for the fluid equation due to the \f$|\mathbf{E}|\f$ criterion. + \li \b \c ref\_threshold\_charge - Refinement threshold for the curvature of the charge density. + \li \b \c ref\_threshold\_dens - Refinement threshold for the curvature of the particle densities. + \li \b \c cdr\_brick\_r, \b \c cdr\_brick\_z - Size \f$(r\f$ and \f$z)\f$ of the minimal refinement area. See Section \ref sect_size_refinement. + \li \b \c pois\_max\_error - An area of the Poisson grid is further refined if the relative error between two consecutive refined levels exceeds this value. + \li \b \c nu\_a - Courant number based on advection to determine the time step. Note, that \b \c nu\_a < 1 to satisfy CFL stability. In streamer simulations, this time step restriction will dominate over other parameters (\b \c nu\_d (diffusion) and \b \c nu\_rt (reaction)). More details on the time stepping can be found in \ref sect_timestepping. + +\subsubsection sect_needle Implementation of the needle-plane configuration + +As mentioned in section \ref sect_overview , the needle-plane electrode geometry is +implemented using a charge simulation technique, which means that the entire needle is +represented by a single point charge located on the axis. +The position and strength of this charge is updated each time step to ensure that the +potential at the point that would be the tip of the needle remains fixed. +A schematic depiction of this setup can be seen in [Figure 1.](#setup). +This provides a reasonable approximation of the potential in the area below +the needle (the needle is always located at the top of the domain), but the potential +will be wrong in the areas to the sides of the needle. +Consequently, the density equations are only solved from the tip of the needle and downwards. +This means that the computational domain for the density equations is smaller than +that for the Poisson equation. + +In the specification of the external electric field, \c E0\_z is interpreted as the electric field between the two planar electrodes, far away from the needle. The applied potential is computed as follows: +\f[ + V = E_{0,z} * (L_z + L_{needle}) +\f] + +\subsubsection sect_output Output + +The code generates a large amount of output files at every \c \b output\_dt units +of simulated time. +These output files combined are sufficient to resume the simulation +from that time step and can also be used for data analysis. +Output files are named \c variable.C123abc.tsv, where 'tsv' stands for 'Tab-Separated Values'. +\c variable is a particle species or electric field. +Examples include \c electrons, \c n2plus and \c eabs +(the latter being \f$|\mathbf{E}|\f$). \c 123 is the sequence number or +output time step (which is unrelated to the time step of the numerical scheme) of that +output set, it starts at \c 000 for the first set. +This is the initial condition of the system before the simulation starts at \f$t = 0\f$. +The alphabetic part of the filename after the output time step, \c abc denotes the +subgrid contained in that file and this extension is defined recursively. +The coarsest grid covering the entire domain has no such alphabetical extension +(example: \c electrons.C123.tsv). +At every next level, the subgrids at that level are named \c a, \c b, \c c, ... +and this letter is appended to the alphabetical extension. +The file \c electrons.C123ba.tsv contains electron densities at the +123-th time step (so at \f$t = 123 * output\_dt\f$ ) for the first +subgrid of the second subgrid of the main grid. +Beware that since the grid refinement is adaptive, each time step has different subgrids. + + +\par Figure 4. Schematic depiction of the naming convention for output files. Each next letter corresponds to a new refined level. + +Data, as shown in Figure 4., is stored as plain text, +with each line containing a single number. +Data is ordered in columns (with fixed \f$r\f$ coordinate). +So to read the data, use the following pseudo-code: +\verbatim +for (i = 0, i < rmax*zmax; i++) +{ + r = floor(i / zmax); + z = i % zmax; + data[r,z] = read_line_from_file(); +} +\endverbatim + +The dimensions of the grid are not contained in the data files. +Instead, for each subgrid and output-step, two additional files are created: + +1. _r.C123abc.tsv_\n +2. _z.C123abc.tsv_\n +\n + +corresponding to subgrid _abc_ of output step _123_. The structure of these files is identical to that of the regular data files, but instead of particle densities or electric field strengths, these files contain the \f$r\f$ and \f$z\f$ coordinates of the center of the cell corresponding to that line-number. So to determine the coordinates of the \f$n^{th}\f$ line in a regular data file, simply read the \f$n^{th}\f$ line of the corresponding \b r and \b z files. + +\subsubsection sect_structure File structure + + +\par Figure 5. File structure of of ARCoS package. + +The distribution of the ARCoS package contains several directories: + +\li \b \c FISH90 - the directory where FISH90 or FISHPACK should be downloaded + +\li \b \c output - this directory may be empty. Its name must correspond to the value of \b \c output_dir in file input/default.cfg. Or, the value in input/user_init.cfg if present. +\li \b \c python - contains plot files. By means of \b \c plotvar pictures can be made of the output files. Not yet implemented. +\li \b \c doc - directory with files for [Doxygen][12] to generate documentation from source code and this \b \c MANUAL. The source of this manual (in MANUAL.md) can be found in its directory \b \c markdown. See also the \b \c doxygen_config_file. +\li \b \c arcos_f90 - a part of the \b \c functions in file cdr.c have been replaced by a piece of \b \c FORTRAN90 code in order to accelerate the simulation. +\li \b \c src - this directory contains the source files written in \b \c c. +\li \b \c include - this directory contains the include files +\li \b \c input - this directory contains all input files. Most of them are libconfig configuration files. + + +\subsubsection sect_source Source files + +The \c ARCoS simulation software was mostly written in \c C and its source code is split up in several files, each dealing with a separate part of the program. Most source files have an associated header file (the source file \b \c example.c has header file \b \c example.h ) containing the type-definitions and preprocessor macros. The function prototypes are aggregated in the header file \c proto.h. Below is a short summary of the important source files and the functionality that is contained within them. + + \li cdr.c - Functions for solving the convection-diffusion-reaction (CDR) equations, creation, manipulation and refinement of CDR grids and time stepping. + \li configuration.c - Module for input/output of parameters. The code uses the library +[libconfig](http://www.hyperrealm.com/libconfig/) + \li cstream.c - Contains some general initialization and termination functions. + \li dft.c - Functions related with discrete fourier transformations. + \li grid.c - Low-level functions for handling of grids, both CDR and Poisson grids. + \li interpol2.c - Interpolation functions for the mapping of one grid to another (for example during refinement). + \li main.c - Functions for reading input parameters, starting of the code and the main loop. + \li mapper.c - Mapping of one grid tree onto another. + \li misc.c - Miscellaneous utilities for allocating memory. + \li photo.c - Photoionization functions. + \li poisson.c - Functions for solving the Poisson equation, including manipulation of Poisson grids and calling the external [FISPACK][9] solver. + \li reaction.c - Functions for computation of reactions between species as part of the density equations. + \li react_table.c - Performs initialization of reaction coefficient tables as well as table lookups. + \li rt.c - Functions for handling the loading of the input file containing the kinetic model (species, reactions, seeds). + \li rz_array.c - Low-level functions for handling Fortran-compatible arrays. + \li sprites.c - Routines for the sprites module. diff --git a/doc/markdown/MANUAL.md_cp01 b/doc/markdown/MANUAL.md_cp01 new file mode 100644 index 0000000000000000000000000000000000000000..d6cf4bb8e20884ba425b1a3c919db9bd91433622 --- /dev/null +++ b/doc/markdown/MANUAL.md_cp01 @@ -0,0 +1,897 @@ +\section Contents +
    +
  • + \ref sect_fluid_eq +
      +
    • + \ref sect_physical +
        +
      • \ref sect_ddr
      • +
      • \ref sect_elecpotfield
      • +
      • \ref sect_rescaling
      • +
      +
    • +
    • \ref sect_bic
    • +
    • + \ref sect_numeric +
        +
      • \ref sect_dde
      • +
      • \ref sect_dpe
      • +
      +
    • +
    • \ref sect_timestepping
    • +
    +
  • +
  • + \ref sect_refinement +
      +
    • \ref sect_overview
    • +
    • \ref sect_size_refinement
    • +
    • \ref sect_criterion
    • +
    • \ref sect_curvature
    • +
    • \ref sect_fishpack
    • +
    • \ref sect_Conclusions
    • +
    +
  • +
  • + \ref sect_software +
      +
    • \ref sect_ARCoS_overview
    • +
    • + \ref sect_IO +
        +
      • \ref sect_sim
      • +
      • \ref sect_input
      • +
      • \ref sect_parameter
      • +
      • \ref sect_needle
      • +
      • \ref sect_output
      • +
      • \ref sect_structure
      • +
      • \ref sect_source
      • +
      +
    • +
    +
  • +
+ +\section sect_fluid_eq Fluid model + +\subsection sect_physical Physical model + +\subsubsection sect_ddr Drift-diffusion-reaction equations + +[1]: http://homepages.cwi.nl/~ebert/CaroJCP06.pdf "Montijn et al." +[2]: http://homepages.cwi.nl/~ebert/LuqueAPL07.pdf "Luque et al." +[3]: http://homepages.cwi.nl/~ebert/StrBranchLuque2011.pdf "Luque et al.(2011)" +[4]: http://homepages.cwi.nl/~ebert/JCP-Li-12.pdf "Li et al." +[5]: http://arxiv.org/abs/1301.1552 "Teunissen et al.". +[6]: http:// "PhD Thesis Wormeester(to appear in 2013)" +[7]: http://alexandria.tue.nl/repository/books/598717.pdf "PhD Thesis Montijn" +[8]: http://homepages.cwi.nl/~willem/ "Monograph by Hundsdorfer and Verwer" +[9]: http://www2.cisl.ucar.edu/resources/legacy/fishpack "Fishpack" +[10]: http://www2.cisl.ucar.edu/resources/legacy/fishpack90 "Fish90" +[11]: http://www.amazon.com/books/dp/3540194622 "Y. P. Raizer, Gas Discharge Physics" +[12]: http://www.stack.nl/~dimitri/doxygen/manual/index.html "Doxygen" + + +In a fluid model of a streamer, we replace the individual particles in the +system by a density function \f${n}(\mathbf{r},t)\f$. +The temporal evolution of this density function is governed by the physical +processes of the system and this model takes the form of a set of partial +differential equations (PDEs). +The derivation of this so-called classical streamer model starts from the +continuity equation. For particle species \f$i\f$, we have: +\f[ + \frac{\partial n_i(\mathbf{r},t)}{\partial t} + \nabla \cdot \mathbf{j}_i(\mathbf{r},t) = S_i(\mathbf{r},t). +\f] + +Here \f$S_i(\mathbf{r},t)\f$ represents the total of all sources and sinks of +species \f$i\f$. \f$\mathbf{j}_i(\mathbf{r},t)\f$ is the term for the particle +current density of species \f$i\f$. +Particles can drift and diffuse as described by the following +expression for the particle current density +\f$\mathbf{j}_i\f$: +\f[ + \mathbf{j}_i(\mathbf{r},t) = \mu_i n_i(\mathbf{r},t) \mathbf{E}(\mathbf{r},t) - D_i \nabla n_i (\mathbf{r},t). + +\f] +In the above equation, the first term represents the particle drift due +to the electric field, with \f$\mu_i\f$ the mobility coefficient of species \f$i\f$. +The second term represents the diffusion of particles due to the spatial gradient in particle densities with diffusion coefficient \f$D_i\f$. These equations can be derived from the Boltzmann equation + +On the timescales involved, we consider only electrons to be mobile, while ions and neutrals remain stationary, which means that for heavy species, the [continuity equation](#continuity) is reduced to +\f[ + \frac{\partial n_i(\mathbf{r},t)}{\partial t} = S_i(\mathbf{r},t). +\f] + +The sources and sinks in the first equation play a very important role in the dynamics of the streamer. In this model, the sources and sinks correspond to reactions between the different charged and neutral species present in the gas. The source term due to a single reaction is the product of the densities of the species involved in the reaction and the field-dependent rate coefficient for that reaction. + +As an example, the impact ionization reaction +\f[ + e^- + \mathbf{N}_2 \rightarrow 2 e^- + \mathbf{N}_2^+ +\f] +is modeled by +\f[ + S_{ionization} = k_{ion}(|\mathbf{E}|) n_e [\mathbf{N}_2]. +\f] +Here \f$n_e\f$ is the local electron density, \f$[\mbox{N}_2]\f$ the density of +\f$\mbox{N}_2\f$ and \f$k_{ion}\f$ the reaction coefficient for impact ionization +depending on the magnitude of the local electric field. +The value of \f$k\f$ can be determined in different ways, from experiments, +theoretical calculations or simulations. +The traditional approximation suggested by Townsend +uses an empirical expression for the impact ionization term, see the +[book by Y. P. Raizer, "Gas Discharge Physics"][11]: +\f[ + \frac{dn_e}{dt} = n_e \mu_e |\mathbf{E}| \alpha_0 e^{-E_0 / |\mathbf{E}|}, +\f] +where \f$\mu_e\f$ is the electron mobility coefficient, +\f$\mathbf{E}\f$ is the local electric field and \f$\alpha_0\f$ and \f$E_0\f$ are +parameters that can be determined by fitting experimental data. +In gases that contain an electronegative admixture, such as \f$\mathbf{O}_2\f$, the process of +attachment can provide a sink for the electron density through the following +reactions: +\f[ + e^- + \mathbf{O}_2 \rightarrow \mathbf{O} + \mathbf{O}^- +\f] +\f[ + e^- + \mathbf{O}_2 + \mathbf{O}_2 \rightarrow \mathbf{O}_2^- + \mathbf{O}_2 +\f] +The first attachment process is dissociative attachment, the second an example +of a 3-body attachment (a 3-body attachment can also occur with an oxygen and nitrogen +molecule). +In the case of the 3-body attachment, the reaction rate scales with the square of the oxygen density: +\f[ + S_{3-body-att} = k_{3-body-att}(|\mathbf{E}|) n_e [\mathbf{O}_2]^2. +\f] +Further ionization losses can occur via one or more recombination processes, +but these typically have a timescale that is much longer than the timescale of +streamer development and propagation and are therefore primarily interesting for +the evolution of the charge density after a streamer discharge, +as discussed in [PhD Thesis Wormeester(to appear in 2013)][6], Chapter 5. + + + +In gases with attachment, detachment may occur, resulting in an additional +source of electrons. +In gases that contain both nitrogen and oxygen, the photoionization process +provides a non-local source of electrons. +Since photoionization is non-local, it can not be modelled by simple reaction +equations such as the ones for impact ionization. +Instead, the local contribution of photoionization is calculated by spatially +integrating contributions from the entire domain. +The commonly used model for photoionization and the approximations made to make +this model suitable for simulation are discussed in +[PhD Thesis Wormeester(to appear in 2013)][6], Chapter 3, section Photoionization. + +The reaction model for streamer simulations can be very minimal or very extended, +with many species and reactions, including metastables and various excited states. +The complexity of the reaction model depends on the purpose of the simulations. +For negative streamers in nitrogen, a model containing no more than three species +(\f$\mbox{e}^-\f$, \f$\mbox{N}_2\f$ and \f$\mbox{N}_2^+\f$) and one reaction +(impact ionization) +is sufficient to simulate the dynamics of the streamer head, see [Montijn et al][1]. +For more detailed studies of the streamer chemistry, the reaction model should be +as complete as possible. + + +\subsubsection sect_elecpotfield Electric potential and field + +The streamer evolves under the influence of an electric field, which consists +of an externally applied electric field and the electric field generated by +space charges. +These space charges are present at the head of the streamer as well as on the edge of the streamer channel. +For the further propagation of the streamer, the enhanced electric field in front of the streamer, generated by the space charge in the streamer head is essential. +We compute the net charge density +\f$q(\mathbf{r},t)\f$: +\f[ + q(\mathbf{r},t) = e \sum_i q_i n_i(\mathbf{r},t), +\f] +where for species \f$i\f$, \f$n_i\f$ +denotes the density function of these species and \f$q_i\f$ the charge of +a particle in units of the electron charge \f$e\f$. +From this we compute the potential by solving the Poisson equation +\f[ + \nabla^2 \phi(\mathbf{r},t) = \frac{q(\mathbf{r},t)}{\epsilon_0} +\f] +and the electric field +\f[ + \mathbf{E}(\mathbf{r},t) = -\nabla \phi(\mathbf{r},t). +\f] + +\subsubsection sect_rescaling Rescaling to dimensionless units + +The classical fluid model for streamers can be rescaled to dimensionless units and +it is with these units that the code used in this documentation works. +We refer the interested reader to the +[PhD thesis of Gideon Wormeester (to appear in 2013)][6]. +From the [Townsend](#townsend_ionization) approximation for ionization, +a characteristic field and length scale +emerges: \f$E_0\f$ and \f$l_0 = \alpha_0^{-1}\f$, respectively. +The characteristic velocity follows from the drift velocity of electrons +in the characteristic field, +\f[ + E_0: v_0 = \mu_e E_0. +\f] + +The characteristic number density follows from the [Poisson](#Poisson) equation. +Values for \f$\alpha_0\f$, \f$E_0\f$ and \f$\mu_e\f$ were obtained from +[PhD Thesis Montijn][7] +and are at standard temperature and pressure: +\f{eqnarray*} + \alpha_0 & \simeq & 4332 \quad \mbox{cm}^{-1}\\ + E_0 & \simeq & 2 \times 10^5 \quad \mbox{V} \mbox{cm}^{-1}\\ + \mu_e & \simeq & 380 \quad \mbox{~cm}^2 \mbox{V}^{-1} \mbox{s}^{-1}. +\f} + +When we insert these values in the characteristic scales, we obtain the values with which to rescale the equations: +\f{eqnarray*} + l_0 & \simeq & 2.3 \times 10^{-4} \quad \mbox{~cm}\\ + t_0 & \simeq & 3.0 \times 10^{-12} \quad \mbox{~s}\\ + n_0 & \simeq & 4.7 \times 10^{14} \quad \mbox{~cm}^{-3}\\ + D_0 & \simeq & 1.8 \times 10^{4} \quad \mbox{~cm}^2 \mbox{s}^{-1}. +\f} +We can now make the appropriate substitutions +(\f$t^d = t / t_0\f$ and similarly for the other variables; +the superscript \f${\;}^d\f$ will be used to indicate that a variable is +in dimensionless form, where this is not clear from the context. +For clarity of reading, the superscript \f${\;}^d\f$ will be omitted where it is clear that variables are +dimensionless) to obtain the classical fluid equations in +dimensionless continuity form: +\f[ + \partial_{t} + \nabla \cdot \mathbf{j}_i = S_i, +\f] +where \f$t\f$ is the dimensionless time, \f$\mathbf{j}_i\f$ the dimensionless +particle density current for species \f$i\f$ and \f$S_i\f$ the dimensionless source term +for species \f$i\f$. +\f$S_i\f$ is obtained by rewriting reaction equations such as the +[impact ionization reaction](#reaction_imp_ion) equation in dimensionless form, +where we remark that all rate-coefficients should also be rescaled. +The particle density current \f$\mathbf{j}_i\f$ is obtained by rescaling +[expression](#current_dens) into +equation +\f[ + \mathbf{j}_i = -\mu_i n_i \mathbf{E} - D_i \nabla n_i, +\f] +where \f$\mathbf{E}\f$ is the dimensionless electric field and \f$n_i\f$, +\f$D_i\f$ and \f$\mu_i\f$ are the dimensionless particle density, +diffusion coefficient and mobility respectively of species \f$i\f$. +We find that in dimensionless units \f$\mu_i\f$ is equal to 1 while for heavy particles +\f$\mu_i\f$ is taken as 0, since heavy particles are assumed to be stationary in +this model. +The [dimensionless current density equation](#current_dens_dimless) can therefore be simplified to +\f[ + \mathbf{j}_e = -n_e \mathbf{E} - D_e \nabla n_e +\f] +for electrons and \f$ \mathbf{j}_i = 0 \f$ for heavy particles. +The expression for the [charge density equation](#charge_dens) \f$q\f$, is rescaled to +\f[ + q(\mathbf{r},t) = \sum_i q_i n_i(\mathbf{r},t). +\f] +The [Poisson](#Poisson) equation is rescaled to +\f[ + \nabla^2 \phi = q. +\f] +We remark that although the code +described here internally +works with the dimensionless equations and variables described in this section, +all results are presented in regular units unless otherwise noted. +Input parameters for the simulation code are expected to be in dimensionless units. +Finally we note that the rescaling to dimensionless units does not change +the structure of the equations, it is merely a rescaling to a different +set of units, where the dimensionless units yield a set of equations where some +constants (such as \f$e\f$, \f$\epsilon_0\f$, \f$\mu_e\f$) become unity. + +\subsection sect_bic Boundary and initial conditions + + +We consider a cylindrical computational domain with coordinates: +\f[ +(r,z,\theta) \in (0,L_r) \times (0,L_z) \times (0,2\pi). +\f] +Although the code described here is capable of performing full 3D calculations, +we assume cylindrical symmetry to greatly simplify the computations. +For any spatially dependent function \f$f(r,z,\theta)\f$, we assume: +\f$\partial_{\theta} f(r,z,\theta) = 0\f$. +Consequently, the coordinate system for our computations is limited to +\f$(0,L_r) \times (0,L_z)\f$. +We consider a setup with a powered electrode at \f$z = L_z\f$ and a grounded +electrode at \f$z = 0\f$. +If the powered electrode is a plate, the following boundary conditions are used for +the electric potential \f$\phi(r,z,t)\f$: + +\f[ + \begin{array}{llll} + \forall z \; & \partial_r \phi(0,z,t) & = & 0\\ + \forall r \; & \phi(L_r,z,t) & = & 0\\ + \forall z \; & \phi(r,0,t) & = & 0\\ + \forall r \; & \phi(r,L_z,t) & = & \phi_0 + \end{array} +\f] + +with \f$\phi_0\f$ the potential applied to the powered electrode. +If the powered electrode is a needle protruding from a plate, the needle has the +same potential \f$\phi_0\f$ as the plate. + + +\par Figure 1. Schematic of the computational setup. + +In Figure 1., the shaded rectangle represents the computational domain for +the fluid equations, the thick horizontal lines the two planar electrodes +with the needle and its parameters depicted at the anode. +The area between the two planar electrodes is the computational domain +for the Poisson equation. +The needle is simulated by a single point charge, \f$Q\f$, chosen such +that \f$\phi =\phi_0\f$ in the point \f$P\f$, which is the tip of the needle. +The calculation assumes cylindrical symmetry around the needle axis +represented by the dashed-dotted line. + +For the density equations, we use homogeneous Neumann conditions on all edges: +\f[ + \partial_r n(0,z,t) = \partial_r n(L_r,z,t) = \partial_z n(r,0,t) = \partial_z n(r,L_z,t) = 0, +\f] +where we remark that if the powered electrode is a needle, the computational domain +for the density equations is smaller than the computational domain for the Poisson +equation and the \f$L_z\f$ values for both domains are not equal. +This difference is a requirement of the numerical implementation of the needle +electrode and is further detailed in section \ref sect_needle. + +While the boundary conditions mentioned above are the ones used by Wormeester, +the code that was used can also handle different choices of boundary conditions: +both homogeneous Neumann and homogeneous Dirichlet boundary conditions are available +for the top (\f$z = L_z\f$), bottom (\f$z = 0\f$) and right (\f$r = L_r\f$) +edges of the domain for both the densities and the potential. +The Neumann condition on the central axis of the cylindrical domain is required +for symmetry reasons. + +As initial conditions for particle densities, two types of seeds are implemented in +the code. A homogeneous seed, with a constant density over the entire domain and a +Gaussian seed of the form +\f[ + n(r,z,0) = n_{max} \mbox{exp}(-\frac{r^2 + (z - z_0)^2}{\sigma^2}). +\f] +Here \f$z_0\f$ specifies the \f$z\f$-coordinate of the maximum of the seed +(which is located on the symmetry axis with \f$r = 0\f$), where the density is +\f$n_{max}\f$. \f$\sigma\f$ is a measure of the radius of the seed, it is the distance +at which the density drops to \f$e^{-1}\f$ of the maximum value. + +In typical streamer simulations, a seed of electrons and positive ions is placed at the tip of the needle to initiate the discharge. Other than these Gaussian seeds and the neutral background gas, initial particle densities are zero with the possible exception of added background ionization, a homogeneous density of negative and positive ions. The initial distribution of electrons and ions is charge neutral at every point of the domain. + +\subsection sect_numeric Numerical method + +The physical equations in section \ref sect_fluid_eq are to be solved numerically. +The computational code we have applied for this uses finite volume methods to solve +a discretized version of the physical equations. +Here we give a basic summary of the numerical technique used. +For more details, the reader is referred to the work of [Montijn et al.][1], +upon which the current code is based. + +\subsubsection sect_dde Discretization of density equations + +The [dimensionless continuity ](#continuity_dimless) and the [dimensionless current density](#current_dens_dimless) equations +are discretized using finite volume methods and solved on a uniform rectangular grid with cells: +\f[ + C_{ij} = [(i - 1) \Delta r, i \Delta r] \times [(j - 1) \Delta z, j \Delta z]\left(i = 1 , \cdots , \frac{L_r}{\Delta r}, j = 1 , \cdots , \frac{L_z}{\Delta z}\right), +\f] +where \f$L_r\f$ and \f$L_z\f$ are the \f$r\f$- and \f$z\f$-dimensions of the grid and \f$\Delta r\f$ and \f$\Delta z\f$ the size of a cell in \f$r\f$- and \f$z\f$-direction, respectively. Particle density distributions are represented by their value in the cell center, which can be seen as an average over the cell. For some species \f$n\f$, we use \f$n_{i,j}\f$ to denote the density at the cell center \f$C_{ij}\f$. For sake of clarity of notation we omit the superscript \f$^d\f$ indicating that variables are in dimensionless units. + +The discretized continuity equations in cylindrical coordinates, with cylindrical symmetry (\f$\partial_{\theta} f = 0\f$) assumed, have the following form: +\f[ + \begin{array}{ll} + \frac{d n_{i,j}}{d t} = & \frac{1}{r_i \Delta r} \Big(r_{i - \frac{1}{2}} F^a_{i - \frac{1}{2},j} - r_{i + \frac{1}{2}} F^a_{i + \frac{1}{2},j} + r_{i - \frac{1}{2}} F^d_{i - \frac{1}{2},j} - r_{i + \frac{1}{2}} F^d_{i + \frac{1}{2},j}\Big) + \\ + & \frac{1}{\Delta z} \Big(F^a_{i,j - \frac{1}{2}} - F^a_{i,j + \frac{1}{2}} + F^d_{i,j - \frac{1}{2}} - F^d_{i,j + \frac{1}{2}}\Big) + S_{i,j}. +\end{array} +\f] +Here \f$F^a\f$ and \f$F^d\f$ represent the advective and diffusive fluxes across the cell boundaries. Since we assume ions and neutral particles to be stationary, these terms are nonzero only for electrons. For heavy particles, only the source term \f$S_{ij}\f$ remains. + +The advective flux, \f$F^a\f$ uses an upwind scheme with flux limiting and is defined as follows: +\f[ + \begin{array}{ll} +F^a_{i + \frac{1}{2},j} = & E^+_{r; ~ i + \frac{1}{2},j} \Big[ n_{i,j} + \psi(P_{i,j})(n_{i+1,j} - n_{i,j}) \Big] \\ +& E^-_{r; ~ i + \frac{1}{2},j} \Big[ n_{i + 1,j} + \psi(\frac{1}{P_{i+1,j}})(n_{i,j} - n_{i+1,j}) \Big] +\end{array} +\f] + +\f[ + \begin{array}{ll} + F^a_{i,j + \frac{1}{2}} = & E^+_{z; ~ i,j + \frac{1}{2}} \Big[ n_{i,j} + \psi(Q_{i,j})(n_{i,j+1} - n_{i,j}) \Big] \\ + & E^-_{z; ~ i,j + \frac{1}{2}} \Big[ n_{i,j + 1} + \psi(\frac{1}{Q_{i,j+1}})(n_{i,j} - n_{i,j+1}) \Big], +\end{array} +\f] +where \f$E^+ = max(-E,0)\f$ and \f$E^- = min(-E,0)\f$ are used to distinguish the upwind directions for the components of the electric field, \f$E_r\f$ and \f$E_z\f$, and we have +\f[ +\begin{array}{lll} + P_{i,j} & = & \frac{n_{i,j} - n_{i-1,j}}{n_{i+1,j} - n_{i,j}}\\ + Q_{i,j} & = & \frac{n_{i,j} - n_{i,j-1}}{n_{i,j+1} - n_{i,j}}. +\end{array} +\f] +\f$\psi\f$ is the Koren limiter function: +\f[ + \psi(x) = max(0, min(1, \frac{1}{3} + \frac{x}{6}, x)). +\f] +The diffusive flux \f$F^d\f$ is calculated using a second-order central differences scheme: +\f[ +\begin{array}{lll} + F^d_{i + \frac{1}{2},j} & = & \frac{D}{\Delta r}(n_{i,j} - n_{i+1,j})\\ + F^d_{i,j + \frac{1}{2}} & = & \frac{D}{\Delta z}(n_{i,j} - n_{i,j+1}) +\end{array} +\f] +and the reaction term \f$S_{i,j}\f$ is computed as +\f[ + S_{i,j} = \sum_{A~\in~{reactions}} \Big[ k_A(|\mathbf{E}|_{i,j}) \prod_{s~\in~{Spec(A)}} n_{s; i,j} \Big] +\f] +where \f$k_A\f$ denotes the field-dependent reaction rate coefficient of +reaction \f$A\f$, and \f$Spec(A)\f$ the set of species that appear as an input +for reaction \f$A\f$. + +\subsubsection sect_dpe Discretization of the Poisson equation + +We compute the net charge \f$q_{i,j}\f$ in a cell center by adding up the contributions from the individual charged species: +\f[ + q_{i,j} = \sum_{s~\in~{species}} n_{s; i,j} q_s. +\f] +With this net charge, the electric potential \f$\phi\f$ can be computed in the cell centers through a second-order central approximation of the dimensionless Poisson equation: +\f[ + q_{i,j} = \frac{\phi_{i+1,j} - 2 \phi_{i,j} + \phi_{i-1,j}}{\Delta r^2} + \frac{\phi_{i+1,j} - \phi_{i-1,j}}{2r_{i,j} \Delta r} + \frac{\phi_{i,j+1} - 2 \phi_{i,j} + \phi_{i,j-1}}{\Delta z^2}. +\f] +From the potential we can compute the components of the electric field from \f$\mathbf{E} = - \nabla \phi\f$ in the cell boundaries: +\f[ +\begin{array}{lll} + E_{r; ~ i + \frac{1}{2},j} & = & \frac{\phi_{i,j} - \phi_{i+1,j}}{\Delta r}\\ + E_{z; ~ i,j + \frac{1}{2}} & = & \frac{\phi_{i,j} - \phi_{i,j+1}}{\Delta r}. +\end{array} +\f] +The electric field strength is determined at the cell center, so we have to compute the field components in the center by averaging the values on the boundaries after which we can compute the field strength: +\f[ + |\mathbf{E}|_{i,j} = \sqrt{\left(\frac{E_{r;i - \frac{1}{2},j} + E_{r;i + \frac{1}{2},j}}{2}\right)^2 + \left(\frac{E_{z;i,j - \frac{1}{2}} + E_{z;i,j + \frac{1}{2}}}{2}\right)^2}. +\f] + +\subsection sect_timestepping Time stepping + +The code uses the explicit trapezoidal rule, a second order Runge-Kutta method, +for the temporal discretization with time step \f$\Delta t\f$. +Given some time step \f$t_i = i \Delta t\f$, density distributions +\f$\mathbf{n}_i(r,z) = \mathbf{n}(r,z,t_i)\f$ and electric field +\f$\mathbf{E}_i(r,z) = \mathbf{E}(r,z,t_i)\f$, the densities and field at the next +time step, \f$t_{i+1}\f$ are calculated by first computing an intermediate result +for the densities: +\f[ + \overline{\mathbf{n}}_{i+1} = \mathbf{n}_i + \Delta t F(\mathbf{n}_i, \mathbf{E}_i). +\f] +Using these intermediate densities, the potential can be computed by solving the +Poisson equation, after which we obtain the intermediate electric field +\f$\overline{\mathbf{E}}_{i+1}\f$. +With this, we compute the final values of the densities at \f$t_{i+1}\f$: +\f[ + \mathbf{n}_{i+1} = \mathbf{n}_i + \frac{\Delta t}{2} F(\mathbf{n}_i, \mathbf{E}_i) + \frac{\Delta t}{2} F(\overline{\mathbf{n}}_{i+1}, \overline{\mathbf{E}}_{i+1}). +\f] +Finally, we again compute the potential and electric field, now using the final +values of the densities. + +The size of the time step \f$\Delta t\f$ is determined by using a Courant-Friederichs-Levy (CFL) restriction for stability of the advection part of the equations: +\f[ + \texttt{max} E_r \frac{\Delta t}{\Delta r} + \texttt{max} E_z \frac{\Delta_t}{\Delta_z} < \nu_a. +\f] +There are additional restrictions from other diffusion and reaction parts of the +equations, but they are dominated by the CFL criterior for the advection part, see +[Montijn et al.][1]. +The value of \f$\nu_a\f$ is typically set to 0.25, which is well below the maximum +required for stability. +We refer the interested reader to the [Monograph by Hundsdorfer and Verwer][8]. + +\section sect_refinement Overview of refinement strategies and criteria + +\subsection sect_overview Overview + +The \c ARCoS simulation code contains functions for adaptive grid refinement (also known as adaptive mesh refinement or AMR). Since streamers span different length scales, there is a need to simulate relatively large physical domains while still having high spatial resolution in areas such as the streamer head. To ensure that such large domains can be simulated without giving up resolution and accuracy, the numerical grid is refined adaptively at each time step. The equations are solved on a coarse grid, after which the solution is analyzed using refinement criteria to determine the areas where refinement is needed. The equations are then solved on the refined subgrids after which the process is iterated. Grid generation and grid refinement are performed separately for the density equations and for the Poisson equation. + +There are three main refinement criteria. The first two concern refinement of the density grids: Refinement based on the absolute value of \f$\mathbf{E}\f$ and refinement based on the curvature of densities (both charge density and particle density). The grids used by the [FISHPACK][9] solver use their own refinement scheme where the decision to refine is made if the difference between the solution on a grid and the solution on a finer grid exceeds a threshold. The [FISHPACK][9] solver is used for both the Poisson equation that determines the electric potential of the system and the Helmholtz equations for the photoionization reactions. + +\subsection sect_size_refinement Size of the refined areas of the density grids + +All CDR (Convection-Diffusion-Reaction, CDR is the shorthand term for the density part of the code) refinement criteria are on a per-point basis, which means that the question whether to refine or not is initially answered for every grid cell. This is inconvenient for several reasons, primarily due to the computational cost of such a scheme. The regions containing the streamer head will almost always need to be refined, it is not necessary to evaluate this point-by-point in these regions. + +To ease this problem, a minimal refinement area is defined by two parameters:\n +\c cdr\_brick\_dr and \c cdr\_brick\_dz, see e.g., file default.cfg . The refinement module divides the grid it receives (this can be the coarsest grid covering the entire domain or a refined grid covering only part of the domain, the code and grid structure are recursive) into "bricks" of these dimensions and searches each brick for cells that match the refinement criteria. Once such a cell is found, the entire brick containing that cell is refined. + +For the [FISHPACK][9] module, a different approach is used. The refinement routine scans its input grid, starting at the top (\f$z = z_{min}\f$), going down per "line" (a set of cells with equal \f$z\f$d-coordinate). Once it finds a line with points that meet the refinement criterion it searches for the first line that does not contain any points that meet the criterion. It then refines the smallest rectangular area that contains all the points that meet the criterion. This process is repeated until the bottom (\f$z = z_{max}\f$) of the grid is reached. + + +\par Figure 2. The nested structure of refined density grids + +In Figure 2., +the black squares represent grid cells at the coarsest level (level 0), +the dark gray cells are the first refined sublevel (level 1). Two rectangular +grids are included at this level, their shared border is indicated by the +red line. +The light gray cells show grids at a further refined level (level 2). + + +\par Figure 3. The nested structure of refined Poisson grids + +The black grid, as shown in Figure 3. is the coarsest level, the dark gray cells are the first +refined sublevel, the light gray cells show grids at a further refined level. +Each grid has at most one subgrid. + +The tree of grids for the density equations may contain refined grids that are adjacent to each other. A schematic showing the nested structure of refined density grids is shown in [Figure 2.](#refinement_cdr). The red line in this figure indicates the shared border between two subgrids. For the Poisson-grids, such a structure is not possible and a grid can have at most one refined child-grid as depicted in [Figure 3.](#refinement_poisson). + +\subsection sect_criterion The |E| criterion + +The electric field criterion is the most simple of the three refinement criteria. It is an empirical criterion that is not directly motivated by the underlying numerics. A cell with coordinates \f$(r,z)\f$ qualifies for refinement if: +\f[ +|\mathbf{E}(r,z)| > E_c +\f] +where \f$E_c\f$ is the threshold electric field strength for refinement. \f$E_c\f$ is a user-determined parameter that is provided in the input file for a run. Since this criterion is independent of the grid level or the cell size, once a cell meets the criterion at the coarsest level, it will also do so at every refined level. Because of this property, the user can limit the refinement depth that is reached through this criterion with the \c ref\_level\_eabs input parameter, see e.g., file default.cfg. Setting \c ref\_level\_eabs to 1, for example, restricts the refinement from the coarsest level to the first refined level due to the \f$|\mathbf{E}|\f$ criterion. + +The \f$|\mathbf{E}|\f$ criterion is inflexible in the sense that it requires the user to have advance knowledge of what the field strengths will be. A possible alternative would be to replace the fixed threshold value \f$E_c\f$ by a dimensionless fraction \f$c\f$ and refine if +\f[ +|\mathbf{E}(r,z)| > c E_{max} +\f] +with \f$E_{max}\f$ the maximum electric field strength in the computational domain. Since the electric field criterion is mostly empirical, picking the right value for the refinement threshold may be a trial-and-error process. + +\subsection sect_curvature The curvature criteria + +There are two criteria that use the curvature of density functions in order to determine which areas to refine. If the curvature is large compared to the cell size, the numerics may become unreliable and it is desirable to work with a finer grid. For a density function \f$u(r,z)\f$ and a cell size \f$\triangle r \times \triangle z\f$ the curvature function \f$C_u(r,z)\f$ is a discretization of the second derivative of \f$u\f$ in cylindrical coordinates \f$(r,z)\f$: +\f[ + \begin{array}{ll} + C_u(r,z) = & \frac{1}{r + \frac{\triangle r}{2}}\Big[(r + \triangle r)\big(u(r + \triangle r, z) - u(r,z)\big) - r\big(u(r,z) - u(r - \triangle r,z)\big)\Big] + \\ + & \big[u(r, z + \triangle z) - 2 u(r,z) + u(r, z - \triangle z)\big]. + \end{array} +\f] +Rather than the absolute value of the curvature, the refinement module looks at the curvature relative to the global maximum, \f$Max(u)\f$. The final criterion then reads:\n +\n +\b Refine \f$(r,z)\f$ \b if \f$\frac{C_u(r,z)}{Max(u)} > C_t\f$\n +\n +with \f$C_t\f$ the threshold curvature. This refinement criterion is checked for two density functions \f$u\f$. The first is the (absolute) charge density function. Here an extra condition applies: the absolute value of the charge needs to exceed a certain threshold value (which is hard-coded) before a cell can qualify for refinement based on this criterion. Secondly, the curvature criterion is applied to the particle density functions. Since only mobile particles require a high spatial resolution, any immobile species are not considered in these criteria (which currently excludes all species other than electrons). The computational grids for these immobile species are simply the same as the grids used to solve the density equations for electrons. + +\subsection sect_fishpack FISHPACK refinement + +The [FISHPACK][9] module, for the Poisson equation and the photoionization equations, uses a different set of grids than the CDR module and with it a different refinement scheme. Initially, two grids are set up, one coarse and one fine grid (with the fine grid having twice the spatial resolution in each dimension, so 4 times the number of cells). The Poisson/Helmholtz equation is then solved on both grids and the solution of the coarse grid is interpolated onto the fine grid. A grid cell then qualifies for refinement if the absolute difference between the interpolated coarse solution and the fine solution (this difference is called the error) is more than some user-defined threshold. When refinement is needed, a new set of grids is determined using the strategy mentioned earlier and the process is repeated until either the desired accuracy is reached or the maximum number of allowed refinement levels is reached. Since the [FISHPACK][9] module was originally only used to solve the Poisson equation for the electrostatic problem and the value of the electric field +is defined on the edge of a cell, a cell that does not meet the error-criterion still qualifies for refinement if its neighbor does meet the error-criterion. + +One limitation to this scheme is the limited number of grid cells that the [FISHPACK][9] routine can handle. Since [FISHPACK][9] applies a cyclic reduction scheme, the round-off error increases with the number of grid cells. This places a limit on the size of grids that [FISHPACK][9] can solve. Once the refinement module wants to create a grid that is larger than the so-called [FISHPACK][9] limit, the refinement attempt is rejected and the code relaxes the error threshold by a factor of 2 and again determines the area to refine, using the new threshold. + +To solve the photoionization problem, two Helmholtz equations need to be solved (For details on the implementation of photoionization, the reader is referred to [PhD Thesis Wormeester(to appear in 2013)][6], Chapter 3, section Photoionization +and references therein). Each of the so-called "photo-terms" has its own characteristic absorption length, which depends on the gas density and oxygen ratio. The term with the short absorption length is often dominated by impact ionization in the head of the streamer, while the term with the long absorption length is the main contributor of electrons in front of the streamer head that are required for a positive streamer to propagate. + +The default behavior of the \c ARCoS code is to treat these two photoionization terms in the same manner as the Poisson problem when it comes to refinement: all user-definable parameters were equal. Since the term with the short absorption length gives rise to a solution that benefits strongly from high spatial resolution (due to the steep gradients) it will easily trigger the refinement criterion. However, it is this term that is dominated by impact ionization, see [Luque et al.][2], +which reduces the relevance of accurate computation of this term. The user can therefore specify the refinement criteria for each of the two photoionization terms separately, providing the user with the means to allow the important, long absorption length term to benefit from high spatial resolution, while reducing the computational cost incurred by the less important term. However, in tests it was found that tuning the refinement criteria for the photoionization terms has very little effect on +computational cost or results. + +\subsection sect_Conclusions Conclusion +The adaptive refinement scheme of \c ARCoS allows for the simulation of large domains while maintaining high spatial resolution in regions that require this. A number of refinement parameters influence both the computational performance and the accuracy of the results, which means that the user has to monitor the results carefully. Since the refinement criteria were setup by +[Montijn et al.][1]. +and +[Luque et al.][2]. +for simulations of air and pure nitrogen, application of the code to other gases may require changes to the values of the various thresholds used in the refinement criteria. An example is high-purity oxygen, with a small nitrogen admixture. In such a gas, ionizing photons will have a very short characteristic absorption length and the calculation of the photoionization terms should be done with high accuracy close to the photon source, primarily the streamer head. However, the limitation of the [FISHPACK][9] refinement method does not permit several smaller, adjacent +refined sub-grids, which makes it difficult to properly focus on the streamer head without including too much of the channel. + +\section sect_software ARCoS software + +\subsection sect_ARCoS_overview Basic overview and functionality + +The \c ARCoS simulation software was originally developed by Alejendro Luque as a more flexible version of the adaptive refinement code developed by Carolynne Montijn as described in [PhD Thesis Montijn][7]. +The original code by Montijn has been written in Fortran90, while \c ARCoS has been written in C. +The original [FISHPACK][9] package used for solving the Poisson and Helmholtz equations is written +in Fortran77 and was developed by Adams, Swarztrauber and Sweet. The \c ARCoS code is now compiled +with [FISH90][10], a modernization of the original [FISHPACK][9], employing Fortran90 to slightly +simplify and standardize the interface to some of the routines. + +\c ARCoS solves the fluid equations for streamers, described in section \ref sect_fluid_eq, +on nested Cartesian grids using an adaptive mesh refinement technique. +\c ARCoS allows for the simulation of both positive and negative streamers in the +electrode configurations plate-plate and needle-plate. +The needle-plate electrode geometry is included using a charge simulation method +[Luque et al.][2]. +This method replaces the electrode needle by a single point charge, with the +location and the size of the charge being updated at every time step to ensure the +potential at needle tip remains fixed at the predetermined value. +The limitation of this method is that the potential on the rest of the surface +of the simulated needle will not be accurate. +Consequently, the [continuity](#continuity) equation is only solved on +a smaller grid, not containing the simulated needle. + +The effect of this is that \c ARCoS is not well suited for the study of the +inception of streamers, as the area around the tip of the needle is not +accurately modelled. +However, since inception is often affected by the behavior +of individual particles, the use of a particle code such as described in +[Teunissen et al.][5] and [Li et al.][4]. +is recommended for studying streamer inception. +The purpose of the \c ARCoS code is to study streamer propagation in the phase +after the streamer has formed. +Studies performed by [Luque et al.][2] show that the dynamics of +streamers in later stages hardly depends on initial conditions. + +\c ARCoS allows the user full control over the numerical parameters of the +simulation: grid size, refinement criteria and CFL numbers can be set by the user. +The kinetic model, i.e., the list of particle species, their reactions and +initial densities as well as the diffusion and mobility coefficients can be +specified via a series of input files, allowing the user to fine-tune the properties +of the gas in which the streamer is simulated, see configuration file input/kinetic_example.cfg. + +The \c ARCoS code can be downloaded from the website +\c http://md-wiki.project.cwi.nl/ + +\subsection sect_IO Handling the software, input and output + +\subsubsection sect_sim Starting a simulation + +Two input parameter files governs all details of the simulation: + +\li \b Physical \b parameters such as voltage, electrode configuration, size of the gap, etc. +\li \b Numerical \b parameters such as grid size, refinement criteria, etc. +\li \b Practical \b details like the directory name, where the output files should be stored and the interval at which output should be generated. + +[libconfig](http://www.hyperrealm.com/libconfig/), a free library for processing +structured configuration files, is used for reading, manipulating and writing these files. +The first file, stored as input/default.cfg, must contain the default values for the global variables. +This file is a part of the streamer package distribution. +The second file, say input/user_init.cfg, an example is given by input/example_user_init.cfg, +has a structure analogously to input/default.cfg, and should contain the parameters which differ +from the default values. +The program delivers a configuration file, say input/example_user_continue.cfg with the updated parameters +from input/user_init.cfg completed with the default values of input/default.cfg. + +Since the execution time of a single run will take on the order of several days, it is recommended to +split the time period into smaller pieces, and restart the execution several times from the point +where the previous run stopped. +The easiest way to restart the simulation is + \li to copy the file input/user_continue.cfg into input/default.cfg, to be sure that equal values for the parameters are used, + \li to edit the file input/user_init.cfg, and change the \b \c t_end value, the \b \c restart value and the name of the \b \c load_file. See the end of of this section. + +The use of the configuration files construction has the following advantages: + \li recompilation of the code is not necessary in case of a restart + \li the user always has a clear overview of the parameter values used + \li results of different or continuing runs can be stored in different output directories, + as listed in the configuration file. + \li besides the parameter value also comment coupled to a parameter can be changed in the configuration files written by the user. The length of the comment must be restricted by 100 characters + \li the order of the parameters in the configuration file is free + \li the user has the possibility to control the simulation, many parameter values can be changed. + +It is easy to resume a simulation by using a set of output data as initial conditions. +One has to adapt the parameter file with modified start and end times for the simulation. +To start a \c ARCoS simulation use the following command from +the directory containing the executables: +\n +\code + ./arcos > out.example 2> err.example +\endcode +\n + +The \c ARCoS program starts and it will print out the parameter values used: + \li in \c out.example + \li in input/user_continue.cfg. + +The program will print some extra information to file \c out.example, e.g., the step size and +when a new set of output data has been written, and to which set of file names. +Warnings and errors will be printed in file \c err.example. The program can terminate in three different ways: + + \li The preset end-time is reached. + \li The program is terminated by the user. + \li The time-step (as determined by the Courant criterion for stability, more details to come) has dropped below a preset threshold. This usually points to some form of instability. + +In case the simulation runs on a PC or desktop machine, a convenient approach is to set a very +large value for the end time and, rather than having the program determine when to terminate, +keeping track of the progress of the streamer by checking the output files and manually terminating +the program when the desired output is reached, e.g., the streamer has reached the electrode, or, + it has started to branch. +In other cases, it may be necessary for the program to be able to run for a fixed amount of time. +For example when it needs to exit gracefully, which is required for profiling software to work. +Also in case of batch jobbing with a limited CPU wall clock time, like on most supercomputers, +the end time must be chosen corresponding to the wall clock time. + +Data files with periodical data controlled by \c $output_dt, stored in directory \c $output\_dir, +have names using the format \c variable.C123abc.tsv: + \tparam is a particle species or electric field, e.g. \c charge, \c d_dummyminus, \c d_electrons \n + \tparam <123> is the sequence number of that particular output dataset and \n + \tparam specified the subgrid the output belongs to. + +These files can be used to plot the solution or to restart the simulation. More details on this in the section on output files. To resume the example simulation from output set \c 123, call: +\n +\code +./arcos example C123 +\endcode +\n + +\subsubsection sect_input The input files + + +File and directory handling: + \li \b \c kin\_input - The filename of the [libconfig](http://www.hyperrealm.com/libconfig/) + input file containing the species, seeds and reactions. + By convention, these files have the extension \b .cfg. + \li \b \c output\_dir - The directory where the output files will be stored. + This can be a relative path to the directory with the executable or an absolute + path. When the execution starts, the directory $output_dir must be present and writable. + \li \b \c output\_dt - The interval (in dimensionless units) with which an output dataset is to be saved. + Lower values mean more frequent output, which gives finer grained time-dependent + data at the cost of more disk space. + +Physical parameters: + \li \b \c L\_r - Radius of the physical domain in dimensionless units. + \li \b \c L\_z - Length of the physical domain. Does not include the needle. + \li \b \c has\_photoionization - Whether to enable the photoionization module.\n + So, if \b \c has\_photoionization = 1, photoionization is present,\n + if \b \c has\_photoionization = 0, execution without photoionization.\n + \li \b \c photoionization\_file - Filename of the file containing the photoionization parameters.\n These parameters are further explained in appendix~ref{app:photoionization_parameters}. + +\todo: WRITE APPENDIX + + \li \b \c E0\_z, \b \c E0\_y, \b \c E0\_x - Components of the external electric field in dimensionless units. Since the electrodes are located at the top and bottom of the domain \f$(z = L_z\f$ and \f$z = 0)\f$, only \c E0\_z should be nonzero. Positive values of \c E0\_z will generate an electric field in the \f$^z\f$ direction, with the top electrode (at \f$z = L_z\f$) having a negative charge, generating negative streamers and vice verse. + \li \b \c pois\_inhom - Whether to use a needle-plane geometry or not.\n + If \b \c pois\_inhom = 1 then we have \b \c needle-plane case, \n + otherwise if \b \c pois\_inhom = 0 gives the plane-plane case. \n + See below for additional remarks regarding the needle-plane geometry. + \li \b \c needle\_length and \b \c needle\_radius - The length and radius of the needle in dimensionless units. Only applies when \b \c pois\_inhom = 1. + \li \b \c end\_t - Time at which the simulation will stop, in dimensionless units. + \li \b \c max\_ntheta - Number of azimuthal grid cells. Default \b \c max\_ntheta = 1. \n + \b \c max\_ntheta > 1 will activate the full 3D simulation (without cylindrical symmetry) using a pseudo-spectral method described in more detail in [Luque et al.(2011)][3]. + +Numerical parameters: + \li \b \c gridpoints\_r, \b \c gridpoints\_z - Number of gridpoints in \f$r\f$ and \f$z\f$ direction for the density equations at the coarsest level. + \li \b \c cdr\_max\_level - Maximum number of refinement levels of the grid for the fluid equations. \n + \b \c cdr\_max\_level = 0 means no refinement. + \li \b \c cdr\_bnd\_bottom, \b \c cdr\_bnd\_top, \b \c cdr\_bnd\_right - Boundary condition for the density equations at the bottom \f$(z = 0)\f$, top \f$(z = L_z)\f$ and right \f$(r = L_r)\f$ of the domain. \n + \b \c cdr\_bnd\_xxx = 1 gives homogeneous Neumann boundary conditions, \n + \b \c cdr\_bnd\_xxx = -1 gives homogeneous Dirichlet boundary conditions. + \li \b \c pois\_max\_level - Maximum number of refinement levels of the grid for the Poisson equation. +\b \c pois\_max\_level = 0 means no refinement. + \li \b \c pois\_bnd\_bottom, \b \c pois\_bnd\_top, \b \c pois\_bnd\_right - Boundary condition for the Poisson equation at the bottom \f$(z = 0)\f$, top \f$(z = L_z)\f$ and right \f$(r = L_r)\f$ of the domain. \n +\b \c pois\_bnd\_xxx = 1 gives homogeneous Neumann boundary conditions, \n +\b \c pois\_bnd\_xxx = -1 gives homogeneous Dirichlet. + +\subsubsection sect_parameter The parameter file + +In the parameter file input/default.cfg variables and their values are assigned with the following syntax +\verbatim +{ + type = "type"; /* type can be a "string", a "double", an "int" */ + name = "name"; /* variable name as defined in file include/parameters.h */ + comment = "comment"; /* description of the variable, maximum of 100 characters */ + value = "value"; /* value of type string, double or integer, related to "type" */ +}, + + # <-- this starts a comment-line, which is ignored. + + # White lines are also ignored. + # String-values should be between quotes, numeric values should not + pi=3.14 + # (Note: The above is an approximation) + # Scientific notation can be used: + pi_times_thousand=3.14E3 +\endverbatim + +Non-existent or misspelled parameters are ignored. +Parameters are not required, every parameter has a default value, which can be found +in function \b \c init_parameters of src/cstream.c. + +The following overview lists the parameters generally meant for testing purposes and changing them is not required for streamer simulations. Therefore they are best left at their default value. + +File and directory handling: + \li \b \c cdr\_output\_margin - Number of margin-cells to be added to the output of the density grids. 2 layers of ghost cells are added on the edge of the computational domain for the purpose of enforcing boundary conditions. With this parameter, these can be included in the output. Value must be smaller than or equal to 2. Default \b \c cdr\_output\_margin = 0. + \li \b \c pois\_output - Output the grids used in solving the Poisson equation? The grids used for the Poisson equation are different than those used for the density equations as detailed in section \ref sect_refinement. \b \c pois\_output = 0. Note that the absolute electric field is already saved as a density grid, so it is not required to set this parameter to 1 to obtain this data. + \li \b \c pois\_output\_margin - Number of margin-cells to be added to the output of the Poisson grids. Default \b \c pois\_output\_margin = 0. Note : \b \c pois\_output\_margin <= 2. + +Physical parameters: + \li \b \c start\_t - Initial time. This parameter is used when resuming simulations and is automatically updated in that case. + +Numerical parameters: \n + +The adaptive mesh refinement criteria and the parameters related to them are discussed in more detail in section \ref sect_refinement. + + \li \b \c ref\_threshold\_eabs - Refine grid if \f$|\mathbf{E}|\f$ exceeds this value. + \li \b \c ref\_level\_eabs - Maximum number of refinement levels of the grid for the fluid equation due to the \f$|\mathbf{E}|\f$ criterion. + \li \b \c ref\_threshold\_charge - Refinement threshold for the curvature of the charge density. + \li \b \c ref\_threshold\_dens - Refinement threshold for the curvature of the particle densities. + \li \b \c cdr\_brick\_r, \b \c cdr\_brick\_z - Size \f$(r\f$ and \f$z)\f$ of the minimal refinement area. See Section \ref sect_size_refinement. + \li \b \c pois\_max\_error - An area of the Poisson grid is further refined if the relative error between two consecutive refined levels exceeds this value. + \li \b \c nu\_a - Courant number based on advection to determine the time step. Note, that \b \c nu\_a < 1 to satisfy CFL stability. In streamer simulations, this time step restriction will dominate over other parameters (\b \c nu\_d (diffusion) and \b \c nu\_rt (reaction)). More details on the time stepping can be found in \ref sect_timestepping. + +\subsubsection sect_needle Implementation of the needle-plane configuration + +As mentioned in section \ref sect_overview , the needle-plane electrode geometry is +implemented using a charge simulation technique, which means that the entire needle is +represented by a single point charge located on the axis. +The position and strength of this charge is updated each time step to ensure that the +potential at the point that would be the tip of the needle remains fixed. +A schematic depiction of this setup can be seen in [Figure 1.](#setup). +This provides a reasonable approximation of the potential in the area below +the needle (the needle is always located at the top of the domain), but the potential +will be wrong in the areas to the sides of the needle. +Consequently, the density equations are only solved from the tip of the needle and downwards. +This means that the computational domain for the density equations is smaller than +that for the Poisson equation. + +In the specification of the external electric field, \c E0\_z is interpreted as the electric field between the two planar electrodes, far away from the needle. The applied potential is computed as follows: +\f[ + V = E_{0,z} * (L_z + L_{needle}) +\f] + +\subsubsection sect_output Output + +The code generates a large amount of output files at every \c \b output\_dt units +of simulated time. +These output files combined are sufficient to resume the simulation +from that time step and can also be used for data analysis. +Output files are named \c variable.C123abc.tsv, where 'tsv' stands for 'Tab-Separated Values'. +\c variable is a particle species or electric field. +Examples include \c electrons, \c n2plus and \c eabs +(the latter being \f$|\mathbf{E}|\f$). \c 123 is the sequence number or +output time step (which is unrelated to the time step of the numerical scheme) of that +output set, it starts at \c 000 for the first set. +This is the initial condition of the system before the simulation starts at \f$t = 0\f$. +The alphabetic part of the filename after the output time step, \c abc denotes the +subgrid contained in that file and this extension is defined recursively. +The coarsest grid covering the entire domain has no such alphabetical extension +(example: \c electrons.C123.tsv). +At every next level, the subgrids at that level are named \c a, \c b, \c c, ... +and this letter is appended to the alphabetical extension. +The file \c electrons.C123ba.tsv contains electron densities at the +123-th time step (so at \f$t = 123 * output\_dt\f$ ) for the first +subgrid of the second subgrid of the main grid. +Beware that since the grid refinement is adaptive, each time step has different subgrids. + + +\par Figure 4. Schematic depiction of the naming convention for output files. Each next letter corresponds to a new refined level. + +Data, as shown in Figure 4., is stored as plain text, +with each line containing a single number. +Data is ordered in columns (with fixed \f$r\f$ coordinate). +So to read the data, use the following pseudo-code: +\verbatim +for (i = 0, i < rmax*zmax; i++) +{ + r = floor(i / zmax); + z = i % zmax; + data[r,z] = read_line_from_file(); +} +\endverbatim + +The dimensions of the grid are not contained in the data files. +Instead, for each subgrid and output-step, two additional files are created: + +1. _r.C123abc.tsv_\n +2. _z.C123abc.tsv_\n +\n + +corresponding to subgrid _abc_ of output step _123_. The structure of these files is identical to that of the regular data files, but instead of particle densities or electric field strengths, these files contain the \f$r\f$ and \f$z\f$ coordinates of the center of the cell corresponding to that line-number. So to determine the coordinates of the \f$n^{th}\f$ line in a regular data file, simply read the \f$n^{th}\f$ line of the corresponding \b r and \b z files. + +\subsubsection sect_structure File structure + + +\par Figure 5. File structure of of ARCoS package. + +The distribution of the ARCoS package contains several directories: + +\li \b \c FISH90 - the directory where FISH90 or FISHPACK should be downloaded + +\li \b \c output - this directory may be empty. Its name must correspond to the value of \b \c output_dir in file input/default.cfg. Or, the value in input/user_init.cfg if present. +\li \b \c python - contains plot files. By means of \b \c plotvar pictures can be made of the output files. Not yet implemented. +\li \b \c doc - directory with files for [Doxygen][12] to generate documentation from source code and this \b \c MANUAL. The source of this manual (in MANUAL.md) can be found in its directory \b \c markdown. See also the \b \c doxygen_config_file. +\li \b \c arcos_f90 - a part of the \b \c functions in file cdr.c have been replaced by a piece of \b \c FORTRAN90 code in order to accelerate the simulation. +\li \b \c src - this directory contains the source files written in \b \c c. +\li \b \c include - this directory contains the include files +\li \b \c input - this directory contains all input files. Most of them are libconfig configuration files. + + +\subsubsection sect_source Source files + +The \c ARCoS simulation software was mostly written in \c C and its source code is split up in several files, each dealing with a separate part of the program. Most source files have an associated header file (the source file \b \c example.c has header file \b \c example.h ) containing the type-definitions and preprocessor macros. The function prototypes are aggregated in the header file \c proto.h. Below is a short summary of the important source files and the functionality that is contained within them. + + \li cdr.c - Functions for solving the convection-diffusion-reaction (CDR) equations, creation, manipulation and refinement of CDR grids and time stepping. + \li configuration.c - Module for input/output of parameters. The code uses the library +[libconfig](http://www.hyperrealm.com/libconfig/) + \li cstream.c - Contains some general initialization and termination functions. + \li dft.c - Functions related with discrete fourier transformations. + \li grid.c - Low-level functions for handling of grids, both CDR and Poisson grids. + \li interpol2.c - Interpolation functions for the mapping of one grid to another (for example during refinement). + \li main.c - Functions for reading input parameters, starting of the code and the main loop. + \li mapper.c - Mapping of one grid tree onto another. + \li misc.c - Miscellaneous utilities for allocating memory. + \li photo.c - Photoionization functions. + \li poisson.c - Functions for solving the Poisson equation, including manipulation of Poisson grids and calling the external [FISPACK][9] solver. + \li reaction.c - Functions for computation of reactions between species as part of the density equations. + \li react_table.c - Performs initialization of reaction coefficient tables as well as table lookups. + \li rt.c - Functions for handling the loading of the input file containing the kinetic model (species, reactions, seeds). + \li rz_array.c - Low-level functions for handling Fortran-compatible arrays. + \li sprites.c - Routines for the sprites module. diff --git a/fish90/README b/fish90/README new file mode 100644 index 0000000000000000000000000000000000000000..b8240054f60c5825623b333505a5343de070129b --- /dev/null +++ b/fish90/README @@ -0,0 +1,24 @@ + +SCD released version 1.1 of FISHPACK90 on December 19, 2005. It is an +improvement over Version 1.0 in that it uses Fortran90 intrinsic function +ASSOCIATED to check on pointer association. Also, version 1.1 offers +an integated Makefile for use with gmake. + +Here is some history for version 1.0: + +SCD released FISHPACK90 1.0 in September 30 2004. It is an improvement +of the original Fortran77 FISHPACK insofar as it has removed workspace +arguments in the solvers, replacing them with FORTRAN90 derived data +types that are pointers to real and complex allocatable arrays and are +opaque to user level interface. And also this version replaced many +internal interfaces in conformance with strict prototype +matching of Fortran90. + +Neither version FISHPACK90 1.0 nor 1.1 are full-blown Fortran90 +implementation of FISHPACK. User calls to the old FISHPACK solvers are +not compatible with calls to FISHPACK90 solvers. + +IMPORTANT NOTE: FISHPACK90 has dependencies in the FFTPACK library; the +present version of FFTPACK has not been updated in the same manner as +FISHPACK90. That is, FFTPACK may not strictly conform to the Fortran90 +interface specification. diff --git a/fish90/include/fishpack.h b/fish90/include/fishpack.h new file mode 100644 index 0000000000000000000000000000000000000000..18513055b11fa3e6a5b9ce39fa39a550ba1fccb9 --- /dev/null +++ b/fish90/include/fishpack.h @@ -0,0 +1,50 @@ +#ifndef _FISPHACK_H_ + +/* Arguments for the boundary conditions in fishpack: + The first name is the b.c. at the lowest value of the variable, + the second one is the b.c. at the highest value. + DIR = Dirichlet, + NEU = Neumann, + UNS = Unspecified (when r = 0 for cylindrical calculations). +*/ +#define FISH_PERIODIC 0 +#define FISH_DIR_DIR 1 +#define FISH_DIR_NEU 2 +#define FISH_NEU_NEU 3 +#define FISH_NEU_DIR 4 + +#define FISH_UNS_DIR 5 +#define FISH_UNS_NEU 6 + + +/* This is the maximum number of grid cells that fishpack can handle + without accumulating larger and larger roundoff errors + (it's only an approximation: not checked throughly so if you notice + that you are getting strange things such as artificial lines in + the electric field, this is the first thing you should check). */ +#define FISH_MAX_GRIDPOINTS 1700 + +#define LOG2 0.69314718055994530941723212145818 + +#define FISH_WORK(M_, N_) (13 * (M_) + 4 * (N_) \ + + (M_) * (int) (log(N_) / LOG2)) + +#define FISH_ERROR_MAX 13 +const char *hstcyl_error_str[FISH_ERROR_MAX]; + +void +fish_hstcyl (double r0, double r1, int nr, + int rbndcnd, double *bcr0, double *bcr1, + double z0, double z1, int nz, + int zbndcnd, double *bcz0, double *bcz1, + double lambda, double s, double *f, int idimf); +void +fish_hstcrt (double r0, double r1, int nr, + int rbndcnd, double *bcr0, double *bcr1, + double z0, double z1, int nz, + int zbndcnd, double *bcz0, double *bcz1, + double lambda, double *f, int idimf); + +#define _FISHPACK_H_ +#endif /* _FISHPACK_H_ */ + diff --git a/fish90/src/Makefile b/fish90/src/Makefile new file mode 100644 index 0000000000000000000000000000000000000000..8b56cb940710d031bf8038a5b1f0223c18546fc1 --- /dev/null +++ b/fish90/src/Makefile @@ -0,0 +1,39 @@ +# This Makefile builds the FISH90 library. +# FISH90 is a modified F90 version of FISHPACK + +TOPDIR := ../.. + +include $(TOPDIR)/Makefile.config +include $(TOPDIR)/Makefile.inc + +LIBFISH = ../lib/libfish90.a + +.PHONY: all + +all: + @echo + @echo "###############################" + @echo "### BUILDING FISH90 library ###" + @echo "###############################" + @echo + make lib + +SRCF = genbunal.f90 gnbnaux.f90 hst_procs.f90 poisson.f90 +SRCC = hstcrt_wrap.c hstcyl_wrap.c + +OBJF = $(subst .f90,.o,$(SRCF)) +OBJC = $(subst .c,.o,$(SRCC)) +OBJ := fish.o $(OBJF) $(OBJC) + +hst_procs.o : fish.o genbunal.o poisson.o +genbunal.o : gnbnaux.o poisson.o +poisson.o : gnbnaux.o + +lib : $(LIBFISH) + +$(LIBFISH) : $(OBJ) + $(AR) $@ $? + mv fish.mod ../lib + +clean: + rm -f $(LIBFISH) $(OBJ) *~ ../lib/fish.mod ../lib/FISH.mod fish.f diff --git a/fish90/src/fish.F b/fish90/src/fish.F new file mode 100644 index 0000000000000000000000000000000000000000..616b5166bcd7a446db9104debea75b92a06783b4 --- /dev/null +++ b/fish90/src/fish.F @@ -0,0 +1,166 @@ +! +! file fish.f +! +! . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . +! . . +! . copyright (c) 2004 by UCAR . +! . . +! . UNIVERSITY CORPORATION for ATMOSPHERIC RESEARCH . +! . . +! . all rights reserved . +! . . +! . . +! . FISHPACK version 5.0 . +! . . +! . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . +! +! +! * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * +! * * +! * F I S H P A C K * +! * * +! * * +! * A PACKAGE OF FORTRAN SUBPROGRAMS FOR THE SOLUTION OF * +! * * +! * SEPARABLE ELLIPTIC PARTIAL DIFFERENTIAL EQUATIONS * +! * * +! * (Version 5.0 , JUNE 2004) * +! * * +! * BY * +! * * +! * JOHN ADAMS, PAUL SWARZTRAUBER AND ROLAND SWEET * +! * * +! * OF * +! * * +! * THE NATIONAL CENTER FOR ATMOSPHERIC RESEARCH * +! * * +! * BOULDER, COLORADO (80307) U.S.A. * +! * * +! * WHICH IS SPONSORED BY * +! * * +! * THE NATIONAL SCIENCE FOUNDATION * +! * * +! * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * +! +! + +! this module is used by all fishpack solvers to allocate +! real and complex work space + MODULE fish + + TYPE fishworkspace + DOUBLE PRECISION,DIMENSION(:),ALLOCATABLE :: rew + COMPLEX,DIMENSION(:),ALLOCATABLE :: cxw + END TYPE fishworkspace + + CONTAINS + SUBROUTINE allocatfish(irwk,icwk,wsave,ierror) + IMPLICIT NONE + TYPE (fishworkspace) :: wsave +! irwk is the required real work space length +! icwk is the required integer work space length + INTEGER, INTENT(IN) :: irwk,icwk +! ierror is set to 20 if the dynamic allocation is unsuccessful +! (e.g., this would happen if m,n are too large for the computers memory + INTEGER, INTENT(INOUT) :: ierror + INTEGER :: istatus +! first deallocate to avoid memory leakage + write(*,*) 'fish.F: allocatfish' + if(allocated(wsave%rew)) then + write(*,*) 'allocated wsave%rew, size= ',size(wsave%rew) + DEALLOCATE(wsave%rew,STAT=istatus) + write(*,*) 'deallocate wsave%rew, istatus=',istatus + end if +! allocate irwk words of real work space + if (irwk > 0) then + ALLOCATE(wsave%rew(irwk),STAT = istatus) + write(*,*) 'fish.F: allocatfish, irwk:',irwk + end if +! + if(allocated(wsave%cxw)) then + write(*,*) 'allocated wsave%cxw, size=',size(wsave%cxw) + DEALLOCATE(wsave%cxw,STAT=istatus) + write(*,*) 'deallocate wsave%cxw, istatus=',istatus + end if +! allocate icwk words of complex work space + if (icwk > 0) then + ALLOCATE(wsave%cxw(icwk),STAT = istatus) + write(*,*) 'fish.F: allocatfish, icrk:',icwk + end if + ierror = 0 +! flag fatal error if allocation fails + if (istatus .ne. 0 ) then + ierror = 20 + END IF + RETURN + END SUBROUTINE allocatfish + + SUBROUTINE BLK_space(N,M,irwk,icwk) +! this subroutine computes the real and complex work space +! requirements (generous estimate) of blktri for N,M values + IMPLICIT NONE + INTEGER,INTENT(IN) :: N,M + INTEGER,INTENT(OUT) :: irwk,icwk + INTEGER :: L,log2n +! compute nearest integer greater than or equal to +! log base 2 of n+1, i.e., log2n is smallest integer +! such that 2**log2n >= n+1 + log2n = 1 + do + log2n = log2n+1 + if (n+1 <= 2**log2n) EXIT + end do + L = 2**(log2n+1) + irwk = (log2n-2)*L+5+MAX0(2*N,6*M)+log2n+2*n + icwk = ((log2n-2)*L+5+log2n)/2+3*M+N + RETURN + END SUBROUTINE BLK_space + + SUBROUTINE GEN_space(N,M,irwk) +! this subroutine computes the real work space +! requirement (generously) of genbun for the current N,M + IMPLICIT NONE + INTEGER,INTENT(IN) :: N,M + INTEGER,INTENT(OUT) :: irwk + INTEGER :: log2n +! compute nearest integer greater than or equal to +! log base 2 of n+1, i.e., log2n is smallest integer +! such that 2**log2n >= n+1 + log2n = 1 + do + log2n = log2n+1 + if (n+1 <= 2**log2n) EXIT + end do + irwk = 4*N + (10 + log2n)*M + RETURN + END SUBROUTINE GEN_space + + SUBROUTINE fishfin(wsave,ierror) +! this subroutine releases allocated work space +! fishfin should be called after a fishpack solver has finished +! TYPE (fishworkspace) variable wsave. + IMPLICIT NONE + TYPE (fishworkspace) :: wsave + INTEGER,intent(out) :: ierror + INTEGER :: istatus +! + write(*,*) 'fish.F: fishfin' + if(allocated(wsave%rew)) then + write(*,*) 'deallocated wsave%rew, size= ',size(wsave%rew) + DEALLOCATE(wsave%rew,STAT=istatus) + end if + if(allocated(wsave%cxw)) then + write(*,*) 'deallocated wsave%cxw, size=',size(wsave%cxw) + DEALLOCATE(wsave%cxw,STAT=istatus) + end if +! #ifndef G95 + ! if(associated(wsave%rew))DEALLOCATE(wsave%rew) + ! if(associated(wsave%cxw))DEALLOCATE(wsave%cxw) +! #endif + if (istatus .ne. 0 ) then + ierror = 20 + END IF + + END SUBROUTINE fishfin + + END MODULE fish diff --git a/fish90/src/genbunal.f90 b/fish90/src/genbunal.f90 new file mode 100644 index 0000000000000000000000000000000000000000..c4d025d8c880227ef1b1b6bbc5f3c28ac9d6d4ac --- /dev/null +++ b/fish90/src/genbunal.f90 @@ -0,0 +1,1325 @@ +! +! file genbun.f +! +! . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . +! . . +! . copyright (c) 2004 by UCAR . +! . . +! . UNIVERSITY CORPORATION for ATMOSPHERIC RESEARCH . +! . . +! . all rights reserved . +! . . +! . . +! . FISHPACK version 5.0 . +! . . +! . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . +! +! * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * +! * * +! * F I S H P A C K * +! * * +! * * +! * A PACKAGE OF FORTRAN SUBPROGRAMS FOR THE SOLUTION OF * +! * * +! * SEPARABLE ELLIPTIC PARTIAL DIFFERENTIAL EQUATIONS * +! * * +! * (Version 5.0 , JUNE 2004) * +! * * +! * BY * +! * * +! * JOHN ADAMS, PAUL SWARZTRAUBER AND ROLAND SWEET * +! * * +! * OF * +! * * +! * THE NATIONAL CENTER FOR ATMOSPHERIC RESEARCH * +! * * +! * BOULDER, COLORADO (80307) U.S.A. * +! * * +! * WHICH IS SPONSORED BY * +! * * +! * THE NATIONAL SCIENCE FOUNDATION * +! * * +! * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * +! +! SUBROUTINE GENBUN (NPEROD,N,MPEROD,M,A,B,C,IDIMY,Y,IERROR) +! +! +! DIMENSION OF A(M),B(M),C(M),Y(IDIMY,N) +! ARGUMENTS +! +! LATEST REVISION JUNE 2004 +! +! PURPOSE THE NAME OF THIS PACKAGE IS A MNEMONIC FOR THE +! GENERALIZED BUNEMAN ALGORITHM. +! +! IT SOLVES THE REAL LINEAR SYSTEM OF EQUATIONS +! +! A(I)*X(I-1,J) + B(I)*X(I,J) + C(I)*X(I+1,J) +! + X(I,J-1) - 2.*X(I,J) + X(I,J+1) = Y(I,J) +! +! FOR I = 1,2,...,M AND J = 1,2,...,N. +! +! INDICES I+1 AND I-1 ARE EVALUATED MODULO M, +! I.E., X(0,J) = X(M,J) AND X(M+1,J) = X(1,J), +! AND X(I,0) MAY EQUAL 0, X(I,2), OR X(I,N), +! AND X(I,N+1) MAY EQUAL 0, X(I,N-1), OR X(I,1) +! DEPENDING ON AN INPUT PARAMETER. +! +! USAGE CALL GENBUN (NPEROD,N,MPEROD,M,A,B,C,IDIMY,Y, +! IERROR) +! +! ARGUMENTS +! +! ON INPUT NPEROD +! +! INDICATES THE VALUES THAT X(I,0) AND +! X(I,N+1) ARE ASSUMED TO HAVE. +! +! = 0 IF X(I,0) = X(I,N) AND X(I,N+1) = +! X(I,1). +! = 1 IF X(I,0) = X(I,N+1) = 0 . +! = 2 IF X(I,0) = 0 AND X(I,N+1) = X(I,N-1). +! = 3 IF X(I,0) = X(I,2) AND X(I,N+1) = +! X(I,N-1). +! = 4 IF X(I,0) = X(I,2) AND X(I,N+1) = 0. +! +! N +! THE NUMBER OF UNKNOWNS IN THE J-DIRECTION. +! N MUST BE GREATER THAN 2. +! +! MPEROD +! = 0 IF A(1) AND C(M) ARE NOT ZERO +! = 1 IF A(1) = C(M) = 0 +! +! M +! THE NUMBER OF UNKNOWNS IN THE I-DIRECTION. +! N MUST BE GREATER THAN 2. +! +! A,B,C +! ONE-DIMENSIONAL ARRAYS OF LENGTH M THAT +! SPECIFY THE COEFFICIENTS IN THE LINEAR +! EQUATIONS GIVEN ABOVE. IF MPEROD = 0 +! THE ARRAY ELEMENTS MUST NOT DEPEND UPON +! THE INDEX I, BUT MUST BE CONSTANT. +! SPECIFICALLY, THE SUBROUTINE CHECKS THE +! FOLLOWING CONDITION . +! +! A(I) = C(1) +! C(I) = C(1) +! B(I) = B(1) +! +! FOR I=1,2,...,M. +! +! IDIMY +! THE ROW (OR FIRST) DIMENSION OF THE +! TWO-DIMENSIONAL ARRAY Y AS IT APPEARS +! IN THE PROGRAM CALLING GENBUN. +! THIS PARAMETER IS USED TO SPECIFY THE +! VARIABLE DIMENSION OF Y. +! IDIMY MUST BE AT LEAST M. +! +! Y +! A TWO-DIMENSIONAL COMPLEX ARRAY THAT +! SPECIFIES THE VALUES OF THE RIGHT SIDE +! OF THE LINEAR SYSTEM OF EQUATIONS GIVEN +! ABOVE. +! Y MUST BE DIMENSIONED AT LEAST M*N. +! +! +! ON OUTPUT Y +! +! CONTAINS THE SOLUTION X. +! +! IERROR +! AN ERROR FLAG WHICH INDICATES INVALID +! INPUT PARAMETERS EXCEPT FOR NUMBER +! ZERO, A SOLUTION IS NOT ATTEMPTED. +! +! = 0 NO ERROR. +! = 1 M .LE. 2 . +! = 2 N .LE. 2 +! = 3 IDIMY .LT. M +! = 4 NPEROD .LT. 0 OR NPEROD .GT. 4 +! = 5 MPEROD .LT. 0 OR MPEROD .GT. 1 +! = 6 A(I) .NE. C(1) OR C(I) .NE. C(1) OR +! B(I) .NE. B(1) FOR +! SOME I=1,2,...,M. +! = 7 A(1) .NE. 0 OR C(M) .NE. 0 AND +! MPEROD = 1 +! = 20 If the dynamic allocation of real and +! complex work space required for solution +! fails (for example if N,M are too large +! for your computer) +! +! +! SPECIAL CONDITONS NONE +! +! I/O NONE +! +! PRECISION SINGLE +! +! REQUIRED FILES comf.f,gnbnaux.f,fish.f +! FILES +! +! LANGUAGE FORTRAN 90 +! +! HISTORY WRITTEN IN 1979 BY ROLAND SWEET OF NCAR'S +! SCIENTIFIC COMPUTING DIVISION. MADE AVAILABLE +! ON NCAR'S PUBLIC LIBRARIES IN JANUARY, 1980. +! Revised in June 2004 by John Adams using +! Fortran 90 dynamically allocated work space. +! +! ALGORITHM THE LINEAR SYSTEM IS SOLVED BY A CYCLIC +! REDUCTION ALGORITHM DESCRIBED IN THE +! REFERENCE. +! +! PORTABILITY FORTRAN 90 -- +! THE MACHINE DEPENDENT CONSTANT PI IS +! DEFINED IN FUNCTION PIMACH. +! +! REFERENCES SWEET, R., "A CYCLIC REDUCTION ALGORITHM FOR +! SOLVING BLOCK TRIDIAGONAL SYSTEMS OF ARBITRARY +! DIMENSIONS," SIAM J. ON NUMER. ANAL., 14 (1977) +! PP. 706-720. +! +! ACCURACY THIS TEST WAS PERFORMED ON a platform with +! 64 bit floating point arithmetic. +! A UNIFORM RANDOM NUMBER GENERATOR WAS USED +! TO CREATE A SOLUTION ARRAY X FOR THE SYSTEM +! GIVEN IN THE 'PURPOSE' DESCRIPTION ABOVE +! WITH +! A(I) = C(I) = -0.5*B(I) = 1, I=1,2,...,M +! +! AND, WHEN MPEROD = 1 +! +! A(1) = C(M) = 0 +! A(M) = C(1) = 2. +! +! THE SOLUTION X WAS SUBSTITUTED INTO THE +! GIVEN SYSTEM AND, USING DOUBLE PRECISION +! A RIGHT SIDE Y WAS COMPUTED. +! USING THIS ARRAY Y, SUBROUTINE GENBUN +! WAS CALLED TO PRODUCE APPROXIMATE +! SOLUTION Z. THEN RELATIVE ERROR +! E = MAX(ABS(Z(I,J)-X(I,J)))/ +! MAX(ABS(X(I,J))) +! WAS COMPUTED, WHERE THE TWO MAXIMA ARE TAKEN +! OVER I=1,2,...,M AND J=1,...,N. +! +! THE VALUE OF E IS GIVEN IN THE TABLE +! BELOW FOR SOME TYPICAL VALUES OF M AND N. +! +! M (=N) MPEROD NPEROD E +! ------ ------ ------ ------ +! +! 31 0 0 6.E-14 +! 31 1 1 4.E-13 +! 31 1 3 3.E-13 +! 32 0 0 9.E-14 +! 32 1 1 3.E-13 +! 32 1 3 1.E-13 +! 33 0 0 9.E-14 +! 33 1 1 4.E-13 +! 33 1 3 1.E-13 +! 63 0 0 1.E-13 +! 63 1 1 1.E-12 +! 63 1 3 2.E-13 +! 64 0 0 1.E-13 +! 64 1 1 1.E-12 +! 64 1 3 6.E-13 +! 65 0 0 2.E-13 +! 65 1 1 1.E-12 +! 65 1 3 4.E-13 +! * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * + SUBROUTINE GENBUN(NPEROD, N, MPEROD, M, A, B, C, IDIMY, Y, IERROR) + USE fish + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + + TYPE(fishworkspace) :: w +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: NPEROD, N, MPEROD, M, IDIMY + INTEGER, INTENT(OUT) :: IERROR + DOUBLE PRECISION, DIMENSION(:) :: A, B, C + DOUBLE PRECISION, INTENT(INOUT) :: Y(IDIMY,*) +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: IRWK, ICWK +!----------------------------------------------- + + write(*,*) 'fish90: genbun' + IERROR = 0 +! check input arguments + IF (M <= 2) then + ierror = 1 + return + end if + IF (N <= 2) then + ierror = 2 + return + end if + IF (IDIMY < M) then + ierror = 3 + return + end if + IF (NPEROD<0 .OR. NPEROD>4) then + ierror = 4 + return + end if + IF (MPEROD<0 .OR. MPEROD>1) then + ierror = 5 + return + end if +! compute and allocate real work space for genbun + CALL GEN_SPACE (N, M, IRWK) + ICWK = 0 + CALL ALLOCATFISH (IRWK, ICWK, W, IERROR) +! return if allocation failed (e.g., if n,m are too large) + IF (IERROR == 20) THEN + write(*,*) 'error call ALLOCATFISH' + RETURN + END IF + call genbunn(NPEROD,N,MPEROD,M,A,B,C,IDIMY,Y,IERROR,w%rew,IRWK) +! release allocated work space + CALL FISHFIN (W,IERROR) + IF (IERROR == 20) THEN + write(*,*) 'error call FISHFIN' + RETURN + END IF +! + END SUBROUTINE GENBUN + + + SUBROUTINE GENBUNN(NPEROD,N,MPEROD,M,vecA,vecB,vecC,IDIMY,matY, & + IERROR,vecW,IW) + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: NPEROD, N, MPEROD, M, IDIMY,IW + INTEGER, INTENT(INOUT) :: IERROR + DOUBLE PRECISION, DIMENSION(M), INTENT(IN) :: vecA, vecB, vecC + DOUBLE PRECISION, DIMENSION(IW), INTENT(OUT) :: vecW + DOUBLE PRECISION, DIMENSION(IDIMY,N),INTENT(INOUT) :: matY +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: I, MP1, IWBA, IWBB, IWBC, IWB2, IWB3, IWW1, IWW2, IWW3, & + IWD, IWTCOS, IWP, IW2, K, J, MP, NP, & + IPSTOR, IREV, MH, MHM1, MODD, NBY2, MSKIP + DOUBLE PRECISION :: A1 +!----------------------------------------------- + IF (MPEROD /= 1) THEN + DO I = 2, M + IF (vecA(I) /= vecC(1)) GO TO 103 + IF (vecC(I) /= vecC(1)) GO TO 103 + IF (vecB(I) /= vecB(1)) GO TO 103 + END DO + GO TO 104 + ENDIF + IF (vecA(1)/=ZERO .OR. vecC(M)/=ZERO) IERROR = 7 + GO TO 104 + 103 CONTINUE + IERROR = 6 + 104 CONTINUE + IF (IERROR /= 0) RETURN + MP1 = M + 1 + IWBA = MP1 + IWBB = IWBA + M + IWBC = IWBB + M + IWB2 = IWBC + M + IWB3 = IWB2 + M + IWW1 = IWB3 + M + IWW2 = IWW1 + M + IWW3 = IWW2 + M + IWD = IWW3 + M + IWTCOS = IWD + M + IWP = IWTCOS + 4*N + vecW(IWBA:M-1+IWBA) = -vecA(:M) + vecW(IWBC:M-1+IWBC) = -vecC(:M) + vecW(IWBB:M-1+IWBB) = TWO - vecB(:M) + matY(:M,:N) = -matY(:M,:N) + MP = MPEROD + 1 + NP = NPEROD + 1 + GO TO (114,107) MP + 107 CONTINUE + GO TO (108,109,110,111,123) NP + 108 CONTINUE + IW2 = IW - IWP + 1 + CALL POISP2 (M, N, vecW(IWBA:IWBA+M-1), vecW(IWBB:IWBB+M-1), & + vecW(IWBC:IWBC+M-1), matY, IDIMY, & + vecW(1:M), vecW(IWB2:IWB2+M-1), vecW(IWB3:IWB3+M-1), & + vecW(IWW1:IWW1+M-1), vecW(IWW2:IWW2+M-1), & + vecW(IWW3:IWW3+M-1), vecW(IWD:IWD+M-1), & + vecW(IWTCOS:IWTCOS+4*N-1), vecW(IWP:),IW2) + GO TO 112 + 109 CONTINUE + IW2 = IW - IWP + 1 + CALL POISD2 (M, N, 1, vecW(IWBA:IWBA+M-1), vecW(IWBB:IWBB+M-1), & + vecW(IWBC::IWBC+M-1), matY, IDIMY, & + vecW(1:M), vecW(IWW1:IWW1+M-1), vecW(IWD:IWD+M-1), & + vecW(IWTCOS:IWTCOS+4*N-1), vecW(IWP:), IW2) + GO TO 112 + 110 CONTINUE + IW2 = IW - IWP + 1 + CALL POISN2 (M, N, 1, 2, vecW(IWBA:IWBA+M-1), vecW(IWBB:IWBB+M-1), & + vecW(IWBC:IWBC+M-1), matY, IDIMY, vecW(1:M), & + vecW(IWB2:IWB2+M-1), vecW(IWB3:IWB3+M-1), & + vecW(IWW1:IWW1+M-1), vecW(IWW2:IWW2+M-1), & + vecW(IWW3::IWW3+M-1), vecW(IWD:IWD+M-1), & + vecW(IWTCOS:IWTCOS+4*N-1),vecW(IWP:),IW2) + GO TO 112 + 111 CONTINUE + IW2 = IW - IWP + 1 + CALL POISN2 (M, N, 1, 1, vecW(IWBA:IWBA+M-1), vecW(IWBB:IWBB+M-1), & + vecW(IWBC::IWBC+M-1), matY, IDIMY, vecW(1:M), & + vecW(IWB2:IWW1+M-1), vecW(IWB3:IWB3+M-1), & + vecW(IWW1:IWW1+M-1), vecW(IWW2:IWW2+M-1), & + vecW(IWW3::IWW3+M-1), vecW(IWD:IWD+M-1), & + vecW(IWTCOS:IWTCOS+4*N-1),vecW(IWP:),IW2) + 112 CONTINUE + IPSTOR = vecW(IWW1) + IREV = 2 + IF (NPEROD == 4) GO TO 124 + 113 CONTINUE + GO TO (127,133) MP + 114 CONTINUE + MH = (M + 1)/2 + MHM1 = MH - 1 + MODD = 1 + IF (MH*2 == M) MODD = 2 + DO J = 1, N + vecW(:MHM1) = matY(MH-1:MH-MHM1:(-1),J) - matY(MH+1:MHM1+MH,J) + vecW(MH+1:MHM1+MH) = matY(MH-1:MH-MHM1:(-1),J) + matY(MH+1:MHM1+MH,J) + vecW(MH) = TWO*matY(MH,J) + GO TO (117,116) MODD + 116 CONTINUE + vecW(M) = TWO*matY(M,J) + 117 CONTINUE + matY(:M,J) = vecW(:M) + END DO + K = IWBC + MHM1 - 1 + I = IWBA + MHM1 + vecW(K) = ZERO + vecW(I) = ZERO + vecW(K+1) = TWO*vecW(K+1) + SELECT CASE (MODD) + CASE DEFAULT + K = IWBB + MHM1 - 1 + vecW(K) = vecW(K) - vecW(I-1) + vecW(IWBC-1) = vecW(IWBC-1) + vecW(IWBB-1) + CASE (2) + vecW(IWBB-1) = vecW(K+1) + END SELECT + GO TO 107 +! +! REVERSE COLUMNS WHEN NPEROD = 4. +! + 123 CONTINUE + IREV = 1 + NBY2 = N/2 + 124 CONTINUE + DO J = 1, NBY2 + MSKIP = N + 1 - J + DO I = 1, M + A1 = matY(I,J) + matY(I,J) = matY(I,MSKIP) + matY(I,MSKIP) = A1 + END DO + END DO + GO TO (110,113) IREV + 127 CONTINUE + DO J = 1, N + vecW(MH-1:MH-MHM1:(-1)) = HALF*(matY(MH+1:MHM1+MH,J)+matY(:MHM1,J)) + vecW(MH+1:MHM1+MH) = HALF*(matY(MH+1:MHM1+MH,J)-matY(:MHM1,J)) + vecW(MH) = HALF*matY(MH,J) + GO TO (130,129) MODD + 129 CONTINUE + vecW(M) = HALF*matY(M,J) + 130 CONTINUE + matY(:M,J) = vecW(:M) + END DO + 133 CONTINUE + vecW(1) = IPSTOR + IWP - 1 + RETURN + END SUBROUTINE GENBUNN + + + SUBROUTINE POISD2(MR,NR,ISTAG,vecBA,vecBB,vecBC,matY,IDIMY, & + vecB,vecW,vecD,TCOS,vecP,IDIMP) + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: MR, NR, ISTAG, IDIMY,IDIMP + DOUBLE PRECISION, DIMENSION(MR), INTENT(IN) :: vecBA, vecBB, & + vecBC + DOUBLE PRECISION, DIMENSION(IDIMY,NR),INTENT(INOUT) :: matY + DOUBLE PRECISION, DIMENSION(MR), INTENT(INOUT) :: vecB, vecD, vecW + DOUBLE PRECISION, DIMENSION(4*NR), INTENT(INOUT) :: TCOS + DOUBLE PRECISION, DIMENSION(IDIMP), INTENT(INOUT) :: vecP +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: M, N, JSH, IP, IPSTOR, KR, IRREG, JSTSAV, I, LR, NUN, & + JST, JSP, L, NODD, J, JM1, JP1, JM2, JP2, JM3, JP3, & + NODDPR, KRPI, IDEG, JDEG + DOUBLE PRECISION :: FI, T +!----------------------------------------------- +! +! SUBROUTINE TO SOLVE POISSON'S EQUATION FOR DIRICHLET BOUNDARY +! CONDITIONS. +! +! ISTAG = 1 IF THE LAST DIAGONAL BLOCK IS THE MATRIX A. +! ISTAG = 2 IF THE LAST DIAGONAL BLOCK IS THE MATRIX A+I. +! + M = MR + N = NR + JSH = 0 + FI = ONE/FLOAT(ISTAG) + IP = -M + IPSTOR = 0 + SELECT CASE (ISTAG) + CASE DEFAULT + KR = 0 + IRREG = 1 + IF (N > 1) GO TO 106 + TCOS(1) = ZERO + CASE (2) + KR = 1 + JSTSAV = 1 + IRREG = 2 + IF (N > 1) GO TO 106 + TCOS(1) = -ONE + END SELECT + vecB(:M) = matY(:M,1) + CALL TRIX (1, 0, M, vecBA, vecBB, vecBC, vecB, TCOS, 4*NR, vecD, vecW) + matY(:M,1) = vecB(:M) + GO TO 183 + 106 CONTINUE + LR = 0 + vecP(:M) = ZERO + NUN = N + JST = 1 + JSP = N +! +! IRREG = 1 WHEN NO IRREGULARITIES HAVE OCCURRED, OTHERWISE IT IS 2. +! + 108 CONTINUE + L = 2*JST + NODD = 2 - 2*((NUN + 1)/2) + NUN +! +! NODD = 1 WHEN NUN IS ODD, OTHERWISE IT IS 2. +! + SELECT CASE (NODD) + CASE DEFAULT + JSP = JSP - L + CASE (1) + JSP = JSP - JST + IF (IRREG /= 1) JSP = JSP - L + END SELECT + CALL COSGEN (JST, 1, HALF, ZERO, TCOS, 4*NR) + IF (L <= JSP) THEN + DO J = L, JSP, L + JM1 = J - JSH + JP1 = J + JSH + JM2 = J - JST + JP2 = J + JST + JM3 = JM2 - JSH + JP3 = JP2 + JSH + IF (JST == 1) THEN + vecB(:M) = TWO*matY(:M,J) + matY(:M,J) = matY(:M,JM2) + matY(:M,JP2) + ELSE + DO I = 1, M + T = matY(I,J) - matY(I,JM1) - matY(I,JP1) + matY(I,JM2) + & + matY(I,JP2) + vecB(I) = T + matY(I,J) - matY(I,JM3) - matY(I,JP3) + matY(I,J) = T + END DO + ENDIF + CALL TRIX (JST, 0, M, vecBA, vecBB, vecBC, vecB, TCOS, 4*NR, vecD, vecW) + matY(:M,J) = matY(:M,J) + vecB(:M) + END DO + ENDIF +! +! REDUCTION FOR LAST UNKNOWN +! + SELECT CASE (NODD) + CASE DEFAULT + GO TO (152,120) IRREG +! +! ODD NUMBER OF UNKNOWNS +! + 120 CONTINUE + JSP = JSP + L + J = JSP + JM1 = J - JSH + JP1 = J + JSH + JM2 = J - JST + JP2 = J + JST + JM3 = JM2 - JSH + GO TO (123,121) ISTAG + 121 CONTINUE + IF (JST /= 1) GO TO 123 + vecB(:M) = matY(:M,J) + matY(:M,J) = ZERO + GO TO 130 + 123 CONTINUE + SELECT CASE (NODDPR) + CASE DEFAULT + vecB(:M) = HALF*(matY(:M,JM2)-matY(:M,JM1)-matY(:M,JM3)) + & + vecP(IP+1:M+IP)+ matY(:M,J) + CASE (2) + vecB(:M) = HALF*(matY(:M,JM2)-matY(:M,JM1)-matY(:M,JM3)) + & + matY(:M,JP2) - matY(:M,JP1) + matY(:M,J) + END SELECT + matY(:M,J) = HALF*(matY(:M,J)-matY(:M,JM1)-matY(:M,JP1)) + 130 CONTINUE + CALL TRIX (JST, 0, M, vecBA, vecBB, vecBC, vecB, TCOS, 4*NR, vecD, vecW) + IP = IP + M + IPSTOR = MAX0(IPSTOR,IP + M) + vecP(IP+1:M+IP) = matY(:M,J) + vecB(:M) + vecB(:M) = matY(:M,JP2) + vecP(IP+1:M+IP) + IF (LR == 0) THEN + DO I = 1, JST + KRPI = KR + I + TCOS(KRPI) = TCOS(I) + END DO + ELSE + CALL COSGEN (LR, JSTSAV, ZERO, FI, TCOS(JST+1), 4*NR-JST) + CALL MERGE (TCOS, 0, JST, JST, LR, KR, 4*NR) + ENDIF + CALL COSGEN (KR, JSTSAV, ZERO, FI, TCOS, 4*NR) + CALL TRIX (KR, KR, M, vecBA, vecBB, vecBC, vecB, TCOS, 4*NR, vecD, vecW) + matY(:M,J) = matY(:M,JM2) + vecB(:M) + vecP(IP+1:M+IP) + LR = KR + KR = KR + L +! +! EVEN NUMBER OF UNKNOWNS +! + CASE (2) + JSP = JSP + L + J = JSP + JM1 = J - JSH + JP1 = J + JSH + JM2 = J - JST + JP2 = J + JST + JM3 = JM2 - JSH + SELECT CASE (IRREG) + CASE DEFAULT + JSTSAV = JST + IDEG = JST + KR = L + CASE (2) + CALL COSGEN (KR, JSTSAV, ZERO, FI, TCOS, 4*NR) + CALL COSGEN (LR, JSTSAV, ZERO, FI, TCOS(KR+1), 4*NR-KR) + IDEG = KR + KR = KR + JST + END SELECT + IF (JST == 1) THEN + IRREG = 2 + vecB(:M) = matY(:M,J) + matY(:M,J) = matY(:M,JM2) + ELSE + vecB(:M) = matY(:M,J) + HALF*(matY(:M,JM2)-matY(:M,JM1)- & + matY(:M,JM3)) + SELECT CASE (IRREG) + CASE DEFAULT + matY(:M,J) = matY(:M,JM2) + HALF*(matY(:M,J)- & + matY(:M,JM1)-matY(:M,JP1)) + IRREG = 2 + CASE (2) + SELECT CASE (NODDPR) + CASE DEFAULT + matY(:M,J) = matY(:M,JM2) + vecP(IP+1:M+IP) + IP = IP - M + CASE (2) + matY(:M,J) = matY(:M,JM2) + matY(:M,J) - matY(:M,JM1) + END SELECT + END SELECT + ENDIF + CALL TRIX (IDEG, LR, M, vecBA, vecBB, vecBC, vecB, TCOS, 4*NR, vecD, vecW) + matY(:M,J) = matY(:M,J) + vecB(:M) + END SELECT + 152 CONTINUE + NUN = NUN/2 + NODDPR = NODD + JSH = JST + JST = 2*JST + IF (NUN >= 2) GO TO 108 +! +! START SOLUTION. +! + J = JSP + vecB(:M) = matY(:M,J) + SELECT CASE (IRREG) + CASE DEFAULT + CALL COSGEN (JST, 1, HALF, ZERO, TCOS, 4*NR) + IDEG = JST + CASE (2) + KR = LR + JST + CALL COSGEN (KR, JSTSAV, ZERO, FI, TCOS, 4*NR) + CALL COSGEN (LR, JSTSAV, ZERO, FI, TCOS(KR+1), 4*NR-KR) + IDEG = KR + END SELECT + CALL TRIX (IDEG, LR, M, vecBA, vecBB, vecBC, vecB, TCOS, 4*NR, vecD, vecW) + JM1 = J - JSH + JP1 = J + JSH + SELECT CASE (IRREG) + CASE DEFAULT + matY(:M,J) = HALF*(matY(:M,J)-matY(:M,JM1)-matY(:M,JP1)) + vecB(:M) + CASE (2) + SELECT CASE (NODDPR) + CASE DEFAULT + matY(:M,J) = vecP(IP+1:M+IP) + vecB(:M) + IP = IP - M + CASE (2) + matY(:M,J) = matY(:M,J) - matY(:M,JM1) + vecB(:M) + END SELECT + END SELECT + 164 CONTINUE + JST = JST/2 + JSH = JST/2 + NUN = 2*NUN + IF (NUN > N) GO TO 183 + DO J = JST, N, L + JM1 = J - JSH + JP1 = J + JSH + JM2 = J - JST + JP2 = J + JST + IF (J <= JST) THEN + vecB(:M) = matY(:M,J) + matY(:M,JP2) + ELSE + IF (JP2 <= N) GO TO 168 + vecB(:M) = matY(:M,J) + matY(:M,JM2) + IF (JST < JSTSAV) IRREG = 1 + GO TO (170,171) IRREG + 168 CONTINUE + vecB(:M) = matY(:M,J) + matY(:M,JM2) + matY(:M,JP2) + ENDIF + 170 CONTINUE + CALL COSGEN (JST, 1, HALF, ZERO, TCOS, 4*NR) + IDEG = JST + JDEG = 0 + GO TO 172 + 171 CONTINUE + IF (J + L > N) LR = LR - JST + KR = JST + LR + CALL COSGEN (KR, JSTSAV, ZERO, FI, TCOS, 4*NR) + CALL COSGEN (LR, JSTSAV, ZERO, FI, TCOS(KR+1), 4*NR-KR) + IDEG = KR + JDEG = LR + 172 CONTINUE + CALL TRIX (IDEG, JDEG, M, vecBA, vecBB, vecBC, vecB, TCOS, 4*NR, vecD, vecW) + IF (JST <= 1) THEN + matY(:M,J) = vecB(:M) + ELSE + IF (JP2 > N) GO TO 177 + 175 CONTINUE + matY(:M,J) = HALF*(matY(:M,J)-matY(:M,JM1)-matY(:M,JP1)) + vecB(:M) + CYCLE + 177 CONTINUE + GO TO (175,178) IRREG + 178 CONTINUE + IF (J + JSH <= N) THEN + matY(:M,J) = vecB(:M) + vecP(IP+1:M+IP) + IP = IP - M + ELSE + matY(:M,J) = vecB(:M) + matY(:M,J) - matY(:M,JM1) + ENDIF + ENDIF + END DO + L = L/2 + GO TO 164 + 183 CONTINUE + vecW(1) = IPSTOR + RETURN + END SUBROUTINE POISD2 + + + SUBROUTINE POISN2(M, N, ISTAG, MIXBND, vecA, vecBB, vecC, & + matQ, IDIMQ, vecB, vecB2,vecB3, & + vecW, vecW2, vecW3, vecD, TCOS, vecP, IDIMP) + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: M, N, ISTAG, MIXBND, IDIMQ,IDIMP + DOUBLE PRECISION, DIMENSION(M), INTENT(IN) :: vecA, vecBB, vecC + DOUBLE PRECISION, DIMENSION(IDIMQ,N), INTENT(INOUT) :: matQ + DOUBLE PRECISION, DIMENSION(M),INTENT(INOUT) :: vecB, vecB2, vecB3, & + vecD, vecW, vecW2, vecW3 + DOUBLE PRECISION, DIMENSION(IDIMP),INTENT(INOUT) :: vecP + DOUBLE PRECISION, DIMENSION(4*N),INTENT(INOUT) :: TCOS +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER, DIMENSION(4) :: K + INTEGER :: K1, K2, K3, K4, MR, IP, IPSTOR, I2R, JR, NR, NLAST, & + KR, LR, I, NROD, JSTART, JSTOP, I2RBY2, & + J, JP1, JP2, JP3, JM1,JM2, JM3, NRODPR, II, I1, I2, & + JR2, NLASTP, JSTEP + DOUBLE PRECISION :: FISTAG, FNUM, FDEN, FI, T +!----------------------------------------------- +! +! SUBROUTINE TO SOLVE POISSON'S EQUATION WITH NEUMANN BOUNDARY +! CONDITIONS. +! +! ISTAG = 1 IF THE LAST DIAGONAL BLOCK IS A. +! ISTAG = 2 IF THE LAST DIAGONAL BLOCK IS A-I. +! MIXBND = 1 IF HAVE NEUMANN BOUNDARY CONDITIONS AT BOTH BOUNDARIES. +! MIXBND = 2 IF HAVE NEUMANN BOUNDARY CONDITIONS AT BOTTOM AND +! DIRICHLET CONDITION AT TOP. (FOR THIS CASE, MUST HAVE ISTAG = 1.) +! + EQUIVALENCE (K(1), K1), (K(2), K2), (K(3), K3), (K(4), K4) + FISTAG = 3 - ISTAG + FNUM = ONE/FLOAT(ISTAG) + FDEN = HALF*FLOAT(ISTAG - 1) + MR = M + IP = -MR + IPSTOR = 0 + I2R = 1 + JR = 2 + NR = N + NLAST = N + KR = 1 + LR = 0 + GO TO (101,103) ISTAG + 101 CONTINUE + matQ(:MR,N) = HALF*matQ(:MR,N) + GO TO (103,104) MIXBND + 103 CONTINUE + IF (N <= 3) GO TO 155 + 104 CONTINUE + JR = 2*I2R + NROD = 1 + IF ((NR/2)*2 == NR) NROD = 0 + SELECT CASE (MIXBND) + CASE DEFAULT + JSTART = 1 + CASE (2) + JSTART = JR + NROD = 1 - NROD + END SELECT + JSTOP = NLAST - JR + IF (NROD == 0) JSTOP = JSTOP - I2R + CALL COSGEN (I2R, 1, HALF, ZERO, TCOS, 4*NR) + I2RBY2 = I2R/2 + IF (JSTOP < JSTART) THEN + J = JR + ELSE + DO J = JSTART, JSTOP, JR + JP1 = J + I2RBY2 + JP2 = J + I2R + JP3 = JP2 + I2RBY2 + JM1 = J - I2RBY2 + JM2 = J - I2R + JM3 = JM2 - I2RBY2 + IF (J == 1) THEN + JM1 = JP1 + JM2 = JP2 + JM3 = JP3 + ENDIF + IF (I2R == 1) THEN + IF (J == 1) JM2 = JP2 + vecB(:MR) = TWO*matQ(:MR,J) + matQ(:MR,J) = matQ(:MR,JM2) + matQ(:MR,JP2) + ELSE + DO I = 1, MR + FI = matQ(I,J) + matQ(I,J)=matQ(I,J)-matQ(I,JM1)-matQ(I,JP1)+ & + matQ(I,JM2)+matQ(I,JP2) + vecB(I) = FI + matQ(I,J) - matQ(I,JM3) - matQ(I,JP3) + END DO + ENDIF + CALL TRIX (I2R, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,J) = matQ(:MR,J) + vecB(:MR) +! +! END OF REDUCTION FOR REGULAR UNKNOWNS. +! + END DO +! +! BEGIN SPECIAL REDUCTION FOR LAST UNKNOWN. +! + J = JSTOP + JR + ENDIF + NLAST = J + JM1 = J - I2RBY2 + JM2 = J - I2R + JM3 = JM2 - I2RBY2 + IF (NROD /= 0) THEN +! +! ODD NUMBER OF UNKNOWNS +! + IF (I2R == 1) THEN + vecB(:MR) = FISTAG*matQ(:MR,J) + matQ(:MR,J) = matQ(:MR,JM2) + ELSE + vecB(:MR) = matQ(:MR,J) + HALF*(matQ(:MR,JM2)- & + matQ(:MR,JM1)-matQ(:MR,JM3)) + IF (NRODPR == 0) THEN + matQ(:MR,J) = matQ(:MR,JM2) + vecP(IP+1:MR+IP) + IP = IP - MR + ELSE + matQ(:MR,J) = matQ(:MR,J) - matQ(:MR,JM1) + matQ(:MR,JM2) + ENDIF + IF (LR /= 0) THEN + CALL COSGEN (LR, 1, HALF, FDEN, TCOS(KR+1), 4*NR-KR) + ELSE + vecB(:MR) = FISTAG*vecB(:MR) + ENDIF + ENDIF + CALL COSGEN (KR, 1, HALF, FDEN, TCOS, 4*NR) + CALL TRIX (KR, LR, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,J) = matQ(:MR,J) + vecB(:MR) + KR = KR + I2R + ELSE + JP1 = J + I2RBY2 + JP2 = J + I2R + IF (I2R == 1) THEN + vecB(:MR) = matQ(:MR,J) + CALL TRIX (1, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + IP = 0 + IPSTOR = MR + SELECT CASE (ISTAG) + CASE DEFAULT + vecP(:MR) = vecB(:MR) + vecB(:MR) = vecB(:MR) + matQ(:MR,N) + TCOS(1) = ONE + TCOS(2) = ZERO + CALL TRIX (1, 1, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,J) = matQ(:MR,JM2) + vecP(:MR) + vecB(:MR) + GO TO 150 + CASE (1) + vecP(:MR) = vecB(:MR) + matQ(:MR,J) = matQ(:MR,JM2) + TWO*matQ(:MR,JP2) + 3.*vecB(:MR) + GO TO 150 + END SELECT + ENDIF + vecB(:MR) = matQ(:MR,J) + HALF*(matQ(:MR,JM2)- & + matQ(:MR,JM1)-matQ(:MR,JM3)) + IF (NRODPR == 0) THEN + vecB(:MR) = vecB(:MR) + vecP(IP+1:MR+IP) + ELSE + vecB(:MR) = vecB(:MR) + matQ(:MR,JP2) - matQ(:MR,JP1) + ENDIF + CALL TRIX (I2R, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + IP = IP + MR + IPSTOR = MAX0(IPSTOR,IP + MR) + vecP(IP+1:MR+IP) = vecB(:MR) + HALF*(matQ(:MR,J)- & + matQ(:MR,JM1)-matQ(:MR,JP1)) + vecB(:MR) = vecP(IP+1:MR+IP) + matQ(:MR,JP2) + IF (LR /= 0) THEN + CALL COSGEN (LR, 1, HALF, FDEN, TCOS(I2R+1), 4*NR-I2R) + CALL MERGE (TCOS, 0, I2R, I2R, LR, KR, 4*NR) + ELSE + DO I = 1, I2R + II = KR + I + TCOS(II) = TCOS(I) + END DO + ENDIF + CALL COSGEN (KR, 1, HALF, FDEN, TCOS, 4*NR) + IF (LR == 0) THEN + GO TO (146,145) ISTAG + ENDIF + 145 CONTINUE + CALL TRIX (KR, KR, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + GO TO 148 + 146 CONTINUE + vecB(:MR) = FISTAG*vecB(:MR) + 148 CONTINUE + matQ(:MR,J) = matQ(:MR,JM2) + vecP(IP+1:MR+IP) + vecB(:MR) + 150 CONTINUE + LR = KR + KR = KR + JR + ENDIF + SELECT CASE (MIXBND) + CASE DEFAULT + NR = (NLAST - 1)/JR + 1 + IF (NR <= 3) GO TO 155 + CASE (2) + NR = NLAST/JR + IF (NR <= 1) GO TO 192 + END SELECT + I2R = JR + NRODPR = NROD + GO TO 104 + 155 CONTINUE + J = 1 + JR + JM1 = J - I2R + JP1 = J + I2R + JM2 = NLAST - I2R + IF (NR /= 2) THEN + IF (LR /= 0) GO TO 170 + IF (N == 3) THEN +! +! CASE N = 3. +! + GO TO (156,168) ISTAG + 156 CONTINUE + vecB(:MR) = matQ(:MR,2) + TCOS(1) = ZERO + CALL TRIX (1, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,2) = vecB(:MR) + vecB(:MR) = 4.*vecB(:MR) + matQ(:MR,1) + TWO*matQ(:MR,3) + TCOS(1) = -TWO + TCOS(2) = TWO + I1 = 2 + I2 = 0 + CALL TRIX (I1, I2, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,2) = matQ(:MR,2) + vecB(:MR) + vecB(:MR) = matQ(:MR,1) + TWO*matQ(:MR,2) + TCOS(1) = ZERO + CALL TRIX (1, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,1) = vecB(:MR) + JR = 1 + I2R = 0 + GO TO 194 + ENDIF +! +! CASE N = 2**P+1 +! + GO TO (162,170) ISTAG + 162 CONTINUE + vecB(:MR) = matQ(:MR,J) + HALF*matQ(:MR,1) - & + matQ(:MR,JM1) + matQ(:MR,NLAST) - matQ(:MR,JM2) + CALL COSGEN (JR, 1, HALF, ZERO, TCOS, 4*NR) + CALL TRIX (JR, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,J) = HALF*(matQ(:MR,J)-matQ(:MR,JM1)-matQ(:MR,JP1)) + vecB(:MR) + vecB(:MR) = matQ(:MR,1) + TWO*matQ(:MR,NLAST) + 4.*matQ(:MR,J) + JR2 = 2*JR + CALL COSGEN (JR, 1, ZERO, ZERO, TCOS, 4*NR) + TCOS(JR+1:JR*2) = -TCOS(JR:1:(-1)) + CALL TRIX (JR2, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,J) = matQ(:MR,J) + vecB(:MR) + vecB(:MR) = matQ(:MR,1) + TWO*matQ(:MR,J) + CALL COSGEN (JR, 1, HALF, ZERO, TCOS, 4*NR) + CALL TRIX (JR, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,1) = HALF*matQ(:MR,1) - matQ(:MR,JM1) + vecB(:MR) + GO TO 194 +! +! CASE OF GENERAL N WITH NR = 3 . +! + 168 CONTINUE + vecB(:MR) = matQ(:MR,2) + matQ(:MR,2) = ZERO + vecB2(:MR) = matQ(:MR,3) + vecB3(:MR) = matQ(:MR,1) + JR = 1 + I2R = 0 + J = 2 + GO TO 177 + 170 CONTINUE + vecB(:MR) = HALF*matQ(:MR,1) - matQ(:MR,JM1) + matQ(:MR,J) + IF (NROD == 0) THEN + vecB(:MR) = vecB(:MR) + vecP(IP+1:MR+IP) + ELSE + vecB(:MR) = vecB(:MR) + matQ(:MR,NLAST) - matQ(:MR,JM2) + ENDIF + DO I = 1, MR + T = HALF*(matQ(I,J)-matQ(I,JM1)-matQ(I,JP1)) + matQ(I,J) = T + vecB2(I) = matQ(I,NLAST) + T + vecB3(I) = matQ(I,1) + TWO*T + END DO + 177 CONTINUE + K1 = KR + 2*JR - 1 + K2 = KR + JR + TCOS(K1+1) = -TWO + K4 = K1 + 3 - ISTAG + CALL COSGEN (K2 + ISTAG - 2, 1, ZERO, FNUM, TCOS(K4), 4*NR-K4+1) + K4 = K1 + K2 + 1 + CALL COSGEN (JR - 1, 1, ZERO, ONE, TCOS(K4), 4*NR-K4+1) + CALL MERGE (TCOS, K1, K2, K1 + K2, JR - 1, 0, 4*NR) + K3 = K1 + K2 + LR + CALL COSGEN (JR, 1, HALF, ZERO, TCOS(K3+1), 4*NR-K3) + K4 = K3 + JR + 1 + CALL COSGEN (KR, 1, HALF, FDEN, TCOS(K4), 4*NR-K4+1) + CALL MERGE (TCOS, K3, JR, K3 + JR, KR, K1, 4*NR) + IF (LR /= 0) THEN + CALL COSGEN (LR, 1, HALF, FDEN, TCOS(K4), 4*NR-K4+1) + CALL MERGE (TCOS, K3, JR, K3 + JR, LR, K3 - LR, 4*NR) + CALL COSGEN (KR, 1, HALF, FDEN, TCOS(K4), 4*NR-K4+1) + ENDIF + K3 = KR + K4 = KR + CALL TRI3 (MR, vecA, vecBB, vecC, K, vecB, vecB2, vecB3, & + TCOS, 4*NR, vecD, vecW, vecW2, vecW3) + vecB(:MR) = vecB(:MR) + vecB2(:MR) + vecB3(:MR) + TCOS(1) = TWO + CALL TRIX (1, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,J) = matQ(:MR,J) + vecB(:MR) + vecB(:MR) = matQ(:MR,1) + TWO*matQ(:MR,J) + CALL COSGEN (JR, 1, HALF, ZERO, TCOS, 4*NR) + CALL TRIX (JR, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + IF (JR == 1) THEN + matQ(:MR,1) = vecB(:MR) + GO TO 194 + ENDIF + matQ(:MR,1) = HALF*matQ(:MR,1) - matQ(:MR,JM1) + vecB(:MR) + GO TO 194 + ENDIF + IF (N == 2) THEN +! +! CASE N = 2 +! + vecB(:MR) = matQ(:MR,1) + TCOS(1) = ZERO + CALL TRIX (1, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,1) = vecB(:MR) + vecB(:MR) = TWO*(matQ(:MR,2)+vecB(:MR))*FISTAG + TCOS(1) = -FISTAG + TCOS(2) = TWO + CALL TRIX (2, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,1) = matQ(:MR,1) + vecB(:MR) + JR = 1 + I2R = 0 + GO TO 194 + ENDIF + vecB3(:MR) = ZERO + vecB(:MR) = matQ(:MR,1) + TWO*vecP(IP+1:MR+IP) + matQ(:MR,1) = HALF*matQ(:MR,1) - matQ(:MR,JM1) + vecB2(:MR) = TWO*(matQ(:MR,1)+matQ(:MR,NLAST)) + K1 = KR + JR - 1 + TCOS(K1+1) = -TWO + K4 = K1 + 3 - ISTAG + CALL COSGEN (KR + ISTAG - 2, 1, ZERO, FNUM, TCOS(K4), 4*NR-K4+1) + K4 = K1 + KR + 1 + CALL COSGEN (JR - 1, 1, ZERO, ONE, TCOS(K4), 4*NR-K4+1) + CALL MERGE (TCOS, K1, KR, K1 + KR, JR - 1, 0, 4*NR) + CALL COSGEN (KR, 1, HALF, FDEN, TCOS(K1+1), 4*NR-K1) + K2 = KR + K4 = K1 + K2 + 1 + CALL COSGEN (LR, 1, HALF, FDEN, TCOS(K4), 4*NR-K4+1) + K3 = LR + K4 = 0 + CALL TRI3 (MR, vecA, vecBB, vecC, K, vecB, vecB2, vecB3, TCOS, & + 4*NR, vecD, vecW, vecW2, vecW3) + vecB(:MR) = vecB(:MR) + vecB2(:MR) + TCOS(1) = TWO + CALL TRIX (1, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,1) = matQ(:MR,1) + vecB(:MR) + GO TO 194 + 192 CONTINUE + vecB(:MR) = matQ(:MR,NLAST) + GO TO 196 + 194 CONTINUE + J = NLAST - JR + vecB(:MR) = matQ(:MR,NLAST) + matQ(:MR,J) + 196 CONTINUE + JM2 = NLAST - I2R + IF (JR == 1) THEN + matQ(:MR,NLAST) = ZERO + ELSE + IF (NROD == 0) THEN + matQ(:MR,NLAST) = vecP(IP+1:MR+IP) + IP = IP - MR + ELSE + matQ(:MR,NLAST) = matQ(:MR,NLAST) - matQ(:MR,JM2) + ENDIF + ENDIF + CALL COSGEN (KR, 1, HALF, FDEN, TCOS, 4*NR) + CALL COSGEN (LR, 1, HALF, FDEN, TCOS(KR+1), 4*NR-KR) + IF (LR == 0) THEN + vecB(:MR) = FISTAG*vecB(:MR) + ENDIF + CALL TRIX (KR, LR, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,NLAST) = matQ(:MR,NLAST) + vecB(:MR) + NLASTP = NLAST + 206 CONTINUE + JSTEP = JR + JR = I2R + I2R = I2R/2 + IF (JR == 0) GO TO 222 + SELECT CASE (MIXBND) + CASE DEFAULT + JSTART = 1 + JR + CASE (2) + JSTART = JR + END SELECT + KR = KR - JR + IF (NLAST + JR <= N) THEN + KR = KR - JR + NLAST = NLAST + JR + JSTOP = NLAST - JSTEP + ELSE + JSTOP = NLAST - JR + ENDIF + LR = KR - JR + CALL COSGEN (JR, 1, HALF, ZERO, TCOS, 4*NR) + DO J = JSTART, JSTOP, JSTEP + JM2 = J - JR + JP2 = J + JR + IF (J == JR) THEN + vecB(:MR) = matQ(:MR,J) + matQ(:MR,JP2) + ELSE + vecB(:MR) = matQ(:MR,J) + matQ(:MR,JM2) + matQ(:MR,JP2) + ENDIF + IF (JR == 1) THEN + matQ(:MR,J) = ZERO + ELSE + JM1 = J - I2R + JP1 = J + I2R + matQ(:MR,J) = HALF*(matQ(:MR,J)-matQ(:MR,JM1)-matQ(:MR,JP1)) + ENDIF + CALL TRIX (JR, 0, MR, vecA, vecBB, vecC, vecB, TCOS, 4*NR, vecD, vecW) + matQ(:MR,J) = matQ(:MR,J) + vecB(:MR) + END DO + NROD = 1 + IF (NLAST + I2R <= N) NROD = 0 + IF (NLASTP /= NLAST) GO TO 194 + GO TO 206 + 222 CONTINUE + vecW(1) = IPSTOR + RETURN + END SUBROUTINE POISN2 + + + SUBROUTINE POISP2(M, N, vecA, vecBB, vecC, matQ, IDIMQ, & + vecB, vecB2, vecB3, vecW, vecW2, vecW3, & + vecD, TCOS, vecP, IP) + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: M, N, IDIMQ, IP + DOUBLE PRECISION, DIMENSION(M), INTENT(IN) :: vecA, vecBB, vecC + DOUBLE PRECISION, DIMENSION(4*N), INTENT(INOUT) :: TCOS + DOUBLE PRECISION, DIMENSION(IDIMQ,N), INTENT(INOUT) :: matQ + DOUBLE PRECISION, DIMENSION(IP),INTENT(INOUT) :: vecP + DOUBLE PRECISION, DIMENSION(M),INTENT(INOUT) :: vecB, vecB2, vecB3, & + vecD, vecW, vecW2, vecW3 +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: MR, NR, NRM1, J, NRMJ, NRPJ, I, IPSTOR, LH + DOUBLE PRECISION :: S, T +!----------------------------------------------- +! +! SUBROUTINE TO SOLVE POISSON EQUATION WITH PERIODIC BOUNDARY +! CONDITIONS. +! + MR = M + NR = (N + 1)/2 + NRM1 = NR - 1 + IF (2*NR == N) THEN +! +! EVEN NUMBER OF UNKNOWNS +! + DO J = 1, NRM1 + NRMJ = NR - J + NRPJ = NR + J + DO I = 1, MR + S = matQ(I,NRMJ) - matQ(I,NRPJ) + T = matQ(I,NRMJ) + matQ(I,NRPJ) + matQ(I,NRMJ) = S + matQ(I,NRPJ) = T + END DO + END DO + matQ(:MR,NR) = TWO*matQ(:MR,NR) + matQ(:MR,N) = TWO*matQ(:MR,N) + CALL POISD2 (MR, NRM1, 1, vecA, vecBB, vecC, matQ, IDIMQ, & + vecB, vecW, vecD, TCOS, vecP, IP) + IPSTOR = vecW(1) + CALL POISN2 (MR, NR + 1, 1, 1, vecA, vecBB, vecC, matQ(:,NR:), & + IDIMQ, vecB, vecB2, vecB3, vecW, vecW2, vecW3, vecD, & + TCOS, vecP, IP) + IPSTOR = MAX0(IPSTOR,INT(vecW(1))) + DO J = 1, NRM1 + NRMJ = NR - J + NRPJ = NR + J + DO I = 1, MR + S = HALF*(matQ(I,NRPJ)+matQ(I,NRMJ)) + T = HALF*(matQ(I,NRPJ)-matQ(I,NRMJ)) + matQ(I,NRMJ) = S + matQ(I,NRPJ) = T + END DO + END DO + matQ(:MR,NR) = HALF*matQ(:MR,NR) + matQ(:MR,N) = HALF*matQ(:MR,N) + ELSE + DO J = 1, NRM1 + NRPJ = N + 1 - J + DO I = 1, MR + S = matQ(I,J) - matQ(I,NRPJ) + T = matQ(I,J) + matQ(I,NRPJ) + matQ(I,J) = S + matQ(I,NRPJ) = T + END DO + END DO + matQ(:MR,NR) = TWO*matQ(:MR,NR) + LH = NRM1/2 + DO J = 1, LH + NRMJ = NR - J + DO I = 1, MR + S = matQ(I,J) + matQ(I,J) = matQ(I,NRMJ) + matQ(I,NRMJ) = S + END DO + END DO + CALL POISD2 (MR, NRM1, 2, vecA, vecBB, vecC, matQ, IDIMQ, & + vecB, vecW, vecD, TCOS, vecP, IP) + IPSTOR = vecW(1) + CALL POISN2 (MR, NR, 2, 1, vecA, vecBB, vecC, matQ(:,NR:), IDIMQ, & + vecB, vecB2, vecB3, vecW, vecW2, vecW3, vecD, TCOS, & + vecP, IP) + IPSTOR = MAX0(IPSTOR,INT(vecW(1))) + DO J = 1, NRM1 + NRPJ = NR + J + DO I = 1, MR + S = HALF*(matQ(I,NRPJ)+matQ(I,J)) + T = HALF*(matQ(I,NRPJ)-matQ(I,J)) + matQ(I,NRPJ) = T + matQ(I,J) = S + END DO + END DO + matQ(:MR,NR) = HALF*matQ(:MR,NR) + DO J = 1, LH + NRMJ = NR - J + DO I = 1, MR + S = matQ(I,J) + matQ(I,J) = matQ(I,NRMJ) + matQ(I,NRMJ) = S + END DO + END DO + ENDIF + vecW(1) = IPSTOR +! +! REVISION HISTORY--- +! +! SEPTEMBER 1973 VERSION 1 +! APRIL 1976 VERSION 2 +! JANUARY 1978 VERSION 3 +! DECEMBER 1979 VERSION 3.1 +! FEBRUARY 1985 DOCUMENTATION UPGRADE +! NOVEMBER 1988 VERSION 3.2, FORTRAN 77 CHANGES +! June 2004 Version 5.0, Fortran 90 changes +!----------------------------------------------------------------------- + END SUBROUTINE POISP2 diff --git a/fish90/src/gnbnaux.f90 b/fish90/src/gnbnaux.f90 new file mode 100644 index 0000000000000000000000000000000000000000..4640121ecf744e48588a3222b58c153710f7eb37 --- /dev/null +++ b/fish90/src/gnbnaux.f90 @@ -0,0 +1,399 @@ +! +! file gnbnaux.f +! +! +! . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . +! . . +! . copyright (c) 2004 by UCAR . +! . . +! . UNIVERSITY CORPORATION for ATMOSPHERIC RESEARCH . +! . . +! . all rights reserved . +! . . +! . . +! . FISHPACK version 5.0 . +! . . +! . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . +! +! * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * +! * * +! * F I S H P A C K * +! * * +! * * +! * A PACKAGE OF FORTRAN SUBPROGRAMS FOR THE SOLUTION OF * +! * * +! * SEPARABLE ELLIPTIC PARTIAL DIFFERENTIAL EQUATIONS * +! * * +! * (Version 5.0 , JUNE 2004) * +! * * +! * BY * +! * * +! * JOHN ADAMS, PAUL SWARZTRAUBER AND ROLAND SWEET * +! * * +! * OF * +! * * +! * THE NATIONAL CENTER FOR ATMOSPHERIC RESEARCH * +! * * +! * BOULDER, COLORADO (80307) U.S.A. * +! * * +! * WHICH IS SPONSORED BY * +! * * +! * THE NATIONAL SCIENCE FOUNDATION * +! * * +! * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * +! +! +! PACKAGE GNBNAUX +! +! LATEST REVISION June 2004 +! +! PURPOSE TO PROVIDE AUXILIARY ROUTINES FOR FISHPACK +! ENTRIES GENBUN AND POISTG. +! +! USAGE THERE ARE NO USER ENTRIES IN THIS PACKAGE. +! THE ROUTINES IN THIS PACKAGE ARE NOT INTENDED +! TO BE CALLED BY USERS, BUT RATHER BY ROUTINES +! IN PACKAGES GENBUN AND POISTG. +! +! SPECIAL CONDITIONS NONE +! +! I/O NONE +! +! PRECISION SINGLE +! +! +! LANGUAGE FORTRAN 90 +! +! HISTORY WRITTEN IN 1979 BY ROLAND SWEET OF NCAR'S +! SCIENTIFIC COMPUTING DIVISION. MADE AVAILABLE +! ON NCAR'S PUBLIC LIBRARIES IN JANUARY, 1980. +! Revised by John Adams in June 2004 incorporating +! Fortran 90 features +! +! PORTABILITY FORTRAN 90 +! ******************************************************************** + SUBROUTINE COSGEN(N, IJUMP, FNUM, FDEN, vecA, IA) + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: N, IJUMP, IA + DOUBLE PRECISION, INTENT(IN) :: FNUM, FDEN + DOUBLE PRECISION, DIMENSION(IA),INTENT(OUT) :: vecA +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: K3, K4, K, K1, K5, I, K2, NP1 + DOUBLE PRECISION :: PI, PIBYN, X, Y +!----------------------------------------------- +! +! +! THIS SUBROUTINE COMPUTES REQUIRED COSINE VALUES IN ASCENDING +! ORDER. WHEN IJUMP .GT. 1 THE ROUTINE COMPUTES VALUES +! +! 2*COS(J*PI/L) , J=1,2,...,L AND J .NE. 0(MOD N/IJUMP+1) +! +! WHERE L = IJUMP*(N/IJUMP+1). +! +! +! WHEN IJUMP = 1 IT COMPUTES +! +! 2*COS((J-FNUM)*PI/(N+FDEN)) , J=1, 2, ... ,N +! +! WHERE +! FNUM = 0.5, FDEN = 0.0, FOR REGULAR REDUCTION VALUES +! FNUM = 0.0, FDEN = 1.0, FOR B-R AND C-R WHEN ISTAG = 1 +! FNUM = 0.0, FDEN = 0.5, FOR B-R AND C-R WHEN ISTAG = 2 +! FNUM = 0.5, FDEN = 0.5, FOR B-R AND C-R WHEN ISTAG = 2 +! IN POISN2 ONLY. +! +! + PI = 4.0*ATAN(1.0) + IF (N /= 0) THEN + IF (IJUMP /= 1) THEN + K3 = N/IJUMP + 1 + K4 = K3 - 1 + PIBYN = PI/FLOAT(N + IJUMP) + DO K = 1, IJUMP + K1 = (K - 1)*K3 + K5 = (K - 1)*K4 + DO I = 1, K4 + X = K1 + I + K2 = K5 + I + vecA(K2) = -2.*COS(X*PIBYN) + END DO + END DO + ELSE + NP1 = N + 1 + Y = PI/(FLOAT(N) + FDEN) + DO I = 1, N + X = FLOAT(NP1 - I) - FNUM + vecA(I) = 2.*COS(X*Y) + END DO + ENDIF + ENDIF +! + END SUBROUTINE COSGEN + + SUBROUTINE MERGE(TCOS, I1, M1, I2, M2, I3, itcos) + implicit none + + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: I1, M1, I2, M2, I3, ITCOS + DOUBLE PRECISION, DIMENSION(ITCOS), INTENT(INOUT) :: TCOS +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: J11, J3, J1, J2, J, L, K, M + DOUBLE PRECISION :: X, Y +!----------------------------------------------- +! +! THIS SUBROUTINE MERGES TWO ASCENDING STRINGS OF NUMBERS IN THE +! ARRAY TCOS. THE FIRST STRING IS OF LENGTH M1 AND STARTS AT +! TCOS(I1+1). THE SECOND STRING IS OF LENGTH M2 AND STARTS AT +! TCOS(I2+1). THE MERGED STRING GOES INTO TCOS(I3+1). +! +! + J1 = 1 + J2 = 1 + J = I3 + IF (M1 == 0) GO TO 107 + IF (M2 == 0) GO TO 104 + 101 CONTINUE + J11 = J1 + J3 = MAX(M1,J11) + DO J1 = J11, J3 + J = J + 1 + L = J1 + I1 + X = TCOS(L) + L = J2 + I2 + Y = TCOS(L) + IF (X - Y > 0.) GO TO 103 + TCOS(J) = X + END DO + GO TO 106 + 103 CONTINUE + TCOS(J) = Y + J2 = J2 + 1 + IF (J2 <= M2) GO TO 101 + IF (J1 > M1) GO TO 109 + 104 CONTINUE + K = J - J1 + 1 + DO J = J1, M1 + M = K + J + L = J + I1 + TCOS(M) = TCOS(L) + END DO + GO TO 109 + 106 CONTINUE + IF (J2 > M2) GO TO 109 + 107 CONTINUE + K = J - J2 + 1 + DO J = J2, M2 + M = K + J + L = J + I2 + TCOS(M) = TCOS(L) + END DO + 109 CONTINUE +! + END SUBROUTINE MERGE + + + SUBROUTINE TRIX(IDEGBR, IDEGCR, M, vecA, vecB, vecC, vecY, TCOS, ITCOS, & + vecD, vecW) + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: IDEGBR, IDEGCR, M, ITCOS + DOUBLE PRECISION, DIMENSION(M), INTENT(IN) :: vecA, vecB, vecC + DOUBLE PRECISION, DIMENSION(ITCOS), INTENT(IN) :: TCOS + DOUBLE PRECISION, DIMENSION(M), INTENT(INOUT) :: vecY, vecD, vecW +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: MM1, IFB, IFC, L, LINT, K, I, IP + DOUBLE PRECISION :: X, XX, Z +!----------------------------------------------- +! +! SUBROUTINE TO SOLVE A SYSTEM OF LINEAR EQUATIONS WHERE THE +! COEFFICIENT MATRIX IS A RATIONAL FUNCTION IN THE MATRIX GIVEN BY +! TRIDIAGONAL ( . . . , vecA(I), vecB(I), vecC(I), . . . ). +! + MM1 = M - 1 + IFB = IDEGBR + 1 + IFC = IDEGCR + 1 + L = IFB/IFC + LINT = 1 + DO K = 1, IDEGBR + X = TCOS(K) + IF (K == L) THEN + I = IDEGBR + LINT + XX = X - TCOS(I) + vecW(:M) = vecY(:M) + vecY(:M) = XX*vecY(:M) + ENDIF + Z = 1./(vecB(1)-X) + vecD(1) = vecC(1)*Z + vecY(1) = vecY(1)*Z + DO I = 2, MM1 + Z = 1./(vecB(I)-X-vecA(I)*vecD(I-1)) + vecD(I) = vecC(I)*Z + vecY(I) = (vecY(I)-vecA(I)*vecY(I-1))*Z + END DO + Z = vecB(M) - X - vecA(M)*vecD(MM1) + IF (Z == 0.) THEN + vecY(M) = 0. + ELSE + vecY(M) = (vecY(M)-vecA(M)*vecY(MM1))/Z + ENDIF + DO IP = 1, MM1 + vecY(M-IP) = vecY(M-IP) - vecD(M-IP)*vecY(M+1-IP) + END DO + IF (K /= L) CYCLE + vecY(:M) = vecY(:M) + vecW(:M) + LINT = LINT + 1 + L = (LINT*IFB)/IFC + END DO +! + END SUBROUTINE TRIX + + + SUBROUTINE TRI3(M, vecA, vecB, vecC, ivecK, vecY1, vecY2, vecY3, TCOS, & + ITCOS, vecD, vecW1, vecW2, vecW3) + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: M,ITCOS + INTEGER, DIMENSION(4),INTENT(IN) :: ivecK + DOUBLE PRECISION, DIMENSION(M), INTENT(IN) :: vecA, vecB, vecC + DOUBLE PRECISION, DIMENSION(ITCOS), INTENT(IN) :: TCOS + DOUBLE PRECISION, DIMENSION(M), INTENT(INOUT) :: vecY1, vecY2, vecY3, & + vecD, vecW1, vecW2, vecW3 +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: MM1, K1, K2, K3, K4, IF1, IF2, IF3, IF4, K2K3K4, & + L1, L2, L3, LINT1, LINT2, LINT3, KINT1, KINT2, KINT3, & + N, I, IP + DOUBLE PRECISION :: X, Z, XX +!----------------------------------------------- +! +! SUBROUTINE TO SOLVE THREE LINEAR SYSTEMS WHOSE COMMON COEFFICIENT +! MATRIX IS A RATIONAL FUNCTION IN THE MATRIX GIVEN BY +! +! TRIDIAGONAL (...,vecA(I),vecB(I),vecC(I),...) +! + MM1 = M - 1 + K1 = ivecK(1) + K2 = ivecK(2) + K3 = ivecK(3) + K4 = ivecK(4) + IF1 = K1 + 1 + IF2 = K2 + 1 + IF3 = K3 + 1 + IF4 = K4 + 1 + K2K3K4 = K2 + K3 + K4 + IF (K2K3K4 /= 0) THEN + L1 = IF1/IF2 + L2 = IF1/IF3 + L3 = IF1/IF4 + LINT1 = 1 + LINT2 = 1 + LINT3 = 1 + KINT1 = K1 + KINT2 = KINT1 + K2 + KINT3 = KINT2 + K3 + ELSE + write(*,*) 'warning tri3: l1,l2,l3,kint1,kint2,kint3 uninitialized' + stop 'stop in tri3: l1,l2,l3,kint1,kint2,kint3 uninitialized' + ENDIF + DO N = 1, K1 + X = TCOS(N) + IF (K2K3K4 /= 0) THEN + IF (N == L1) THEN + vecW1(:M) = vecY1(:M) + ENDIF + IF (N == L2) THEN + vecW2(:M) = vecY2(:M) + ENDIF + IF (N == L3) THEN + vecW3(:M) = vecY3(:M) + ENDIF + ENDIF + Z = 1./(vecB(1)-X) + vecD(1) = vecC(1)*Z + vecY1(1) = vecY1(1)*Z + vecY2(1) = vecY2(1)*Z + vecY3(1) = vecY3(1)*Z + DO I = 2, M + Z = 1./(vecB(I)-X-vecA(I)*vecD(I-1)) + vecD(I) = vecC(I)*Z + vecY1(I) = (vecY1(I)-vecA(I)*vecY1(I-1))*Z + vecY2(I) = (vecY2(I)-vecA(I)*vecY2(I-1))*Z + vecY3(I) = (vecY3(I)-vecA(I)*vecY3(I-1))*Z + END DO + DO IP = 1, MM1 + vecY1(M-IP) = vecY1(M-IP) - vecD(M-IP)*vecY1(M+1-IP) + vecY2(M-IP) = vecY2(M-IP) - vecD(M-IP)*vecY2(M+1-IP) + vecY3(M-IP) = vecY3(M-IP) - vecD(M-IP)*vecY3(M+1-IP) + END DO + IF (K2K3K4 == 0) CYCLE + IF (N == L1) THEN + I = LINT1 + KINT1 + XX = X - TCOS(I) + vecY1(:M) = XX*vecY1(:M) + vecW1(:M) + LINT1 = LINT1 + 1 + L1 = (LINT1*IF1)/IF2 + ENDIF + IF (N == L2) THEN + I = LINT2 + KINT2 + XX = X - TCOS(I) + vecY2(:M) = XX*vecY2(:M) + vecW2(:M) + LINT2 = LINT2 + 1 + L2 = (LINT2*IF1)/IF3 + ENDIF + IF (N /= L3) CYCLE + I = LINT3 + KINT3 + XX = X - TCOS(I) + vecY3(:M) = XX*vecY3(:M) + vecW3(:M) + LINT3 = LINT3 + 1 + L3 = (LINT3*IF1)/IF4 + END DO + RETURN +! +! REVISION HISTORY--- +! +! SEPTEMBER 1973 VERSION 1 +! APRIL 1976 VERSION 2 +! JANUARY 1978 VERSION 3 +! DECEMBER 1979 VERSION 3.1 +! OCTOBER 1980 CHANGED SEVERAL DIVIDES OF FLOATING INTEGERS +! TO INTEGER DIVIDES TO ACCOMODATE CRAY-1 ARITHMETIC. +! FEBRUARY 1985 DOCUMENTATION UPGRADE +! NOVEMBER 1988 VERSION 3.2, FORTRAN 77 CHANGES +!----------------------------------------------------------------------- + END SUBROUTINE TRI3 diff --git a/fish90/src/hst_procs.f90 b/fish90/src/hst_procs.f90 new file mode 100644 index 0000000000000000000000000000000000000000..f438ec0416c8da45c55da0e5911711327e42946b --- /dev/null +++ b/fish90/src/hst_procs.f90 @@ -0,0 +1,1650 @@ +! +! file hstcrt.f +! +! . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . +! . . +! . copyright (c) 2004 by UCAR . +! . . +! . UNIVERSITY CORPORATION for ATMOSPHERIC RESEARCH . +! . . +! . all rights reserved . +! . . +! . . +! . FISHPACK version 5.0 . +! . . +! . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . +! +! * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * +! * * +! * F I S H P A C K * +! * * +! * * +! * A PACKAGE OF FORTRAN SUBPROGRAMS FOR THE SOLUTION OF * +! * * +! * SEPARABLE ELLIPTIC PARTIAL DIFFERENTIAL EQUATIONS * +! * * +! * (Version 5.0 , JUNE 2004) * +! * * +! * BY * +! * * +! * JOHN ADAMS, PAUL SWARZTRAUBER AND ROLAND SWEET * +! * * +! * OF * +! * * +! * THE NATIONAL CENTER FOR ATMOSPHERIC RESEARCH * +! * * +! * BOULDER, COLORADO (80307) U.S.A. * +! * * +! * WHICH IS SPONSORED BY * +! * * +! * THE NATIONAL SCIENCE FOUNDATION * +! * * +! * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * +! +! SUBROUTINE HSTCRT (A,B,M,MBDCND,BDA,BDB,C,D,N,NBDCND,BDC,BDD, +! + ELMBDA,F,IDIMF,PERTRB,IERROR) +! +! DIMENSION OF BDA(N),BDB(N),BDC(M),BDD(M),F(IDIMF,N) +! ARGUMENTS +! +! LATEST REVISION June 2004 +! +! PURPOSE SOLVES THE STANDARD FIVE-POINT FINITE +! DIFFERENCE APPROXIMATION TO THE HELMHOLTZ +! EQUATION +! (D/DX)(DU/DX) + (D/DY)(DU/DY) + LAMBDA*U +! = F(X,Y) +! ON A STAGGERED GRID IN CARTESIAN COORDINATES. +! +! USAGE CALL HSTCRT (A,B,M,MBDCND,BDA,BDB,C,D +! N,NBDCND,BDC,BDD,ELMBDA, +! F,IDIMF,PERTRB,IERROR) +! +! ARGUMENTS +! ON INPUT +! +! A,B +! THE RANGE OF X, I.E. A .LE. X .LE. B. +! A MUST BE LESS THAN B. +! +! M +! THE NUMBER OF GRID POINTS IN THE +! INTERVAL (A,B). THE GRID POINTS +! IN THE X-DIRECTION ARE GIVEN BY +! X(I) = A + (I-0.5)DX FOR I=1,2,...,M +! WHERE DX =(B-A)/M. M MUST BE GREATER +! THAN 2. +! +! MBDCND +! INDICATES THE TYPE OF BOUNDARY CONDITIONS +! AT X = A AND X = B. +! +! = 0 IF THE SOLUTION IS PERIODIC IN X, +! U(M+I,J) = U(I,J). +! +! = 1 IF THE SOLUTION IS SPECIFIED AT +! X = A AND X = B. +! +! = 2 IF THE SOLUTION IS SPECIFIED AT +! X = A AND THE DERIVATIVE +! OF THE SOLUTION WITH RESPECT TO X +! IS SPECIFIED AT X = B. +! +! = 3 IF THE DERIVATIVE OF THE SOLUTION +! WITH RESPECT TO X IS SPECIFIED +! AT X = A AND X = B. +! +! = 4 IF THE DERIVATIVE OF THE SOLUTION +! WITH RESPECT TO X IS SPECIFIED +! AT X = A AND THE SOLUTION IS +! SPECIFIED AT X = B. +! +! BDA +! A ONE-DIMENSIONAL ARRAY OF LENGTH N +! THAT SPECIFIES THE BOUNDARY VALUES +! (IF ANY) OF THE SOLUTION AT X = A. +! +! WHEN MBDCND = 1 OR 2, +! BDA(J) = U(A,Y(J)) , J=1,2,...,N. +! +! WHEN MBDCND = 3 OR 4, +! BDA(J) = (D/DX)U(A,Y(J)) , J=1,2,...,N. +! +! BDB +! A ONE-DIMENSIONAL ARRAY OF LENGTH N +! THAT SPECIFIES THE BOUNDARY VALUES +! OF THE SOLUTION AT X = B. +! +! WHEN MBDCND = 1 OR 4 +! BDB(J) = U(B,Y(J)) , J=1,2,...,N. +! +! WHEN MBDCND = 2 OR 3 +! BDB(J) = (D/DX)U(B,Y(J)) , J=1,2,...,N. +! +! C,D +! THE RANGE OF Y, I.E. C .LE. Y .LE. D. +! C MUST BE LESS THAN D. +! +! +! N +! THE NUMBER OF UNKNOWNS IN THE INTERVAL +! (C,D). THE UNKNOWNS IN THE Y-DIRECTION +! ARE GIVEN BY Y(J) = C + (J-0.5)DY, +! J=1,2,...,N, WHERE DY = (D-C)/N. +! N MUST BE GREATER THAN 2. +! +! NBDCND +! INDICATES THE TYPE OF BOUNDARY CONDITIONS +! AT Y = C AND Y = D. +! +! +! = 0 IF THE SOLUTION IS PERIODIC IN Y, I.E. +! U(I,J) = U(I,N+J). +! +! = 1 IF THE SOLUTION IS SPECIFIED AT Y = C +! AND Y = D. +! +! = 2 IF THE SOLUTION IS SPECIFIED AT Y = C +! AND THE DERIVATIVE OF THE SOLUTION +! WITH RESPECT TO Y IS SPECIFIED AT +! Y = D. +! +! = 3 IF THE DERIVATIVE OF THE SOLUTION +! WITH RESPECT TO Y IS SPECIFIED AT +! Y = C AND Y = D. +! +! = 4 IF THE DERIVATIVE OF THE SOLUTION +! WITH RESPECT TO Y IS SPECIFIED AT +! Y = C AND THE SOLUTION IS SPECIFIED +! AT Y = D. +! +! BDC +! A ONE DIMENSIONAL ARRAY OF LENGTH M THAT +! SPECIFIES THE BOUNDARY VALUES OF THE +! SOLUTION AT Y = C. +! +! WHEN NBDCND = 1 OR 2, +! BDC(I) = U(X(I),C) , I=1,2,...,M. +! +! WHEN NBDCND = 3 OR 4, +! BDC(I) = (D/DY)U(X(I),C), I=1,2,...,M. +! +! WHEN NBDCND = 0, BDC IS A DUMMY VARIABLE. +! +! BDD +! A ONE-DIMENSIONAL ARRAY OF LENGTH M THAT +! SPECIFIES THE BOUNDARY VALUES OF THE +! SOLUTION AT Y = D. +! +! WHEN NBDCND = 1 OR 4, +! BDD(I) = U(X(I),D) , I=1,2,...,M. +! +! WHEN NBDCND = 2 OR 3, +! BDD(I) = (D/DY)U(X(I),D) , I=1,2,...,M. +! +! WHEN NBDCND = 0, BDD IS A DUMMY VARIABLE. +! +! ELMBDA +! THE CONSTANT LAMBDA IN THE HELMHOLTZ +! EQUATION. IF LAMBDA IS GREATER THAN 0, +! A SOLUTION MAY NOT EXIST. HOWEVER, +! HSTCRT WILL ATTEMPT TO FIND A SOLUTION. +! +! F +! A TWO-DIMENSIONAL ARRAY THAT SPECIFIES +! THE VALUES OF THE RIGHT SIDE OF THE +! HELMHOLTZ EQUATION. FOR I=1,2,...,M +! AND J=1,2,...,N +! +! F(I,J) = F(X(I),Y(J)) . +! +! F MUST BE DIMENSIONED AT LEAST M X N. +! +! IDIMF +! THE ROW (OR FIRST) DIMENSION OF THE ARRAY +! F AS IT APPEARS IN THE PROGRAM CALLING +! HSTCRT. THIS PARAMETER IS USED TO SPECIFY +! THE VARIABLE DIMENSION OF F. +! IDIMF MUST BE AT LEAST M. +! +! +! ON OUTPUT F +! CONTAINS THE SOLUTION U(I,J) OF THE FINITE +! DIFFERENCE APPROXIMATION FOR THE GRID POINT +! (X(I),Y(J)) FOR I=1,2,...,M, J=1,2,...,N. +! +! PERTRB +! IF A COMBINATION OF PERIODIC OR DERIVATIVE +! BOUNDARY CONDITIONS IS SPECIFIED FOR A +! POISSON EQUATION (LAMBDA = 0), A SOLUTION +! MAY NOT EXIST. PERTRB IS A CONSTANT, +! CALCULATED AND SUBTRACTED FROM F, WHICH +! ENSURES THAT A SOLUTION EXISTS. HSTCRT +! THEN COMPUTES THIS SOLUTION, WHICH IS A +! LEAST SQUARES SOLUTION TO THE ORIGINAL +! APPROXIMATION. THIS SOLUTION PLUS ANY +! CONSTANT IS ALSO A SOLUTION; HENCE, THE +! SOLUTION IS NOT UNIQUE. THE VALUE OF +! PERTRB SHOULD BE SMALL COMPARED TO THE +! RIGHT SIDE F. OTHERWISE, A SOLUTION IS +! OBTAINED TO AN ESSENTIALLY DIFFERENT PROBLEM. +! THIS COMPARISON SHOULD ALWAYS BE MADE TO +! INSURE THAT A MEANINGFUL SOLUTION HAS BEEN +! OBTAINED. +! +! IERROR +! AN ERROR FLAG THAT INDICATES INVALID INPUT +! PARAMETERS. EXCEPT TO NUMBERS 0 AND 6, +! A SOLUTION IS NOT ATTEMPTED. +! +! = 0 NO ERROR +! +! = 1 A .GE. B +! +! = 2 MBDCND .LT. 0 OR MBDCND .GT. 4 +! +! = 3 C .GE. D +! +! = 4 N .LE. 2 +! +! = 5 NBDCND .LT. 0 OR NBDCND .GT. 4 +! +! = 6 LAMBDA .GT. 0 +! +! = 7 IDIMF .LT. M +! +! = 8 M .LE. 2 +! +! SINCE THIS IS THE ONLY MEANS OF INDICATING +! A POSSIBLY INCORRECT CALL TO HSTCRT, THE +! USER SHOULD TEST IERROR AFTER THE CALL. +! +! = 20 If the dynamic allocation of real and +! complex work space required for solution +! fails (for example if N,M are too large +! for your computer) +! +! +! I/O NONE +! +! PRECISION SINGLE +! +! REQUIRED LIBRARY fish.f,comf.f,genbun.f,gnbnaux.f,poistg.f +! FILES +! +! LANGUAGE FORTRAN 90 +! +! HISTORY WRITTEN BY ROLAND SWEET AT NCAR IN 1977. +! RELEASED ON NCAR'S PUBLIC SOFTWARE LIBRARIES +! IN JANUARY 1980. +! Revised in June 2004 by John Adams using +! Fortran 90 dynamically allocated work space. +! +! PORTABILITY FORTRAN 90 +! +! ALGORITHM THIS SUBROUTINE DEFINES THE FINITE-DIFFERENCE +! EQUATIONS, INCORPORATES BOUNDARY DATA, ADJUSTS +! THE RIGHT SIDE WHEN THE SYSTEM IS SINGULAR +! AND CALLS EITHER POISTG OR GENBUN WHICH SOLVES +! THE LINEAR SYSTEM OF EQUATIONS. +! +! TIMING FOR LARGE M AND N, THE OPERATION COUNT +! IS ROUGHLY PROPORTIONAL TO M*N*LOG2(N). +! +! ACCURACY THE SOLUTION PROCESS EMPLOYED RESULTS IN A +! LOSS OF NO MORE THAN FOUR SIGNIFICANT DIGITS +! FOR N AND M AS LARGE AS 64. MORE DETAILED +! INFORMATION ABOUT ACCURACY CAN BE FOUND IN +! THE DOCUMENTATION FOR PACKAGE POISTG WHICH +! SOLVES THE FINITE DIFFERENCE EQUATIONS. +! +! REFERENCES U. SCHUMANN AND R. SWEET,"A DIRECT METHOD +! FOR THE SOLUTION OF POISSON'S EQUATION WITH +! BOUNDARY CONDITIONS ON A STAGGERED GRID OF +! ARBITRARY SIZE," J. COMP. PHYS. 20(1976), +! PP. 171-182. +!*********************************************************************** + SUBROUTINE HSTCRT(A, B, M, MBDCND, vecBDA, vecBDB, C, D, N, NBDCND, & + vecBDC, vecBDD, ELMBDA, matF, IDIMF, PERTRB, IERROR) + USE fish + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER,INTENT(IN) :: M,MBDCND,N,NBDCND,IDIMF + INTEGER,INTENT(OUT) :: IERROR + DOUBLE PRECISION,INTENT(IN) :: A,B,C,D,ELMBDA + DOUBLE PRECISION,INTENT(OUT) :: PERTRB + DOUBLE PRECISION,DIMENSION(N),INTENT(IN) :: vecBDA,vecBDB + DOUBLE PRECISION,DIMENSION(M),INTENT(IN) :: vecBDC,vecBDD + DOUBLE PRECISION,DIMENSION(IDIMF,N),INTENT(INOUT) :: matF +!----------------------------------------------- +! Allocatable arrays +!----------------------------------------------- + DOUBLE PRECISION,DIMENSION(:),ALLOCATABLE :: work +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: irwk, istatus + + ! JANNIS: add interface + interface + SUBROUTINE HSTCRTT(A, B, M, MBDCND, vecBDA, vecBDB, C, D, N, NBDCND, & + vecBDC, vecBDD, ELMBDA, matF, IDIMF, PERTRB, IERROR, vecW, IW) + INTEGER,INTENT(IN) :: M,MBDCND,N,NBDCND,IDIMF,IW + INTEGER,INTENT(OUT) :: IERROR + DOUBLE PRECISION,INTENT(IN) :: A,B,C,D,ELMBDA + DOUBLE PRECISION,INTENT(OUT) :: PERTRB + DOUBLE PRECISION,DIMENSION(N),INTENT(IN) :: vecBDA,vecBDB + DOUBLE PRECISION,DIMENSION(M),INTENT(IN) :: vecBDC,vecBDD + DOUBLE PRECISION,DIMENSION(IDIMF,N),INTENT(INOUT) :: matF + DOUBLE PRECISION,DIMENSION(IW),INTENT(INOUT) :: vecW + end subroutine HSTCRTT + end interface +!----------------------------------------------- +! +! CHECK FOR INVALID PARAMETERS. +! + IERROR = 0 + + IF (A >= B) IERROR = 1 + IF (MBDCND<0 .OR. MBDCND>4) IERROR = 2 + IF (C >= D) IERROR = 3 + IF (N <= 2) IERROR = 4 + IF (NBDCND<0 .OR. NBDCND>4) IERROR = 5 + IF (IDIMF < M) IERROR = 7 + IF (M <= 2) IERROR = 8 + IF (IERROR /= 0) RETURN +!C! write(*,*) 'hstcrt: vecBDC:',vecBDC(1:size(vecBDC)) +!C! write(*,*) 'hstcrt: BDD:',BDD(:) +!C! write(*,*) 'hstcrt: ELMBDA:',ELMBDA +!C! write(*,*) 'hstcrt: matF:',matF(1:IDIMF,:) +!C! write(*,*) 'hstcrt: IDIMF:',IDIMF +! compute and allocate required real work space + CALL GEN_SPACE (N, M, IRWK) + irwk = irwk + 3*M + allocate(work(irwK),STAT=istatus) +!@! write(*,*) 'HSTCRT: allocate work(irwk); irwk=',irwk +! return if allocation failed (e.g., if n,m are too large) + IF (istatus > 0) THEN + write(*,*) 'HSTCRT: error allocate work(irwk); irwk=',irwk + RETURN + END IF + +! check that allocation was successful + call hstcrtt(a,b,m,mbdcnd,vecbda,vecbdb,c,d,n,nbdcnd, & + vecbdc,vecbdd,elmbda,matf,idimf,pertrb,ierror, & + work,size(work)) +! +!@! write(*,*) 'HSTCRT: deallocate work(irwk); irwk=',irwk + deallocate(work,STAT=istatus) + IF (istatus > 0) THEN + write(*,*) 'HSTCRT: error deallocate work' + RETURN + END IF +! + END SUBROUTINE HSTCRT + + SUBROUTINE HSTCRTT(A, B, M, MBDCND, vecBDA, vecBDB, C, D, N, NBDCND, & + vecBDC, vecBDD, ELMBDA, matF, IDIMF, PERTRB, & + IERROR, vecW, IW) + +! USE genbunal +! USE poisson + + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER,INTENT(IN) :: M,MBDCND,N,NBDCND,IDIMF,IW + INTEGER,INTENT(OUT) :: IERROR + DOUBLE PRECISION,INTENT(IN) :: A,B,C,D,ELMBDA + DOUBLE PRECISION,INTENT(OUT) :: PERTRB + DOUBLE PRECISION,DIMENSION(N),INTENT(IN) :: vecBDA,vecBDB + DOUBLE PRECISION,DIMENSION(M),INTENT(IN) :: vecBDC,vecBDD + DOUBLE PRECISION,DIMENSION(IDIMF,N),INTENT(INOUT) :: matF + DOUBLE PRECISION,DIMENSION(IW),INTENT(INOUT) :: vecW +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: NPEROD, MPEROD, NP, MP, ID2, ID3, ID4, & + J, IERR1, IW2 + DOUBLE PRECISION :: DELTAX,TWDELX,DELXSQ,DELTAY,TWDELY,DELYSQ,TWDYSQ,S,ST2 +!----------------------------------------------- + + NPEROD = NBDCND + MPEROD = 0 + IF (MBDCND > 0) MPEROD = 1 + DELTAX = (B - A)/DBLE(M) + TWDELX = ONE/DELTAX + DELXSQ = TWO/DELTAX**2 + DELTAY = (D - C)/DBLE(N) + TWDELY = ONE/DELTAY + DELYSQ = DELTAY**2 + TWDYSQ = TWO/DELYSQ + NP = NBDCND + 1 + MP = MBDCND + 1 +! +! DEFINE THE A,B,C COEFFICIENTS IN W-ARRAY. +! + ID2 = M + ID3 = ID2 + M + ID4 = ID3 + M + S = (DELTAY/DELTAX)**2 + ST2 = TWO*S + vecW(:M) = S + vecW(ID2+1:M+ID2) = (-ST2) + ELMBDA*DELYSQ + vecW(ID3+1:M+ID3) = S +! +! ENTER BOUNDARY DATA FOR X-BOUNDARIES. +! + GO TO (111,102,102,104,104) MP + 102 CONTINUE + matF(1,:N) = matF(1,:N) - vecBDA(:N)*DELXSQ + vecW(ID2+1) = vecW(ID2+1) - vecW(1) + GO TO 106 + 104 CONTINUE + matF(1,:N) = matF(1,:N) + vecBDA(:N)*TWDELX + vecW(ID2+1) = vecW(ID2+1) + vecW(1) + 106 CONTINUE + GO TO (111,107,109,109,107) MP + 107 CONTINUE + matF(M,:N) = matF(M,:N) - vecBDB(:N)*DELXSQ + vecW(ID3) = vecW(ID3) - vecW(1) + GO TO 111 + 109 CONTINUE + matF(M,:N) = matF(M,:N) - vecBDB(:N)*TWDELX + vecW(ID3) = vecW(ID3) + vecW(1) + 111 CONTINUE + GO TO (121,112,112,114,114) NP + 112 CONTINUE + matF(:M,1) = matF(:M,1) - vecBDC(:M)*TWDYSQ + GO TO 116 + 114 CONTINUE + matF(:M,1) = matF(:M,1) + vecBDC(:M)*TWDELY + 116 CONTINUE + GO TO (121,117,119,119,117) NP + 117 CONTINUE + matF(:M,N) = matF(:M,N) - vecBDD(:M)*TWDYSQ + GO TO 121 + 119 CONTINUE + matF(:M,N) = matF(:M,N) - vecBDD(:M)*TWDELY + 121 CONTINUE + matF(:M,:N) = matF(:M,:N)*DELYSQ + IF (MPEROD /= 0) THEN + vecW(1) = ZERO + vecW(ID4) = ZERO + ENDIF + PERTRB = ZERO + IF (ELMBDA >= ZERO) THEN + IF (ELMBDA /= ZERO) THEN + IERROR = 6 + ELSE + GO TO (127,133,133,127,133) MP + 127 CONTINUE + GO TO (128,133,133,128,133) NP +! +! FOR SINGULAR PROBLEMS MUST ADJUST DATA TO INSURE THAT A SOLUTION +! WILL EXIST. +! + 128 CONTINUE + S = ZERO + DO J = 1, N + S = S + SUM(matF(:M,J)) + END DO + PERTRB = S/DBLE(M*N) + matF(:M,:N) = matF(:M,:N) - PERTRB + PERTRB = PERTRB/DELYSQ +! +! SOLVE THE EQUATION. +! + ENDIF + ENDIF + 133 CONTINUE + IERR1 = 0 +! Workarray splitted into parts of length M and IW + IW2 = size(vecW)-ID4 + IF (NPEROD /= 0) THEN + CALL POISTGG (NPEROD, N, MPEROD, M, vecW(1:M), vecW(ID2+1:ID2+M), & + vecW(ID3+1:ID3+M),IDIMF, matF, IERR1, vecW(ID4+1:),IW2) + ELSE + CALL GENBUNN (NPEROD, N, MPEROD, M, vecW(1:M), vecW(ID2+1:ID2+M), & + vecW(ID3+1:ID3+M), IDIMF, matF, IERR1, vecW(ID4+1:),IW2) + ENDIF +! +! REVISION HISTORY--- +! +! SEPTEMBER 1973 VERSION 1 +! APRIL 1976 VERSION 2 +! JANUARY 1978 VERSION 3 +! DECEMBER 1979 VERSION 3.1 +! FEBRUARY 1985 DOCUMENTATION UPGRADE +! NOVEMBER 1988 VERSION 3.2, FORTRAN 77 CHANGES +! June 2004 Version 5.0, Fortran 90 changes +!----------------------------------------------------------------------- + END SUBROUTINE HSTCRTT + + +! file hstcyl.f +! +! . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . +! . . +! . copyright (c) 2004 by UCAR . +! . . +! . UNIVERSITY CORPORATION for ATMOSPHERIC RESEARCH . +! . . +! . all rights reserved . +! . . +! . . +! . FISHPACK version 5.0 . +! . . +! . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . +! +! * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * +! * * +! * F I S H P A C K * +! * * +! * * +! * A PACKAGE OF FORTRAN SUBPROGRAMS FOR THE SOLUTION OF * +! * * +! * SEPARABLE ELLIPTIC PARTIAL DIFFERENTIAL EQUATIONS * +! * * +! * (Version 5.0 , JUNE 2004) * +! * * +! * BY * +! * * +! * JOHN ADAMS, PAUL SWARZTRAUBER AND ROLAND SWEET * +! * * +! * OF * +! * * +! * THE NATIONAL CENTER FOR ATMOSPHERIC RESEARCH * +! * * +! * BOULDER, COLORADO (80307) U.S.A. * +! * * +! * WHICH IS SPONSORED BY * +! * * +! * THE NATIONAL SCIENCE FOUNDATION * +! * * +! * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * +! +! SUBROUTINE HSTCYL (A,B,M,MBDCND,BDA,BDB,C,D,N,NBDCND,BDC,BDD, +! + ELMBDA,F,IDIMF,PERTRB,IERROR) +! +! DIMENSION OF BDA(N),BDB(N),BDC(M),BDD(M),F(IDIMF,N) +! ARGUMENTS +! +! LATEST REVISION June 2004 +! +! PURPOSE SOLVES THE STANDARD FIVE-POINT FINITE +! DIFFERENCE APPROXIMATION ON A STAGGERED +! GRID TO THE MODIFIED HELMHOLTZ EQUATION +! IN CYLINDRICAL COORDINATES. THIS EQUATION +! +! (1/R)(D/DR)(R(DU/DR)) + (D/DZ)(DU/DZ) +! +! + LAMBDA*(1/R**2)*U = F(R,Z) +! +! IS A TWO-DIMENSIONAL MODIFIED HELMHOLTZ +! EQUATION RESULTING FROM THE FOURIER TRANSFORM +! OF A THREE-DIMENSIONAL POISSON EQUATION. +! +! USAGE CALL HSTCYL (A,B,M,MBDCND,BDA,BDB,C,D,N, +! NBDCND,BDC,BDD,ELMBDA,F,IDIMF, +! PERTRB,IERROR) +! +! ARGUMENTS +! ON INPUT A,B +! +! THE RANGE OF R, I.E. A .LE. R .LE. B. +! A MUST BE LESS THAN B AND A MUST BE +! BE NON-NEGATIVE. +! +! M +! THE NUMBER OF GRID POINTS IN THE INTERVAL +! (A,B). THE GRID POINTS IN THE R-DIRECTION +! R-DIRECTION ARE GIVEN BY +! R(I) = A + (I-0.5)DR FOR I=1,2,...,M +! WHERE DR =(B-A)/M. +! M MUST BE GREATER THAN 2. +! +! MBDCND +! INDICATES THE TYPE OF BOUNDARY CONDITIONS +! AT R = A AND R = B. +! +! = 1 IF THE SOLUTION IS SPECIFIED AT R = A +! (SEE NOTE BELOW) AND R = B. +! +! = 2 IF THE SOLUTION IS SPECIFIED AT R = A +! (SEE NOTE BELOW) AND THE DERIVATIVE +! OF THE SOLUTION WITH RESPECT TO R IS +! SPECIFIED AT R = B. +! +! = 3 IF THE DERIVATIVE OF THE SOLUTION +! WITH RESPECT TO R IS SPECIFIED AT +! R = A (SEE NOTE BELOW) AND R = B. +! +! = 4 IF THE DERIVATIVE OF THE SOLUTION +! WITH RESPECT TO R IS SPECIFIED AT +! R = A (SEE NOTE BELOW) AND THE +! SOLUTION IS SPECIFIED AT R = B. +! +! = 5 IF THE SOLUTION IS UNSPECIFIED AT +! R = A = 0 AND THE SOLUTION IS +! SPECIFIED AT R = B. +! +! = 6 IF THE SOLUTION IS UNSPECIFIED AT +! R = A = 0 AND THE DERIVATIVE OF THE +! SOLUTION WITH RESPECT TO R IS SPECIFIED +! AT R = B. +! +! NOTE: +! IF A = 0, DO NOT USE MBDCND = 1,2,3, OR 4, +! BUT INSTEAD USE MBDCND = 5 OR 6. +! THE RESULTING APPROXIMATION GIVES THE ONLY +! MEANINGFUL BOUNDARY CONDITION, +! I.E. DU/DR = 0. +! (SEE D. GREENSPAN, 'INTRODUCTORY NUMERICAL +! ANALYSIS OF ELLIPTIC BOUNDARY VALUE +! PROBLEMS,' HARPER AND ROW, 1965, CHAPTER 5.) +! +! BDA +! A ONE-DIMENSIONAL ARRAY OF LENGTH N THAT +! SPECIFIES THE BOUNDARY VALUES (IF ANY) +! OF THE SOLUTION AT R = A. +! +! WHEN MBDCND = 1 OR 2, +! BDA(J) = U(A,Z(J)) , J=1,2,...,N. +! +! WHEN MBDCND = 3 OR 4, +! BDA(J) = (D/DR)U(A,Z(J)) , J=1,2,...,N. +! +! WHEN MBDCND = 5 OR 6, BDA IS A DUMMY +! VARIABLE. +! +! BDB +! A ONE-DIMENSIONAL ARRAY OF LENGTH N THAT +! SPECIFIES THE BOUNDARY VALUES OF THE +! SOLUTION AT R = B. +! +! WHEN MBDCND = 1,4,OR 5, +! BDB(J) = U(B,Z(J)) , J=1,2,...,N. +! +! WHEN MBDCND = 2,3, OR 6, +! BDB(J) = (D/DR)U(B,Z(J)) , J=1,2,...,N. +! +! C,D +! THE RANGE OF Z, I.E. C .LE. Z .LE. D. +! C MUST BE LESS THAN D. +! +! N +! THE NUMBER OF UNKNOWNS IN THE INTERVAL +! (C,D). THE UNKNOWNS IN THE Z-DIRECTION +! ARE GIVEN BY Z(J) = C + (J-0.5)DZ, +! J=1,2,...,N, WHERE DZ = (D-C)/N. +! N MUST BE GREATER THAN 2. +! +! NBDCND +! INDICATES THE TYPE OF BOUNDARY CONDITIONS +! AT Z = C AND Z = D. +! +! = 0 IF THE SOLUTION IS PERIODIC IN Z, I.E. +! U(I,J) = U(I,N+J). +! +! = 1 IF THE SOLUTION IS SPECIFIED AT Z = C +! AND Z = D. +! +! = 2 IF THE SOLUTION IS SPECIFIED AT Z = C +! AND THE DERIVATIVE OF THE SOLUTION WITH +! RESPECT TO Z IS SPECIFIED AT Z = D. +! +! = 3 IF THE DERIVATIVE OF THE SOLUTION WITH +! RESPECT TO Z IS SPECIFIED AT Z = C +! AND Z = D. +! +! = 4 IF THE DERIVATIVE OF THE SOLUTION WITH +! RESPECT TO Z IS SPECIFIED AT Z = C AND +! THE SOLUTION IS SPECIFIED AT Z = D. +! +! BDC +! A ONE DIMENSIONAL ARRAY OF LENGTH M THAT +! SPECIFIES THE BOUNDARY VALUES OF THE +! SOLUTION AT Z = C. +! +! WHEN NBDCND = 1 OR 2, +! BDC(I) = U(R(I),C) , I=1,2,...,M. +! +! WHEN NBDCND = 3 OR 4, +! BDC(I) = (D/DZ)U(R(I),C), I=1,2,...,M. +! +! WHEN NBDCND = 0, BDC IS A DUMMY VARIABLE. +! +! BDD +! A ONE-DIMENSIONAL ARRAY OF LENGTH M THAT +! SPECIFIES THE BOUNDARY VALUES OF THE +! SOLUTION AT Z = D. +! +! WHEN NBDCND = 1 OR 4, +! BDD(I) = U(R(I),D) , I=1,2,...,M. +! +! WHEN NBDCND = 2 OR 3, +! BDD(I) = (D/DZ)U(R(I),D) , I=1,2,...,M. +! +! WHEN NBDCND = 0, BDD IS A DUMMY VARIABLE. +! +! ELMBDA +! THE CONSTANT LAMBDA IN THE MODIFIED +! HELMHOLTZ EQUATION. IF LAMBDA IS GREATER +! THAN 0, A SOLUTION MAY NOT EXIST. +! HOWEVER, HSTCYL WILL ATTEMPT TO FIND A +! SOLUTION. LAMBDA MUST BE ZERO WHEN +! MBDCND = 5 OR 6. +! +! F +! A TWO-DIMENSIONAL ARRAY THAT SPECIFIES +! THE VALUES OF THE RIGHT SIDE OF THE +! MODIFIED HELMHOLTZ EQUATION. +! FOR I=1,2,...,M AND J=1,2,...,N +! F(I,J) = F(R(I),Z(J)) . +! F MUST BE DIMENSIONED AT LEAST M X N. +! +! IDIMF +! THE ROW (OR FIRST) DIMENSION OF THE ARRAY +! F AS IT APPEARS IN THE PROGRAM CALLING +! HSTCYL. THIS PARAMETER IS USED TO SPECIFY +! THE VARIABLE DIMENSION OF F. IDIMF MUST +! BE AT LEAST M. +! +! ON OUTPUT +! +! F +! CONTAINS THE SOLUTION U(I,J) OF THE FINITE +! DIFFERENCE APPROXIMATION FOR THE GRID POINT +! (R(I),Z(J)) FOR I=1,2,...,M, J=1,2,...,N. +! +! PERTRB +! IF A COMBINATION OF PERIODIC, DERIVATIVE, +! OR UNSPECIFIED BOUNDARY CONDITIONS IS +! SPECIFIED FOR A POISSON EQUATION +! (LAMBDA = 0), A SOLUTION MAY NOT EXIST. +! PERTRB IS A CONSTANT, CALCULATED AND +! SUBTRACTED FROM F, WHICH ENSURES THAT A +! SOLUTION EXISTS. HSTCYL THEN COMPUTES +! THIS SOLUTION, WHICH IS A LEAST SQUARES +! SOLUTION TO THE ORIGINAL APPROXIMATION. +! THIS SOLUTION PLUS ANY CONSTANT IS ALSO +! A SOLUTION; HENCE, THE SOLUTION IS NOT +! UNIQUE. THE VALUE OF PERTRB SHOULD BE +! SMALL COMPARED TO THE RIGHT SIDE F. +! OTHERWISE, A SOLUTION IS OBTAINED TO AN +! ESSENTIALLY DIFFERENT PROBLEM. +! THIS COMPARISON SHOULD ALWAYS BE MADE TO +! INSURE THAT A MEANINGFUL SOLUTION HAS BEEN +! OBTAINED. +! +! IERROR +! AN ERROR FLAG THAT INDICATES INVALID INPUT +! PARAMETERS. EXCEPT TO NUMBERS 0 AND 11, +! A SOLUTION IS NOT ATTEMPTED. +! +! = 0 NO ERROR +! +! = 1 A .LT. 0 +! +! = 2 A .GE. B +! +! = 3 MBDCND .LT. 1 OR MBDCND .GT. 6 +! +! = 4 C .GE. D +! +! = 5 N .LE. 2 +! +! = 6 NBDCND .LT. 0 OR NBDCND .GT. 4 +! +! = 7 A = 0 AND MBDCND = 1,2,3, OR 4 +! +! = 8 A .GT. 0 AND MBDCND .GE. 5 +! +! = 9 M .LE. 2 +! +! = 10 IDIMF .LT. M +! +! = 11 LAMBDA .GT. 0 +! +! = 12 A=0, MBDCND .GE. 5, ELMBDA .NE. 0 +! +! SINCE THIS IS THE ONLY MEANS OF INDICATING +! A POSSIBLY INCORRECT CALL TO HSTCYL, THE +! USER SHOULD TEST IERROR AFTER THE CALL. +! +! = 20 If the dynamic allocation of real and +! complex work space required for solution +! fails (for example if N,M are too large +! for your computer) +! I/O NONE +! +! PRECISION SINGLE +! +! REQUIRED LIBRARY fish.f,comf.f,genbun.f,gnbnaux.f,poistg.f +! FILES +! +! LANGUAGE FORTRAN 90 +! +! HISTORY WRITTEN BY ROLAND SWEET AT NCAR IN 1977. +! RELEASED ON NCAR'S PUBLIC SOFTWARE LIBRARIES +! IN JANUARY 1980. +! Revised in June 2004 by John Adams using +! Fortran 90 dynamically allocated work space. +! +! PORTABILITY FORTRAN 90 +! +! ALGORITHM THIS SUBROUTINE DEFINES THE FINITE-DIFFERENCE +! EQUATIONS, INCORPORATES BOUNDARY DATA, ADJUSTS +! THE RIGHT SIDE WHEN THE SYSTEM IS SINGULAR AND +! CALLS EITHER POISTG OR GENBUN WHICH SOLVES THE +! LINEAR SYSTEM OF EQUATIONS. +! +! TIMING FOR LARGE M AND N, THE OPERATION COUNT +! IS ROUGHLY PROPORTIONAL TO M*N*LOG2(N). +! +! ACCURACY THE SOLUTION PROCESS RESULTS IN A LOSS +! OF NO MORE THAN FOUR SIGNIFICANT DIGITS +! FOR N AND M AS LARGE AS 64. +! MORE DETAILED INFORMATION ABOUT ACCURACY +! CAN BE FOUND IN THE DOCUMENTATION FOR +! SUBROUTINE POISTG WHICH IS THE ROUTINE THAT +! ACTUALLY SOLVES THE FINITE DIFFERENCE +! EQUATIONS. +! +! REFERENCES U. SCHUMANN AND R. SWEET, "A DIRECT METHOD FOR +! THE SOLUTION OF POISSON'S EQUATION WITH NEUMANN +! BOUNDARY CONDITIONS ON A STAGGERED GRID OF +! ARBITRARY SIZE," J. COMP. PHYS. 20(1976), +! PP. 171-182. +!*********************************************************************** + SUBROUTINE HSTCYL(A, B, M, MBDCND, vecBDA, vecBDB, C, D, N, & + NBDCND, vecBDC, vecBDD, ELMBDA, matF, IDIMF, & + PERTRB, IERROR) + USE fish + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: M, MBDCND, N, NBDCND, IDIMF + INTEGER, INTENT(OUT) :: IERROR + DOUBLE PRECISION, INTENT(IN) :: A, B, C, D, ELMBDA + DOUBLE PRECISION, INTENT(OUT) :: PERTRB + DOUBLE PRECISION, DIMENSION(:), INTENT(IN) :: vecBDA, vecBDB, vecBDC, & + vecBDD + DOUBLE PRECISION, DIMENSION(IDIMF,N), INTENT(INOUT) :: matF +!----------------------------------------------- +! Allocatable arrays +!----------------------------------------------- + DOUBLE PRECISION,DIMENSION(:),ALLOCATABLE :: work +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: irwk, istatus +!----------------------------------------------- + ! JANNIS: add interface + interface + SUBROUTINE HSTCYLL(A, B, M, MBDCND, vecBDA, vecBDB, C, D, N, NBDCND, & + vecBDC, vecBDD, ELMBDA, matF, IDIMF, PERTRB, IERROR, W) + INTEGER, INTENT(IN) :: M, MBDCND, N, NBDCND, IDIMF + INTEGER, INTENT(OUT) :: IERROR + DOUBLE PRECISION, INTENT(IN) :: A, B, C, D, ELMBDA + DOUBLE PRECISION, INTENT(OUT) :: PERTRB + DOUBLE PRECISION, DIMENSION(M), INTENT(IN) :: vecBDA, vecBDB,vecBDC, & + vecBDD + DOUBLE PRECISION, DIMENSION(IDIMF,N), INTENT(INOUT) :: matF + DOUBLE PRECISION, DIMENSION(:), INTENT(OUT) :: W + end subroutine hstcyll + end interface + + IERROR = 0 + IF (A < ZERO) IERROR = 1 + IF (A >= B) IERROR = 2 + IF (MBDCND<=0 .OR. MBDCND>=7) IERROR = 3 + IF (C >= D) IERROR = 4 + IF (N <= 2) IERROR = 5 + IF (NBDCND<0 .OR. NBDCND>=5) IERROR = 6 + IF (A==ZERO .AND. MBDCND/=5 .AND. MBDCND/=6) IERROR = 7 + IF (A>ZERO .AND. MBDCND>=5) IERROR = 8 + IF (IDIMF < M) IERROR = 10 + IF (M <= 2) IERROR = 9 + IF (A==ZERO .AND. MBDCND>=5 .AND. ELMBDA/=ZERO) IERROR = 12 + IF (IERROR /= 0) RETURN +! allocate real work space +! compute and allocate required real work space + CALL GEN_SPACE (N, M, IRWK) + IRWK = IRWK + 3*M + allocate(work(irwK),STAT=istatus) +!@! write(*,*) 'HSTCYL: allocate work(irwk); irwk=',irwk +! return if allocation failed (e.g., if n,m are too large) + IF (istatus > 0) THEN + write(*,*) 'HSTCYL: error allocate work(irwk); irwk=',irwk + RETURN + END IF +! check that allocation was successful + call HSTCYLL(A, B, M, MBDCND, vecBDA, vecBDB, C, D, N, NBDCND, & + vecBDC, vecBDD, ELMBDA, matF, IDIMF, PERTRB, IERROR, work) +! release allocated work space +!@! write(*,*) 'HSTCYL: deallocate work(irwk); irwk=',irwk + deallocate(work,STAT=istatus) + IF (istatus > 0) THEN + write(*,*) 'HSTCYL: error deallocate work' + RETURN + END IF +! +! RETURN + END SUBROUTINE HSTCYL + + SUBROUTINE HSTCYLL(A, B, M, MBDCND, vecBDA, vecBDB, C, D, N, NBDCND, & + vecBDC, vecBDD, ELMBDA, matF, IDIMF, PERTRB, IERROR, W) + +! USE poisson +! USE genbunal + + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: M, MBDCND, N, NBDCND, IDIMF + INTEGER, INTENT(OUT) :: IERROR + DOUBLE PRECISION, INTENT(IN) :: A, B, C, D, ELMBDA + DOUBLE PRECISION, INTENT(OUT) :: PERTRB + DOUBLE PRECISION, DIMENSION(M), INTENT(IN) :: vecBDA, vecBDB,vecBDC, & + vecBDD + DOUBLE PRECISION, DIMENSION(IDIMF,N), INTENT(INOUT) :: matF + DOUBLE PRECISION, DIMENSION(:), INTENT(OUT) :: W +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: NP, IWB, IWC, IWR, I, J, K, LP, IERR1 + DOUBLE PRECISION :: DELTAR, DLRSQ, DELTHT, DLTHSQ, A1 +!----------------------------------------------- + DELTAR = (B - A)/DBLE(M) + DLRSQ = DELTAR**2 + DELTHT = (D - C)/DBLE(N) + DLTHSQ = DELTHT**2 + NP = NBDCND + 1 +! +! DEFINE A,B,C COEFFICIENTS IN W-ARRAY. +! + IWB = M + IWC = IWB + M + IWR = IWC + M + DO I = 1, M + J = IWR + I + W(J) = A + (DBLE(I) - HALF)*DELTAR + W(I) = (A + DBLE(I - 1)*DELTAR)/(DLRSQ*W(J)) + K = IWC + I + W(K) = (A + DBLE(I)*DELTAR)/(DLRSQ*W(J)) + K = IWB + I + W(K) = ELMBDA/W(J)**2 - TWO/DLRSQ + END DO +! +! ENTER BOUNDARY DATA FOR R-BOUNDARIES. +! + GO TO (102,102,104,104,106,106) MBDCND + 102 CONTINUE + A1 = TWO*W(1) + W(IWB+1) = W(IWB+1) - W(1) + matF(1,:N) = matF(1,:N) - A1*vecBDA(:N) + GO TO 106 + 104 CONTINUE + A1 = DELTAR*W(1) + W(IWB+1) = W(IWB+1) + W(1) + matF(1,:N) = matF(1,:N) + A1*vecBDA(:N) + 106 CONTINUE + GO TO (107,109,109,107,107,109) MBDCND + 107 CONTINUE + W(IWC) = W(IWC) - W(IWR) + A1 = TWO*W(IWR) + matF(M,:N) = matF(M,:N) - A1*vecBDB(:N) + GO TO 111 + 109 CONTINUE + W(IWC) = W(IWC) + W(IWR) + A1 = DELTAR*W(IWR) + matF(M,:N) = matF(M,:N) - A1*vecBDB(:N) +! +! ENTER BOUNDARY DATA FOR THETA-BOUNDARIES. +! + 111 CONTINUE + A1 = TWO/DLTHSQ + GO TO (121,112,112,114,114) NP + 112 CONTINUE + matF(:M,1) = matF(:M,1) - A1*vecBDC(:M) + GO TO 116 + 114 CONTINUE + A1 = ONE/DELTHT + matF(:M,1) = matF(:M,1) + A1*vecBDC(:M) + 116 CONTINUE + A1 = TWO/DLTHSQ + GO TO (121,117,119,119,117) NP + 117 CONTINUE + matF(:M,N) = matF(:M,N) - A1*vecBDD(:M) + GO TO 121 + 119 CONTINUE + A1 = ONE/DELTHT + matF(:M,N) = matF(:M,N) - A1*vecBDD(:M) + 121 CONTINUE + PERTRB = ZERO + IF (ELMBDA >= ZERO) THEN + IF (ELMBDA /= ZERO) THEN + IERROR = 11 + ELSE + GO TO (130,130,124,130,130,124) MBDCND + 124 CONTINUE + GO TO (125,130,130,125,130) NP + 125 CONTINUE + DO I = 1, M + A1 = ZERO + A1 = SUM(matF(I,:N)) + J = IWR + I + PERTRB = PERTRB + A1*W(J) + END DO + PERTRB = PERTRB/(DBLE(M*N)*HALF*(A + B)) + matF(:M,:N) = matF(:M,:N) - PERTRB + ENDIF + ENDIF + 130 CONTINUE + W(:M) = W(:M)*DLTHSQ + W(IWC+1:M+IWC) = W(IWC+1:M+IWC)*DLTHSQ + W(IWB+1:M+IWB) = W(IWB+1:M+IWB)*DLTHSQ + matF(:M,:N) = matF(:M,:N)*DLTHSQ + LP = NBDCND + W(1) = ZERO + W(IWR) = ZERO +! +! SOLVE THE SYSTEM OF EQUATIONS. +! + IERR1 = 0 + IF (NBDCND /= 0) THEN + CALL POISTGG (LP, N, 1, M, W(1:M), W(IWB+1:IWB+M), W(IWC+1:IWC+M), & + IDIMF, matF, IERR1, W(IWR+1:), SIZE(W)-IWR) + ELSE + CALL GENBUNN (LP, N, 1, M, W(1:M), W(IWB+1:IWB+M), W(IWC+1:IWC+M), & + IDIMF, matF, IERR1, W(IWR+1:), SIZE(W)-IWR) + ENDIF +! RETURN +! +! REVISION HISTORY--- +! +! SEPTEMBER 1973 VERSION 1 +! APRIL 1976 VERSION 2 +! JANUARY 1978 VERSION 3 +! DECEMBER 1979 VERSION 3.1 +! FEBRUARY 1985 DOCUMENTATION UPGRADE +! NOVEMBER 1988 VERSION 3.2, FORTRAN 77 CHANGES +! June 2004 Version 5.0, Fortran 90 changes +!----------------------------------------------------------------------- + END SUBROUTINE HSTCYLL +! +! file mhstcyl.f +! +! . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . +! . . +! . copyright (c) 2004 by UCAR . +! . . +! . UNIVERSITY CORPORATION for ATMOSPHERIC RESEARCH . +! . . +! . all rights reserved . +! . . +! . . +! . FISHPACK version 5.0 . +! . . +! . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . +! +! * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * +! * * +! * F I S H P A C K * +! * * +! * * +! * A PACKAGE OF FORTRAN SUBPROGRAMS FOR THE SOLUTION OF * +! * * +! * SEPARABLE ELLIPTIC PARTIAL DIFFERENTIAL EQUATIONS * +! * * +! * (Version 5.0 , JUNE 2004) * +! * * +! * BY * +! * * +! * JOHN ADAMS, PAUL SWARZTRAUBER AND ROLAND SWEET * +! * * +! * OF * +! * * +! * THE NATIONAL CENTER FOR ATMOSPHERIC RESEARCH * +! * * +! * BOULDER, COLORADO (80307) U.S.A. * +! * * +! * WHICH IS SPONSORED BY * +! * * +! * THE NATIONAL SCIENCE FOUNDATION * +! * * +! * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * +! +! SUBROUTINE MHSTCYL (A,B,M,MBDCND,BDA,BDB,C,D,N,NBDCND,BDC,BDD, +! + ELMBDA,ES,F,IDIMF,PERTRB,IERROR) +! +! DIMENSION OF BDA(N),BDB(N),BDC(M),BDD(M),F(IDIMF,N) +! ARGUMENTS +! +! LATEST REVISION June 2004 +! +! PURPOSE SOLVES THE STANDARD FIVE-POINT FINITE +! DIFFERENCE APPROXIMATION ON A STAGGERED +! GRID TO THE MODIFIED HELMHOLTZ EQUATION +! IN CYLINDRICAL COORDINATES. THIS EQUATION +! +! (D2U/DR2) + (D/DZ)(DU/DZ) +! +! + LAMBDA*(1/R**2)*U + ES * U = F(R,Z) +! +! IS A TWO-DIMENSIONAL MODIFIED HELMHOLTZ +! EQUATION RESULTING FROM THE FOURIER TRANSFORM +! OF A THREE-DIMENSIONAL POISSON EQUATION. +! +! USAGE CALL MHSTCYL (A,B,M,MBDCND,BDA,BDB,C,D,N, +! NBDCND,BDC,BDD,ELMBDA,ES,F,IDIMF, +! PERTRB,IERROR) +! +! ARGUMENTS +! ON INPUT A,B +! +! THE RANGE OF R, I.E. A .LE. R .LE. B. +! A MUST BE LESS THAN B AND A MUST BE +! BE NON-NEGATIVE. +! +! M +! THE NUMBER OF GRID POINTS IN THE INTERVAL +! (A,B). THE GRID POINTS IN THE R-DIRECTION +! R-DIRECTION ARE GIVEN BY +! R(I) = A + (I-0.5)DR FOR I=1,2,...,M +! WHERE DR =(B-A)/M. +! M MUST BE GREATER THAN 2. +! +! MBDCND +! INDICATES THE TYPE OF BOUNDARY CONDITIONS +! AT R = A AND R = B. +! +! = 1 IF THE SOLUTION IS SPECIFIED AT R = A +! (SEE NOTE BELOW) AND R = B. +! +! = 2 IF THE SOLUTION IS SPECIFIED AT R = A +! (SEE NOTE BELOW) AND THE DERIVATIVE +! OF THE SOLUTION WITH RESPECT TO R IS +! SPECIFIED AT R = B. +! +! = 3 IF THE DERIVATIVE OF THE SOLUTION +! WITH RESPECT TO R IS SPECIFIED AT +! R = A (SEE NOTE BELOW) AND R = B. +! +! = 4 IF THE DERIVATIVE OF THE SOLUTION +! WITH RESPECT TO R IS SPECIFIED AT +! R = A (SEE NOTE BELOW) AND THE +! SOLUTION IS SPECIFIED AT R = B. +! +! = 5 IF THE SOLUTION IS UNSPECIFIED AT +! R = A = 0 AND THE SOLUTION IS +! SPECIFIED AT R = B. +! +! = 6 IF THE SOLUTION IS UNSPECIFIED AT +! R = A = 0 AND THE DERIVATIVE OF THE +! SOLUTION WITH RESPECT TO R IS SPECIFIED +! AT R = B. +! +! NOTE: +! IF A = 0, DO NOT USE MBDCND = 1,2,3, OR 4, +! BUT INSTEAD USE MBDCND = 5 OR 6. +! THE RESULTING APPROXIMATION GIVES THE ONLY +! MEANINGFUL BOUNDARY CONDITION, +! I.E. DU/DR = 0. +! (SEE D. GREENSPAN, 'INTRODUCTORY NUMERICAL +! ANALYSIS OF ELLIPTIC BOUNDARY VALUE +! PROBLEMS,' HARPER AND ROW, 1965, CHAPTER 5.) +! +! BDA +! A ONE-DIMENSIONAL ARRAY OF LENGTH N THAT +! SPECIFIES THE BOUNDARY VALUES (IF ANY) +! OF THE SOLUTION AT R = A. +! +! WHEN MBDCND = 1 OR 2, +! BDA(J) = U(A,Z(J)) , J=1,2,...,N. +! +! WHEN MBDCND = 3 OR 4, +! BDA(J) = (D/DR)U(A,Z(J)) , J=1,2,...,N. +! +! WHEN MBDCND = 5 OR 6, BDA IS A DUMMY +! VARIABLE. +! +! BDB +! A ONE-DIMENSIONAL ARRAY OF LENGTH N THAT +! SPECIFIES THE BOUNDARY VALUES OF THE +! SOLUTION AT R = B. +! +! WHEN MBDCND = 1,4,OR 5, +! BDB(J) = U(B,Z(J)) , J=1,2,...,N. +! +! WHEN MBDCND = 2,3, OR 6, +! BDB(J) = (D/DR)U(B,Z(J)) , J=1,2,...,N. +! +! C,D +! THE RANGE OF Z, I.E. C .LE. Z .LE. D. +! C MUST BE LESS THAN D. +! +! N +! THE NUMBER OF UNKNOWNS IN THE INTERVAL +! (C,D). THE UNKNOWNS IN THE Z-DIRECTION +! ARE GIVEN BY Z(J) = C + (J-0.5)DZ, +! J=1,2,...,N, WHERE DZ = (D-C)/N. +! N MUST BE GREATER THAN 2. +! +! NBDCND +! INDICATES THE TYPE OF BOUNDARY CONDITIONS +! AT Z = C AND Z = D. +! +! = 0 IF THE SOLUTION IS PERIODIC IN Z, I.E. +! U(I,J) = U(I,N+J). +! +! = 1 IF THE SOLUTION IS SPECIFIED AT Z = C +! AND Z = D. +! +! = 2 IF THE SOLUTION IS SPECIFIED AT Z = C +! AND THE DERIVATIVE OF THE SOLUTION WITH +! RESPECT TO Z IS SPECIFIED AT Z = D. +! +! = 3 IF THE DERIVATIVE OF THE SOLUTION WITH +! RESPECT TO Z IS SPECIFIED AT Z = C +! AND Z = D. +! +! = 4 IF THE DERIVATIVE OF THE SOLUTION WITH +! RESPECT TO Z IS SPECIFIED AT Z = C AND +! THE SOLUTION IS SPECIFIED AT Z = D. +! +! BDC +! A ONE DIMENSIONAL ARRAY OF LENGTH M THAT +! SPECIFIES THE BOUNDARY VALUES OF THE +! SOLUTION AT Z = C. +! +! WHEN NBDCND = 1 OR 2, +! BDC(I) = U(R(I),C) , I=1,2,...,M. +! +! WHEN NBDCND = 3 OR 4, +! BDC(I) = (D/DZ)U(R(I),C), I=1,2,...,M. +! +! WHEN NBDCND = 0, BDC IS A DUMMY VARIABLE. +! +! BDD +! A ONE-DIMENSIONAL ARRAY OF LENGTH M THAT +! SPECIFIES THE BOUNDARY VALUES OF THE +! SOLUTION AT Z = D. +! +! WHEN NBDCND = 1 OR 4, +! BDD(I) = U(R(I),D) , I=1,2,...,M. +! +! WHEN NBDCND = 2 OR 3, +! BDD(I) = (D/DZ)U(R(I),D) , I=1,2,...,M. +! +! WHEN NBDCND = 0, BDD IS A DUMMY VARIABLE. +! +! ELMBDA +! THE CONSTANT LAMBDA IN THE MODIFIED +! HELMHOLTZ EQUATION. IF LAMBDA IS GREATER +! THAN 0, A SOLUTION MAY NOT EXIST. +! HOWEVER, MHSTCYL WILL ATTEMPT TO FIND A +! SOLUTION. LAMBDA MUST BE ZERO WHEN +! MBDCND = 5 OR 6. +! +! F +! A TWO-DIMENSIONAL ARRAY THAT SPECIFIES +! THE VALUES OF THE RIGHT SIDE OF THE +! MODIFIED HELMHOLTZ EQUATION. +! FOR I=1,2,...,M AND J=1,2,...,N +! F(I,J) = F(R(I),Z(J)) . +! F MUST BE DIMENSIONED AT LEAST M X N. +! +! IDIMF +! THE ROW (OR FIRST) DIMENSION OF THE ARRAY +! F AS IT APPEARS IN THE PROGRAM CALLING +! MHSTCYL. THIS PARAMETER IS USED TO SPECIFY +! THE VARIABLE DIMENSION OF F. IDIMF MUST +! BE AT LEAST M. +! +! ON OUTPUT +! +! F +! CONTAINS THE SOLUTION U(I,J) OF THE FINITE +! DIFFERENCE APPROXIMATION FOR THE GRID POINT +! (R(I),Z(J)) FOR I=1,2,...,M, J=1,2,...,N. +! +! PERTRB +! IF A COMBINATION OF PERIODIC, DERIVATIVE, +! OR UNSPECIFIED BOUNDARY CONDITIONS IS +! SPECIFIED FOR A POISSON EQUATION +! (LAMBDA = 0), A SOLUTION MAY NOT EXIST. +! PERTRB IS A CONSTANT, CALCULATED AND +! SUBTRACTED FROM F, WHICH ENSURES THAT A +! SOLUTION EXISTS. MHSTCYL THEN COMPUTES +! THIS SOLUTION, WHICH IS A LEAST SQUARES +! SOLUTION TO THE ORIGINAL APPROXIMATION. +! THIS SOLUTION PLUS ANY CONSTANT IS ALSO +! A SOLUTION; HENCE, THE SOLUTION IS NOT +! UNIQUE. THE VALUE OF PERTRB SHOULD BE +! SMALL COMPARED TO THE RIGHT SIDE F. +! OTHERWISE, A SOLUTION IS OBTAINED TO AN +! ESSENTIALLY DIFFERENT PROBLEM. +! THIS COMPARISON SHOULD ALWAYS BE MADE TO +! INSURE THAT A MEANINGFUL SOLUTION HAS BEEN +! OBTAINED. +! +! IERROR +! AN ERROR FLAG THAT INDICATES INVALID INPUT +! PARAMETERS. EXCEPT TO NUMBERS 0 AND 11, +! A SOLUTION IS NOT ATTEMPTED. +! +! = 0 NO ERROR +! +! = 1 A .LT. 0 +! +! = 2 A .GE. B +! +! = 3 MBDCND .LT. 1 OR MBDCND .GT. 6 +! +! = 4 C .GE. D +! +! = 5 N .LE. 2 +! +! = 6 NBDCND .LT. 0 OR NBDCND .GT. 4 +! +! = 7 A = 0 AND MBDCND = 1,2,3, OR 4 +! +! = 8 A .GT. 0 AND MBDCND .GE. 5 +! +! = 9 M .LE. 2 +! +! = 10 IDIMF .LT. M +! +! = 11 LAMBDA .GT. 0 +! +! = 12 A=0, MBDCND .GE. 5, ELMBDA .NE. 0 +! +! SINCE THIS IS THE ONLY MEANS OF INDICATING +! A POSSIBLY INCORRECT CALL TO MHSTCYL, THE +! USER SHOULD TEST IERROR AFTER THE CALL. +! +! = 20 If the dynamic allocation of real and +! complex work space required for solution +! fails (for example if N,M are too large +! for your computer) +! I/O NONE +! +! PRECISION SINGLE +! +! REQUIRED LIBRARY fish.f,comf.f,genbun.f,gnbnaux.f,poistg.f +! FILES +! +! LANGUAGE FORTRAN 90 +! +! HISTORY WRITTEN BY ROLAND SWEET AT NCAR IN 1977. +! RELEASED ON NCAR'S PUBLIC SOFTWARE LIBRARIES +! IN JANUARY 1980. +! Revised in June 2004 by John Adams using +! Fortran 90 dynamically allocated work space. +! +! PORTABILITY FORTRAN 90 +! +! ALGORITHM THIS SUBROUTINE DEFINES THE FINITE-DIFFERENCE +! EQUATIONS, INCORPORATES BOUNDARY DATA, ADJUSTS +! THE RIGHT SIDE WHEN THE SYSTEM IS SINGULAR AND +! CALLS EITHER POISTG OR GENBUN WHICH SOLVES THE +! LINEAR SYSTEM OF EQUATIONS. +! +! TIMING FOR LARGE M AND N, THE OPERATION COUNT +! IS ROUGHLY PROPORTIONAL TO M*N*LOG2(N). +! +! ACCURACY THE SOLUTION PROCESS RESULTS IN A LOSS +! OF NO MORE THAN FOUR SIGNIFICANT DIGITS +! FOR N AND M AS LARGE AS 64. +! MORE DETAILED INFORMATION ABOUT ACCURACY +! CAN BE FOUND IN THE DOCUMENTATION FOR +! SUBROUTINE POISTG WHICH IS THE ROUTINE THAT +! ACTUALLY SOLVES THE FINITE DIFFERENCE +! EQUATIONS. +! +! REFERENCES U. SCHUMANN AND R. SWEET, "A DIRECT METHOD FOR +! THE SOLUTION OF POISSON'S EQUATION WITH NEUMANN +! BOUNDARY CONDITIONS ON A STAGGERED GRID OF +! ARBITRARY SIZE," J. COMP. PHYS. 20(1976), +! PP. 171-182. +!*********************************************************************** + SUBROUTINE MHSTCYL(A, B, M, MBDCND, vecBDA, vecBDB, C, D, & + N, NBDCND, vecBDC, vecBDD, ELMBDA, ES, & + matF, IDIMF, PERTRB, IERROR) + USE fish + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: M, MBDCND, N, NBDCND, IDIMF + INTEGER, INTENT(OUT) :: IERROR + DOUBLE PRECISION, INTENT(IN) :: A, B, C, D, ELMBDA, ES + DOUBLE PRECISION, INTENT(OUT) :: PERTRB + DOUBLE PRECISION, DIMENSION(N), INTENT(IN) :: vecBDA, vecBDB + DOUBLE PRECISION, DIMENSION(M), INTENT(IN) :: vecBDC, vecBDD + DOUBLE PRECISION, DIMENSION(IDIMF,N), INTENT(OUT) :: matF +!----------------------------------------------- +! Allocatable arrays +!----------------------------------------------- + DOUBLE PRECISION,DIMENSION(:),ALLOCATABLE :: work +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: irwk, istatus +!----------------------------------------------- + IERROR = 0 + IF (A < ZERO) IERROR = 1 + IF (A >= B) IERROR = 2 + IF (MBDCND<=0 .OR. MBDCND>=7) IERROR = 3 + IF (C >= D) IERROR = 4 + IF (N <= 2) IERROR = 5 + IF (NBDCND<0 .OR. NBDCND>=5) IERROR = 6 +!Mod IF (A==ZERO .AND. MBDCND/=5 .AND. MBDCND/=6) IERROR = 7 + IF (A>ZERO .AND. MBDCND>=5) IERROR = 8 + IF (IDIMF < M) IERROR = 10 + IF (M <= 2) IERROR = 9 +!Mod IF (A==ZERO .AND. MBDCND>=5 .AND. ELMBDA/=ZERO) IERROR = 12 + IF (IERROR /= 0) RETURN +! allocate real work space +! compute and allocate required real work space + CALL GEN_SPACE (N, M, IRWK) + IRWK = IRWK + 3*M +!@! write(*,*) 'MHSTCYL: allocate work(irwk); irwk=',irwk + allocate(work(irwk),STAT=istatus) +! return if allocation failed (e.g., if n,m are too large) + IF (istatus > 0) THEN + write(*,*) 'HSTCRT: error allocate work(irwk); irwk=',irwk + RETURN + END IF + call MHSTCYLL(A, B, M, MBDCND, vecBDA, vecBDB, C, D, N, NBDCND, & + vecBDC, vecBDD, ELMBDA, ES, matF, IDIMF, PERTRB, & + IERROR, work, IRWK ) +! release allocated work space +!@! write(*,*) 'MHSTCYL: deallocate work(irwk); irwk=',irwk + deallocate(work,STAT=istatus) + IF (istatus > 0) THEN + write(*,*) 'MHSTCYL: error deallocate work' + RETURN + END IF +! + END SUBROUTINE MHSTCYL + + SUBROUTINE MHSTCYLL(A, B, M, MBDCND, vecBDA, vecBDB, C, D, N, NBDCND, & + vecBDC, vecBDD, ELMBDA, ES, matF, IDIMF, & + PERTRB, IERROR, W, IW) +! USE genbunal +! USE poisson + + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: M, MBDCND, N, NBDCND, IDIMF, IW + INTEGER, INTENT(OUT) :: IERROR + DOUBLE PRECISION, INTENT(IN) :: A, B, C, D, ELMBDA, ES + DOUBLE PRECISION, INTENT(OUT) :: PERTRB + DOUBLE PRECISION, DIMENSION(N), INTENT(IN) :: vecBDA, vecBDB + DOUBLE PRECISION, DIMENSION(M), INTENT(IN) :: vecBDC, vecBDD + DOUBLE PRECISION, DIMENSION(IDIMF,N), INTENT(OUT) :: matF + DOUBLE PRECISION, DIMENSION(IW), INTENT(INOUT) :: W +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: NP, IWB, IWC, IWR, I, J, K, LP, IERR1 + DOUBLE PRECISION :: DELTAR, DLRSQ, DELTHT, DLTHSQ, A1 +!----------------------------------------------- + DELTAR = (B - A)/DBLE(M) + DLRSQ = DELTAR**2 + DELTHT = (D - C)/DBLE(N) + DLTHSQ = DELTHT**2 + NP = NBDCND + 1 +! +! DEFINE A,B,C COEFFICIENTS IN W-ARRAY. +! + IWB = M + IWC = IWB + M + IWR = IWC + M + DO I = 1, M + J = IWR + I + W(J) = A + (DBLE(I) - HALF)*DELTAR + W(I) = (W(J) - HALF * DELTAR)/(DLRSQ*W(J)) + K = IWC + I + W(K) = (W(J) + HALF * DELTAR)/(DLRSQ*W(J)) + K = IWB + I + W(K) = ELMBDA/W(J)**2 + ES - TWO/DLRSQ + END DO +! +! ENTER BOUNDARY DATA FOR R-BOUNDARIES. +! + GO TO (102,102,104,104,106,106) MBDCND + 102 CONTINUE + A1 = TWO*W(1) + W(IWB+1) = W(IWB+1) - W(1) + matF(1,:N) = matF(1,:N) - A1*vecBDA(:N) + GO TO 106 + 104 CONTINUE + A1 = DELTAR*W(1) + W(IWB+1) = W(IWB+1) + W(1) + matF(1,:N) = matF(1,:N) + A1*vecBDA(:N) + 106 CONTINUE + GO TO (107,109,109,107,107,109) MBDCND + 107 CONTINUE + W(IWC) = W(IWC) - W(IWR) + A1 = TWO*W(IWR) + matF(M,:N) = matF(M,:N) - A1*vecBDB(:N) + GO TO 111 + 109 CONTINUE + W(IWC) = W(IWC) + W(IWR) + A1 = DELTAR*W(IWR) + matF(M,:N) = matF(M,:N) - A1*vecBDB(:N) +! +! ENTER BOUNDARY DATA FOR THETA-BOUNDARIES. +! + 111 CONTINUE + A1 = TWO/DLTHSQ + GO TO (121,112,112,114,114) NP + 112 CONTINUE + matF(:M,1) = matF(:M,1) - A1*vecBDC(:M) + GO TO 116 + 114 CONTINUE + A1 = ONE/DELTHT + matF(:M,1) = matF(:M,1) + A1*vecBDC(:M) + 116 CONTINUE + A1 = TWO/DLTHSQ + GO TO (121,117,119,119,117) NP + 117 CONTINUE + matF(:M,N) = matF(:M,N) - A1*vecBDD(:M) + GO TO 121 + 119 CONTINUE + A1 = ONE/DELTHT + matF(:M,N) = matF(:M,N) - A1*vecBDD(:M) + 121 CONTINUE + PERTRB = ZERO + IF (ELMBDA >= ZERO) THEN + IF (ELMBDA /= ZERO) THEN + IERROR = 11 + ELSE + GO TO (130,130,124,130,130,124) MBDCND + 124 CONTINUE + GO TO (125,130,130,125,130) NP + 125 CONTINUE + DO I = 1, M + A1 = ZERO + A1 = SUM(matF(I,:N)) + J = IWR + I + PERTRB = PERTRB + A1*W(J) + END DO + PERTRB = PERTRB/(DBLE(M*N)*HALF*(A + B)) + matF(:M,:N) = matF(:M,:N) - PERTRB + ENDIF + ENDIF + 130 CONTINUE + W(:M) = W(:M)*DLTHSQ + W(IWC+1:M+IWC) = W(IWC+1:M+IWC)*DLTHSQ + W(IWB+1:M+IWB) = W(IWB+1:M+IWB)*DLTHSQ + matF(:M,:N) = matF(:M,:N)*DLTHSQ + LP = NBDCND + W(1) = ZERO + W(IWR) = ZERO +! +! SOLVE THE SYSTEM OF EQUATIONS. +! + IERR1 = 0 + IF (NBDCND /= 0) THEN + CALL POISTGG (LP, N, 1, M, W, W(IWB+1:IWB+M), W(IWC+1:IWC+M), & + IDIMF, matF,IERR1, W(IWR+1:), size(W)-IWR) + ELSE + CALL GENBUNN (LP, N, 1, M, W, W(IWB+1:IWB+M), W(IWC+1:IWC+M), & + IDIMF, matF,IERR1, W(IWR+1:), size(W)-IWR) + ENDIF +! +! REVISION HISTORY--- +! +! SEPTEMBER 1973 VERSION 1 +! APRIL 1976 VERSION 2 +! JANUARY 1978 VERSION 3 +! DECEMBER 1979 VERSION 3.1 +! FEBRUARY 1985 DOCUMENTATION UPGRADE +! NOVEMBER 1988 VERSION 3.2, FORTRAN 77 CHANGES +! June 2004 Version 5.0, Fortran 90 changes +! February 2009 Modified version of HSTCYL +!----------------------------------------------------------------------- + END SUBROUTINE MHSTCYLL diff --git a/fish90/src/hstcrt_wrap.c b/fish90/src/hstcrt_wrap.c new file mode 100644 index 0000000000000000000000000000000000000000..e69de29bb2d1d6434b8b29ae775ad8c2e48c5391 diff --git a/fish90/src/hstcyl_wrap.c b/fish90/src/hstcyl_wrap.c new file mode 100644 index 0000000000000000000000000000000000000000..7caf2fb6776ff0a6212385e8cc2e40298913c73d --- /dev/null +++ b/fish90/src/hstcyl_wrap.c @@ -0,0 +1,78 @@ +/* Wrapper for the HSTCYL function. + Alejandro Luque Estepa - 2006 +*/ + +#include "stdlib.h" +#include "stdio.h" +#include "../include/fishpack.h" +#include "math.h" +#include "assert.h" + +const char *hstcyl_error_str[FISH_ERROR_MAX] = + {"No error", + "A .LT. 0", + "A .GE. B", + "MBDCND .LT. 1 OR MBDCND .GT. 6", + "C .GE. D", + "N .LE. 2", + "NBDCND .LT. 0 OR NBDCND .GT. 4", + "A = 0 AND MBDCND = 1,2,3, OR 4", + "A .GT. 0 AND MBDCND .GE. 5", + "M .LE. 2", + "IDIMF .LT. M", + "LAMBDA .GT. 0", + "A=0, MBDCND .GE. 5, ELMBDA .NE. 0"}; + +int number=0; + +void mhstcyl_(double *r0, double *r1, int *nr, int *rbndcnd, + double *bcr0, double *bcr1, + double *z0, double *z1, int *nz, int *zbndcnd, + double *bcz0, double *bcz1, + double *lambda, double *s, double *f, + int *idimf, double *pertrb, int *ierror); + +/* Calls hstcyl and checks for errors. If an error occurs, prints the + corresponding message and exists. */ +void +fish_hstcyl (double r0, double r1, int nr, + int rbndcnd, double *bcr0, double *bcr1, + double z0, double z1, int nz, + int zbndcnd, double *bcz0, double *bcz1, + double lambda, double s, double *f, int idimf) +{ + double pertrb; + int ierror; + + mhstcyl_(&r0, &r1, &nr, &rbndcnd, bcr0, bcr1, + &z0, &z1, &nz, &zbndcnd, bcz0, bcz1, + &lambda, &s, f, &idimf, &pertrb, &ierror); + number+=1; + +/* fprintf(stderr, "# calls mhstcyl =%d\n",number); */ + if (pertrb != 0.0) { + fprintf (stderr, "%s: ERROR: Undefined solution to the Poisson equation.", + __func__); + fprintf (stderr, "\nTry to change your boundary conditions.\n"); + exit(-1); + } + + if (0 != ierror) { + if (ierror <= FISH_ERROR_MAX) { + fprintf (stderr, "%s: ERROR: %s\n", __func__, hstcyl_error_str[ierror]); + fprintf (stderr, "The call to fishpack was\n"); + fprintf (stderr, "mhstcyl_ (A = %f, B = %f, M = %d,\n", r0, r1, nr); + fprintf (stderr, " MBDCND = %d, ...\n", rbndcnd); + fprintf (stderr, " C = %f, D = %f, N = %d,\n", z0, z1, nz); + fprintf (stderr, " NBDCND = %d, ...\n", zbndcnd); + fprintf (stderr, " ELMBDA = %f, ...\n", lambda); + fprintf (stderr, " ES = %f, ...\n", s); + fprintf (stderr, " IDIMF = %d, ...)\n", idimf); + } else { + fprintf (stderr, "%s: Unknown error #%d\n", __func__, ierror); + } + + exit(-1); + } +} + diff --git a/fish90/src/poisson.f90 b/fish90/src/poisson.f90 new file mode 100644 index 0000000000000000000000000000000000000000..57f8b42e6808d4819133a77e11a3325dec07701c --- /dev/null +++ b/fish90/src/poisson.f90 @@ -0,0 +1,608 @@ + SUBROUTINE POISTGG(NPEROD,N,MPEROD,M,vecA,vecB,vecC,IDIMY,matY, & + IERROR,W,IW) + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: NPEROD, N, MPEROD, M, IDIMY,IW + INTEGER, INTENT(OUT) :: IERROR + DOUBLE PRECISION, DIMENSION(M), INTENT(IN) :: vecA,vecB,vecC + DOUBLE PRECISION, DIMENSION(IDIMY,N),INTENT(INOUT) :: matY + DOUBLE PRECISION, DIMENSION(IW) :: W +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: IWBA, IWBB, IWBC, IWB2, IWB3, IWW1, IWW2, IWW3, & + IWD,IWTCOS, IWP, I, K, J, NP, MP, IPSTOR, & + IREV, MH, MHM1, MODD, NBY2, MSKIP + DOUBLE PRECISION :: A1 +!----------------------------------------------- + IERROR = 0 + + IWBA = M + 1 + IWBB = IWBA + M + IWBC = IWBB + M + IWB2 = IWBC + M + IWB3 = IWB2 + M + IWW1 = IWB3 + M + IWW2 = IWW1 + M + IWW3 = IWW2 + M + IWD = IWW3 + M + IWTCOS = IWD + M + IWP = IWTCOS + 4*N + DO I = 1, M + K = IWBA + I - 1 + ! write(*,*) '0: i,k:',i,k + ! write(*,*) '0: vecA(I):',vecA(I) + W(K) = -vecA(I) + ! write(*,*) 'A: i,k,w(k):',i,k,w(k) + K = IWBC + I - 1 + W(K) = -vecC(I) + ! write(*,*) 'B: i,k,w(k):',i,k,w(k) + K = IWBB + I - 1 + W(K) = TWO - vecB(I) + ! write(*,*) 'C: i,k,w(k):',i,k,w(k) + matY(I,:N) = -matY(I,:N) + ! write(*,*) 'D: Y(i,:N):',Y(I,:N) + END DO + NP = NPEROD + MP = MPEROD + 1 + GO TO (110,107) MP + 107 CONTINUE + GO TO (108,108,108,119) NPEROD + 108 CONTINUE + CALL POSTG2 (NP, N, M, W(IWBA:IWBA+M-1), W(IWBB:IWBB+M-1), & + W(IWBC:IWBC+M-1), IDIMY, matY, W(1:M), W(IWB2:IWB2+M-1), & + W(IWB3:IWB3+M-1), W(IWW1:IWW1+M-1), W(IWW2:IWW2+M-1), & + W(IWW3:IWW3+M-1), W(IWD:IWD+M-1), W(IWTCOS:IWTCOS+4*N-1), & + W(IWP:),IW-IWP) + IPSTOR = W(IWW1) + IREV = 2 + IF (NPEROD == 4) GO TO 120 + 109 CONTINUE + GO TO (123,129) MP + 110 CONTINUE + MH = (M + 1)/2 + MHM1 = MH - 1 + MODD = 1 + IF (MH*2 == M) MODD = 2 + DO J = 1, N + DO I = 1, MHM1 + W(I) = matY(MH-I,J) - matY(I+MH,J) + W(I+MH) = matY(MH-I,J) + matY(I+MH,J) + END DO + W(MH) = TWO*matY(MH,J) + GO TO (113,112) MODD + 112 CONTINUE + W(M) = TWO*matY(M,J) + 113 CONTINUE + matY(:M,J) = W(:M) + END DO + K = IWBC + MHM1 - 1 + I = IWBA + MHM1 + W(K) = 0. + W(I) = 0. + W(K+1) = TWO*W(K+1) + SELECT CASE (MODD) + CASE DEFAULT + K = IWBB + MHM1 - 1 + W(K) = W(K) - W(I-1) + W(IWBC-1) = W(IWBC-1) + W(IWBB-1) + CASE (2) + W(IWBB-1) = W(K+1) + END SELECT + GO TO 107 + 119 CONTINUE + IREV = 1 + NBY2 = N/2 + NP = 2 + 120 CONTINUE + DO J = 1, NBY2 + MSKIP = N + 1 - J + DO I = 1, M + A1 = matY(I,J) + matY(I,J) = matY(I,MSKIP) + matY(I,MSKIP) = A1 + END DO + END DO + GO TO (108,109) IREV + 123 CONTINUE + DO J = 1, N + W(MH-1:MH-MHM1:(-1)) = HALF*(matY(MH+1:MHM1+MH,J)+matY(:MHM1,J)) + W(MH+1:MHM1+MH) = HALF*(matY(MH+1:MHM1+MH,J)-matY(:MHM1,J)) + W(MH) = HALF*matY(MH,J) + GO TO (126,125) MODD + 125 CONTINUE + W(M) = HALF*matY(M,J) + 126 CONTINUE + matY(:M,J) = W(:M) + END DO + 129 CONTINUE + W(1) = IPSTOR + IWP - 1 +! + END SUBROUTINE POISTGG + + SUBROUTINE POSTG2(NPEROD, N, M, vecA, vecBB, vecC, IDIMQ, matQ, & + vecB, vecB2, vecB3, vecW,vecW2, vecW3, vecD, & + TCOS, vecP,IvecP) + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER , INTENT(IN) :: NPEROD,N,M,IDIMQ,IvecP + DOUBLE PRECISION, DIMENSION(M),INTENT(IN) :: vecA,vecBB,vecC + DOUBLE PRECISION, DIMENSION(M),INTENT(OUT) :: vecB + DOUBLE PRECISION, DIMENSION(IDIMQ,N),INTENT(INOUT) :: matQ + DOUBLE PRECISION, DIMENSION(M),INTENT(INOUT) :: vecB2,vecB3,vecD, & + vecW2,vecW3, vecW + DOUBLE PRECISION, DIMENSION(IvecP),INTENT(INOUT) :: vecP + DOUBLE PRECISION, DIMENSION(4*N),INTENT(INOUT) :: TCOS +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER, DIMENSION(4) :: K + INTEGER :: K1, K2, K3, K4, NP, MR, IP, IPSTOR, I2R, JR, NR, NLAST, & + KR, LR, NROD, JSTART, JSTOP, I2RBY2, & + J, IJUMP, JP1, JP2, JP3, JM1, JM2, JM3, I, NRODPR, II, & + NLASTP, JSTEP + DOUBLE PRECISION :: FNUM, FNUM2, FI, T +!----------------------------------------------- +! +! SUBROUTINE TO SOLVE POISSON'S EQUATION ON A STAGGERED GRID. +! + EQUIVALENCE (K(1), K1), (K(2), K2), (K(3), K3), (K(4), K4) + NP = NPEROD + FNUM = HALF*DBLE(NP/3) + FNUM2 = HALF*DBLE(NP/2) + MR = M + IP = -MR + IPSTOR = 0 + I2R = 1 + JR = 2 + NR = N + NLAST = N + KR = 1 + LR = 0 + IF (NR > 3) THEN + 101 CONTINUE + JR = 2*I2R + NROD = 1 + IF ((NR/2)*2 == NR) NROD = 0 + JSTART = 1 + JSTOP = NLAST - JR + IF (NROD == 0) JSTOP = JSTOP - I2R + I2RBY2 = I2R/2 + IF (JSTOP < JSTART) THEN + J = JR + ELSE + IJUMP = 1 + DO J = JSTART, JSTOP, JR + JP1 = J + I2RBY2 + JP2 = J + I2R + JP3 = JP2 + I2RBY2 + JM1 = J - I2RBY2 + JM2 = J - I2R + JM3 = JM2 - I2RBY2 + IF (J == 1) THEN + CALL COSGEN (I2R, 1, FNUM, HALF, TCOS, size(TCOS) ) + IF (I2R == 1) THEN + vecB(:MR) = matQ(:MR,1) + matQ(:MR,1) = matQ(:MR,2) + GO TO 112 + ENDIF + vecB(:MR) = matQ(:MR,1) + & + HALF*(matQ(:MR,JP2)-matQ(:MR,JP1)-matQ(:MR,JP3)) + matQ(:MR,1) = matQ(:MR,JP2) + matQ(:MR,1) - matQ(:MR,JP1) + GO TO 112 + ENDIF + GO TO (107,108) IJUMP + 107 CONTINUE + IJUMP = 2 + CALL COSGEN (I2R, 1, HALF, ZERO, TCOS, size(TCOS) ) + 108 CONTINUE + IF (I2R == 1) THEN + vecB(:MR) = TWO*matQ(:MR,J) + matQ(:MR,J) = matQ(:MR,JM2) + matQ(:MR,JP2) + ELSE + DO I = 1, MR + FI = matQ(I,J) + matQ(I,J)=matQ(I,J)-matQ(I,JM1)-matQ(I,JP1)+ & + matQ(I,JM2)+matQ(I,JP2) + vecB(I) =FI + matQ(I,J) - matQ(I,JM3) - matQ(I,JP3) + END DO + ENDIF + 112 CONTINUE + CALL TRIX (I2R, 0, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + matQ(:MR,J) = matQ(:MR,J) + vecB(:MR) +! +! END OF REDUCTION FOR REGULAR UNKNOWNS. +! + END DO +! +! BEGIN SPECIAL REDUCTION FOR LAST UNKNOWN. +! + J = JSTOP + JR + ENDIF + NLAST = J + JM1 = J - I2RBY2 + JM2 = J - I2R + JM3 = JM2 - I2RBY2 + IF (NROD /= 0) THEN +! +! ODD NUMBER OF UNKNOWNS +! + IF (I2R == 1) THEN + vecB(:MR) = matQ(:MR,J) + matQ(:MR,J) = matQ(:MR,JM2) + ELSE + vecB(:MR)=matQ(:MR,J)+ & + HALF*(matQ(:MR,JM2)-matQ(:MR,JM1)-matQ(:MR,JM3)) + IF (NRODPR == 0) THEN + matQ(:MR,J) = matQ(:MR,JM2) + vecP(IP+1:MR+IP) + IP = IP - MR + ELSE + matQ(:MR,J) = matQ(:MR,J) - matQ(:MR,JM1) + matQ(:MR,JM2) + ENDIF + IF (LR /= 0) CALL COSGEN (LR, 1, FNUM2, HALF, TCOS(KR+1), & + size(tcos)-KR) + ENDIF + CALL COSGEN (KR, 1, FNUM2, HALF, TCOS, size(tcos)) + CALL TRIX (KR, LR, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + matQ(:MR,J) = matQ(:MR,J) + vecB(:MR) + KR = KR + I2R + ELSE + JP1 = J + I2RBY2 + JP2 = J + I2R + IF (I2R == 1) THEN + vecB(:MR) = matQ(:MR,J) + TCOS(1) = 0. + CALL TRIX (1, 0, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + IP = 0 + IPSTOR = MR + vecP(:MR) = vecB(:MR) + vecB(:MR) = vecB(:MR) + matQ(:MR,N) + TCOS(1) = -ONE + TWO*DBLE(NP/2) + TCOS(2) = 0. + CALL TRIX (1, 1, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + matQ(:MR,J) = matQ(:MR,JM2) + vecP(:MR) + vecB(:MR) + ELSE + vecB(:MR)=matQ(:MR,J)+ & + HALF*(matQ(:MR,JM2)-matQ(:MR,JM1)-matQ(:MR,JM3)) + IF (NRODPR == 0) THEN + vecB(:MR) = vecB(:MR) + vecP(IP+1:MR+IP) + ELSE + vecB(:MR) = vecB(:MR) + matQ(:MR,JP2) - matQ(:MR,JP1) + ENDIF + CALL COSGEN (I2R, 1, HALF, ZERO, TCOS, size(tcos)) + CALL TRIX (I2R, 0, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + IP = IP + MR + IPSTOR = MAX0(IPSTOR,IP + MR) + vecP(IP+1:MR+IP) = vecB(:MR) + & + HALF*(matQ(:MR,J)-matQ(:MR,JM1)-matQ(:MR,JP1)) + vecB(:MR) = vecP(IP+1:MR+IP) + matQ(:MR,JP2) + IF (LR /= 0) THEN + CALL COSGEN (LR, 1, FNUM2, HALF, TCOS(I2R+1), size(tcos)-I2R) + CALL MERGE (TCOS, 0, I2R, I2R, LR, KR, size(TCOS)) + ELSE + DO I = 1, I2R + II = KR + I + TCOS(II) = TCOS(I) + END DO + ENDIF + CALL COSGEN (KR, 1, FNUM2, HALF, TCOS, size(TCOS)) + CALL TRIX (KR, KR, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + matQ(:MR,J) = matQ(:MR,JM2) + vecP(IP+1:MR+IP) + vecB(:MR) + ENDIF + LR = KR + KR = KR + JR + ENDIF + NR = (NLAST - 1)/JR + 1 + IF (NR <= 3) GO TO 142 + I2R = JR + NRODPR = NROD + GO TO 101 + ENDIF ! IF (NR > 3) + 142 CONTINUE + J = 1 + JR + JM1 = J - I2R + JP1 = J + I2R + JM2 = NLAST - I2R + IF (NR /= 2) THEN + IF (LR == 0) THEN + IF (N == 3) THEN +! +! CASE N = 3. +! + GO TO (143,148,143) NP + 143 CONTINUE + vecB(:MR) = matQ(:MR,2) + vecB2(:MR) = matQ(:MR,1) + matQ(:MR,3) + vecB3(:MR) = 0. + SELECT CASE (NP) + CASE DEFAULT + TCOS(1) = -ONE + TCOS(2) = ONE + K1 = 1 + CASE (1:2) + TCOS(1) = -TWO + TCOS(2) = ONE + TCOS(3) = -ONE + K1 = 2 + END SELECT + K2 = 1 + K3 = 0 + K4 = 0 + GO TO 150 + 148 CONTINUE + vecB(:MR) = matQ(:MR,2) + vecB2(:MR) = matQ(:MR,3) + vecB3(:MR) = matQ(:MR,1) + CALL COSGEN (3, 1, HALF, ZERO, TCOS, size(TCOS)) + TCOS(4) = -ONE + TCOS(5) = ONE + TCOS(6) = -ONE + TCOS(7) = ONE + K1 = 3 + K2 = 2 + K3 = 1 + K4 = 1 + 150 CONTINUE + CALL TRI3(MR,vecA,vecBB,vecC,K,vecB,vecB2,vecB3,TCOS, & + size(TCOS),vecD,vecW,vecW2,vecW3) + vecB(:MR) = vecB(:MR) + vecB2(:MR) + vecB3(:MR) + GO TO (153,153,152) NP + 152 CONTINUE + TCOS(1) = TWO + CALL TRIX (1, 0, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + 153 CONTINUE + matQ(:MR,2) = vecB(:MR) + vecB(:MR) = matQ(:MR,1) + vecB(:MR) + TCOS(1) = -ONE + FOUR*FNUM + CALL TRIX (1, 0, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + matQ(:MR,1) = vecB(:MR) + JR = 1 + I2R = 0 + GO TO 188 + ENDIF +! +! CASE N = 2**P+1 +! + vecB(:MR)=matQ(:MR,J)+matQ(:MR,1)-matQ(:MR,JM1)+ & + matQ(:MR,NLAST)-matQ(:MR,JM2) + GO TO (158,160,158) NP + 158 CONTINUE + vecB2(:MR) = matQ(:MR,1) + matQ(:MR,NLAST) + & + matQ(:MR,J) - matQ(:MR,JM1) -matQ(:MR,JP1) + vecB3(:MR) = 0. + K1 = NLAST - 1 + K2 = NLAST + JR - 1 + CALL COSGEN (JR - 1, 1, ZERO, ONE, TCOS(NLAST), size(TCOS)-NLAST+1) + TCOS(K2) = TWO*DBLE(NP - 2) + CALL COSGEN (JR, 1, HALF - FNUM, HALF, TCOS(K2+1),size(TCOS)-K2) + K3 = (3 - NP)/2 + CALL MERGE (TCOS, K1, JR - K3, K2 - K3, JR + K3, 0, size(TCOS)) + K1 = K1 - 1 + K3 + CALL COSGEN (JR, 1, FNUM, HALF, TCOS(K1+1),size(TCOS)-K1) + K2 = JR + K3 = 0 + K4 = 0 + GO TO 162 + 160 CONTINUE + DO I = 1, MR + FI = HALF*(matQ(I,J)-matQ(I,JM1)-matQ(I,JP1)) + vecB2(I) = matQ(I,1) + FI + vecB3(I) = matQ(I,NLAST) + FI + END DO + K1 = NLAST + JR - 1 + K2 = K1 + JR - 1 + CALL COSGEN (JR - 1, 1, ZERO, ONE, TCOS(K1+1), size(TCOS)-K1) + CALL COSGEN (NLAST, 1, HALF, ZERO, TCOS(K2+1), size(TCOS)-K2) + CALL MERGE (TCOS, K1, JR - 1, K2, NLAST, 0, size(TCOS)) + K3 = K1 + NLAST - 1 + K4 = K3 + JR + CALL COSGEN (JR, 1, HALF, HALF, TCOS(K3+1),SIZE(TCOS)-K3) + CALL COSGEN (JR, 1, ZERO, HALF, TCOS(K4+1),SIZE(TCOS)-K4) + CALL MERGE (TCOS, K3, JR, K4, JR, K1, size(TCOS) ) + K2 = NLAST - 1 + K3 = JR + K4 = JR + 162 CONTINUE + CALL TRI3 (MR, vecA, vecBB, vecC, K, vecB, vecB2, vecB3, & + TCOS, size(TCOS), vecD, vecW, vecW2, vecW3) + vecB(:MR) = vecB(:MR) + vecB2(:MR) + vecB3(:MR) + IF (NP == 3) THEN + TCOS(1) = TWO + CALL TRIX (1, 0, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + ENDIF + matQ(:MR,J) = vecB(:MR) + & + HALF*(matQ(:MR,J)-matQ(:MR,JM1)-matQ(:MR,JP1)) + vecB(:MR) = matQ(:MR,J) + matQ(:MR,1) + CALL COSGEN (JR, 1, FNUM, HALF, TCOS,size(TCOS)) + CALL TRIX (JR, 0, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + matQ(:MR,1) = matQ(:MR,1) - matQ(:MR,JM1) + vecB(:MR) + GO TO 188 + ENDIF +! +! CASE OF GENERAL N WITH NR = 3 . +! + vecB(:MR) = matQ(:MR,1) - matQ(:MR,JM1) + matQ(:MR,J) + IF (NROD == 0) THEN + vecB(:MR) = vecB(:MR) + vecP(IP+1:MR+IP) + ELSE + vecB(:MR) = vecB(:MR) + matQ(:MR,NLAST) - matQ(:MR,JM2) + ENDIF + DO I = 1, MR + T = HALF*(matQ(I,J)-matQ(I,JM1)-matQ(I,JP1)) + matQ(I,J) = T + vecB2(I) = matQ(I,NLAST) + T + vecB3(I) = matQ(I,1) + T + END DO + K1 = KR + 2*JR + CALL COSGEN (JR - 1, 1, ZERO, ONE, TCOS(K1+1),size(TCOS)-K1) + K2 = K1 + JR + TCOS(K2) = TWO*DBLE(NP - 2) + K4 = (NP - 1)*(3 - NP) + K3 = K2 + 1 - K4 + CALL COSGEN(KR+JR+K4,1,HALF*DBLE(K4),ONE-DBLE(K4),TCOS(K3), & + size(TCOS)-K3+1 ) + K4 = 1 - NP/3 + CALL MERGE (TCOS, K1, JR - K4, K2 - K4, KR + JR + K4, 0, size(TCOS) ) + IF (NP == 3) K1 = K1 - 1 + K2 = KR + JR + K4 = K1 + K2 + CALL COSGEN (KR, 1, FNUM2, HALF, TCOS(K4+1),size(TCOS)-K4) + K3 = K4 + KR + CALL COSGEN (JR, 1, FNUM, HALF, TCOS(K3+1),size(TCOS)-K3) + CALL MERGE (TCOS, K4, KR, K3, JR, K1, size(TCOS) ) + K4 = K3 + JR + CALL COSGEN (LR, 1, FNUM2, HALF, TCOS(K4+1),size(TCOS)-K4) + CALL MERGE (TCOS, K3, JR, K4, LR, K1 + K2, size(TCOS) ) + CALL COSGEN (KR, 1, FNUM2, HALF, TCOS(K3+1),size(TCOS)-K3) + K3 = KR + K4 = KR + CALL TRI3 (MR, vecA, vecBB, vecC, K, vecB, vecB2, vecB3, & + TCOS, SIZE(TCOS), vecD, vecW, vecW2, vecW3) + vecB(:MR) = vecB(:MR) + vecB2(:MR) + vecB3(:MR) + IF (NP == 3) THEN + TCOS(1) = TWO + CALL TRIX (1, 0, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + ENDIF + matQ(:MR,J) = matQ(:MR,J) + vecB(:MR) + vecB(:MR) = matQ(:MR,1) + matQ(:MR,J) + CALL COSGEN (JR, 1, FNUM, HALF, TCOS,size(TCOS)) + CALL TRIX (JR, 0, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + IF (JR == 1) THEN + matQ(:MR,1) = vecB(:MR) + GO TO 188 + ENDIF + matQ(:MR,1) = matQ(:MR,1) - matQ(:MR,JM1) + vecB(:MR) + GO TO 188 + ENDIF + vecB3(:MR) = 0. + vecB (:MR) = matQ(:MR,1) + vecP(IP+1:MR+IP) + matQ (:MR,1) = matQ(:MR,1) - matQ(:MR,JM1) + vecB2(:MR) = matQ(:MR,1) + matQ(:MR,NLAST) + K1 = KR + JR + K2 = K1 + JR + CALL COSGEN (JR - 1, 1, ZERO, ONE, TCOS(K1+1),SIZE(TCOS)-K1) + GO TO (182,183,182) NP + 182 CONTINUE + TCOS(K2) = TWO*DBLE(NP - 2) + CALL COSGEN (KR, 1, ZERO, ONE, TCOS(K2+1),SIZE(TCOS)-K2) + GO TO 184 + 183 CONTINUE + CALL COSGEN (KR + 1, 1, HALF, ZERO, TCOS(K2),SIZE(TCOS)-K2) + 184 CONTINUE + K4 = 1 - NP/3 + CALL MERGE (TCOS, K1, JR - K4, K2 - K4, KR + K4, 0, size(TCOS) ) + IF (NP == 3) K1 = K1 - 1 + K2 = KR + CALL COSGEN (KR, 1, FNUM2, HALF, TCOS(K1+1),SIZE(TCOS)-K1) + K4 = K1 + KR + CALL COSGEN (LR, 1, FNUM2, HALF, TCOS(K4+1),SIZE(TCOS)-K4) + K3 = LR + K4 = 0 + CALL TRI3 (MR, vecA, vecBB, vecC, K, vecB, vecB2, vecB3, & + TCOS, SIZE(TCOS), vecD, vecW, vecW2, vecW3) + vecB(:MR) = vecB(:MR) + vecB2(:MR) + IF (NP == 3) THEN + TCOS(1) = TWO + CALL TRIX (1, 0, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + ENDIF + matQ(:MR,1) = matQ(:MR,1) + vecB(:MR) + 188 CONTINUE + J = NLAST - JR + vecB(:MR) = matQ(:MR,NLAST) + matQ(:MR,J) + JM2 = NLAST - I2R + IF (JR == 1) THEN + matQ(:MR,NLAST) = 0. + ELSE + IF (NROD == 0) THEN + matQ(:MR,NLAST) = vecP(IP+1:MR+IP) + IP = IP - MR + ELSE + matQ(:MR,NLAST) = matQ(:MR,NLAST) - matQ(:MR,JM2) + ENDIF + ENDIF + CALL COSGEN (KR, 1, FNUM2, HALF, TCOS,SIZE(TCOS)) + CALL COSGEN (LR, 1, FNUM2, HALF, TCOS(KR+1),SIZE(TCOS)-KR) + CALL TRIX (KR, LR, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + matQ(:MR,NLAST) = matQ(:MR,NLAST) + vecB(:MR) + NLASTP = NLAST + 197 CONTINUE + JSTEP = JR + JR = I2R + I2R = I2R/2 + IF (JR == 0) GO TO 210 + JSTART = 1 + JR + KR = KR - JR + IF (NLAST + JR <= N) THEN + KR = KR - JR + NLAST = NLAST + JR + JSTOP = NLAST - JSTEP + ELSE + JSTOP = NLAST - JR + ENDIF + LR = KR - JR + CALL COSGEN (JR, 1, HALF, ZERO, TCOS,SIZE(TCOS)) + DO J = JSTART, JSTOP, JSTEP + JM2 = J - JR + JP2 = J + JR + IF (J == JR) THEN + vecB(:MR) = matQ(:MR,J) + matQ(:MR,JP2) + ELSE + vecB(:MR) = matQ(:MR,J) + matQ(:MR,JM2) + matQ(:MR,JP2) + ENDIF + IF (JR == 1) THEN + matQ(:MR,J) = 0. + ELSE + JM1 = J - I2R + JP1 = J + I2R + matQ(:MR,J) = HALF*(matQ(:MR,J)-matQ(:MR,JM1)-matQ(:MR,JP1)) + ENDIF + CALL TRIX (JR, 0, MR, vecA, vecBB, vecC, vecB, TCOS, & + size(TCOS), vecD, vecW) + matQ(:MR,J) = matQ(:MR,J) + vecB(:MR) + END DO + NROD = 1 + IF (NLAST + I2R <= N) NROD = 0 + IF (NLASTP /= NLAST) GO TO 188 + GO TO 197 + 210 CONTINUE + vecW(1) = IPSTOR +! +! REVISION HISTORY--- +! +! SEPTEMBER 1973 VERSION 1 +! APRIL 1976 VERSION 2 +! JANUARY 1978 VERSION 3 +! DECEMBER 1979 VERSION 3.1 +! FEBRUARY 1985 DOCUMENTATION UPGRADE +! NOVEMBER 1988 VERSION 3.2, FORTRAN 77 CHANGES +! June 2004 Version 5.0, Fortran 90 Changes +!----------------------------------------------------------------------- + END SUBROUTINE POSTG2 diff --git a/fish90/src/test.c b/fish90/src/test.c new file mode 100644 index 0000000000000000000000000000000000000000..ce96079a380e06ec2d50e09a8035d38df47a13bc --- /dev/null +++ b/fish90/src/test.c @@ -0,0 +1,13 @@ +#include "stdlib.h" +#include "stdio.h" +#include "fishpack.h" + + +int main() +{ + fish_hstcyl (0.0, 1.0, 256, + 1, NULL, NULL, + 0.0, 1.0, 256, + 1, NULL, NULL, + 0.0, 0.0, NULL, 0); +} diff --git a/fish90/src/tri3.f90 b/fish90/src/tri3.f90 new file mode 100644 index 0000000000000000000000000000000000000000..48fc20008bf7695426bd1de321dc084f6812a2b6 --- /dev/null +++ b/fish90/src/tri3.f90 @@ -0,0 +1,122 @@ + SUBROUTINE TRI3(M, vecA, vecB, vecC, ivecK, vecY1, vecY2, vecY3, TCOS, & + ITCOS, vecD, vecW1, vecW2, vecW3) + implicit none + + DOUBLE PRECISION, PARAMETER :: ZERO = 0.0D0, HALF = 0.5D0, & + ONE = 1.0D0, TWO = 2.0D0, & + FOUR = 4.0D0 + +!----------------------------------------------- +! D u m m y A r g u m e n t s +!----------------------------------------------- + INTEGER, INTENT(IN) :: M,ITCOS + INTEGER, DIMENSION(4),INTENT(IN) :: ivecK + DOUBLE PRECISION, DIMENSION(M), INTENT(IN) :: vecA, vecB, vecC + DOUBLE PRECISION, DIMENSION(ITCOS), INTENT(IN) :: TCOS + DOUBLE PRECISION, DIMENSION(M), INTENT(INOUT) :: vecY1, vecY2, vecY3, & + vecD, vecW1, vecW2, vecW3 +!----------------------------------------------- +! L o c a l V a r i a b l e s +!----------------------------------------------- + INTEGER :: MM1, K1, K2, K3, K4, IF1, IF2, IF3, IF4, K2K3K4, & + L1, L2, L3, LINT1, LINT2, LINT3, KINT1, KINT2, KINT3, & + N, I, IP + DOUBLE PRECISION :: X, Z, XX +!----------------------------------------------- +! +! SUBROUTINE TO SOLVE THREE LINEAR SYSTEMS WHOSE COMMON COEFFICIENT +! MATRIX IS A RATIONAL FUNCTION IN THE MATRIX GIVEN BY +! +! TRIDIAGONAL (...,vecA(I),vecB(I),vecC(I),...) +! + MM1 = M - 1 + K1 = ivecK(1) + K2 = ivecK(2) + K3 = ivecK(3) + K4 = ivecK(4) + IF1 = K1 + 1 + IF2 = K2 + 1 + IF3 = K3 + 1 + IF4 = K4 + 1 + K2K3K4 = K2 + K3 + K4 + IF (K2K3K4 /= 0) THEN + L1 = IF1/IF2 + L2 = IF1/IF3 + L3 = IF1/IF4 + LINT1 = 1 + LINT2 = 1 + LINT3 = 1 + KINT1 = K1 + KINT2 = KINT1 + K2 + KINT3 = KINT2 + K3 + ELSE + write(*,*) 'warning', & + 'tri3: l1,l2,l3,kint1,kint2,kint3 uninitialized' + stop 'stop in tri3: l1,l2,l3,kint1,kint2,kint3 uninitialized' + ENDIF + DO N = 1, K1 + X = TCOS(N) + IF (K2K3K4 /= 0) THEN + IF (N == L1) THEN + vecW1(:M) = vecY1(:M) + ENDIF + IF (N == L2) THEN + vecW2(:M) = vecY2(:M) + ENDIF + IF (N == L3) THEN + vecW3(:M) = vecY3(:M) + ENDIF + ENDIF + Z = 1./(vecB(1)-X) + vecD(1) = vecC(1)*Z + vecY1(1) = vecY1(1)*Z + vecY2(1) = vecY2(1)*Z + vecY3(1) = vecY3(1)*Z + DO I = 2, M + Z = 1./(vecB(I)-X-vecA(I)*vecD(I-1)) + vecD(I) = vecC(I)*Z + vecY1(I) = (vecY1(I)-vecA(I)*vecY1(I-1))*Z + vecY2(I) = (vecY2(I)-vecA(I)*vecY2(I-1))*Z + vecY3(I) = (vecY3(I)-vecA(I)*vecY3(I-1))*Z + END DO + DO IP = 1, MM1 + vecY1(M-IP) = vecY1(M-IP) - vecD(M-IP)*vecY1(M+1-IP) + vecY2(M-IP) = vecY2(M-IP) - vecD(M-IP)*vecY2(M+1-IP) + vecY3(M-IP) = vecY3(M-IP) - vecD(M-IP)*vecY3(M+1-IP) + END DO + IF (K2K3K4 == 0) CYCLE + IF (N == L1) THEN + I = LINT1 + KINT1 + XX = X - TCOS(I) + vecY1(:M) = XX*vecY1(:M) + vecW1(:M) + LINT1 = LINT1 + 1 + L1 = (LINT1*IF1)/IF2 + ENDIF + IF (N == L2) THEN + I = LINT2 + KINT2 + XX = X - TCOS(I) + vecY2(:M) = XX*vecY2(:M) + vecW2(:M) + LINT2 = LINT2 + 1 + L2 = (LINT2*IF1)/IF3 + ENDIF + IF (N /= L3) CYCLE + I = LINT3 + KINT3 + XX = X - TCOS(I) + vecY3(:M) = XX*vecY3(:M) + vecW3(:M) + LINT3 = LINT3 + 1 + L3 = (LINT3*IF1)/IF4 + END DO + RETURN +! +! REVISION HISTORY--- +! +! SEPTEMBER 1973 VERSION 1 +! APRIL 1976 VERSION 2 +! JANUARY 1978 VERSION 3 +! DECEMBER 1979 VERSION 3.1 +! OCTOBER 1980 CHANGED SEVERAL DIVIDES OF FLOATING INTEGERS +! TO INTEGER DIVIDES TO ACCOMODATE CRAY-1 ARITHMETIC. +! FEBRUARY 1985 DOCUMENTATION UPGRADE +! NOVEMBER 1988 VERSION 3.2, FORTRAN 77 CHANGES +!----------------------------------------------------------------------- + END SUBROUTINE TRI3 diff --git a/include/cdr.h b/include/cdr.h new file mode 100644 index 0000000000000000000000000000000000000000..b5d22137833b963ca80a9369fd873a84960518fe --- /dev/null +++ b/include/cdr.h @@ -0,0 +1,49 @@ +/** @file cdr.h + * @brief Header file for cdr grids. */ + +#include "cstream.h" +#include "tree.h" + +#ifndef _GRID_H_ +#include "grid.h" +#endif + +#ifndef _RZ_ARRAY_H_ +#include "rz_array.h" +#endif + +#ifndef _TREE_H_ +#include "tree.h" +#endif + +#ifndef _CDR_H_ +typedef struct cdr_grid_t cdr_grid_t; + +struct cdr_grid_t { + RECT_COORDS; + LEAF_FIELDS(cdr_grid_t); + int ext_bound; + + /* Pointer to each of the species. And their time derivatives */ + rz_array_t **dens; + rz_array_t **d_dens; + + /* Components and magnitude of the electric field */ + rz_array_t *er, *ez, *etheta, *eabs; + rz_array_t *charge; + + rz_array_t *photo; + + REAL *max_dens; + REAL max_charge; + REAL max_eabs; + + int contains_edge; +}; + +#define SET_DENS_OVERWRITE 1 +#define SET_DENS_ADD 2 +#define SET_DENS_SUB 3 + +#define _CDR_H_ +#endif diff --git a/include/configuration.h b/include/configuration.h new file mode 100644 index 0000000000000000000000000000000000000000..b2ed41ac92c912fc2c0fb9b9473285595a08495a --- /dev/null +++ b/include/configuration.h @@ -0,0 +1,90 @@ +/** @file configuration.h + * @brief Function prototypes for configuration functions. + */ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include +#include +#include +#include +#include + +#ifndef _CSTREAM_H +# include "cstream.h" +#endif + +#ifndef _PARAMETERS_H_ +# include "parameters.h" +#endif + +#ifndef _SPECIES_H +# include "species.h" +#endif + +#ifndef _REACTION_H +# include "reaction.h" +#endif + +#define COMPARE_LIMIT 100 +#define NO_PARAMETERS 100 + +typedef struct array_name { + const char *name; +} ARRAY_NAME ; + +ARRAY_NAME parameter_names[NO_PARAMETERS]; + +bool +change_cfg_integer(const char* name,const char *type,const char *comment, + const char *sstring, int *par,int value,int count, + bool *change, config_setting_t *setting_default,int i); +bool +change_cfg_double(const char* name,const char *type,const char *comment, + const char *sstring,double *par,double value,int count, + bool *change, config_setting_t *setting_default,int i); +//bool +//change_cfg_bool(const char* name,const char *type,const char *comment, +// const char *sstring, bool *par,bool value,int count, +// bool *change, config_setting_t *setting_default,int i); +bool +change_cfg_string(const char *name,const char *type,const char *comment, + const char *sstring,char** par,char* value,int count, + bool *change, config_setting_t *setting_default,int i); +void +change_cfg_parameters (const char *name,const char *type,const char *comment, + int ii,int ivalue, double dvalue, bool bbool, + const char* astring, config_setting_t *setting, + int count,bool *change); +bool +read_parameter(config_setting_t *setting1,config_setting_t *setting2, + int ii,int count,bool *change); + +bool +read_specie(config_setting_t *setting,int ii,species_t *temp_s); + +bool +read_seed(config_setting_t *setting,int ii,seed_t *temp_se); + +bool +read_reaction(config_setting_t *setting,int ii,reaction_t *temp_r); + diff --git a/include/cstream.h b/include/cstream.h new file mode 100644 index 0000000000000000000000000000000000000000..4a27ba27278957b9d0074d879d0611c9326b061b --- /dev/null +++ b/include/cstream.h @@ -0,0 +1,143 @@ +/** @file cstream.h + * @brief Global header file + */ + +#ifndef _CSTREAM_H_ + +#include "tree.h" +#include "assert.h" +#include "stdlib.h" + +#ifdef _OPENMP +# include "omp.h" +#endif + +#ifndef TRUE +# define TRUE 1 +#endif + +#ifndef FALSE +# define FALSE 0 +#endif + + +#ifdef DEBUG_LEVEL +# ifdef _OPENMP +# define debug(level, ...) if (DEBUG_LEVEL >= level) { \ + fprintf (stderr,"[%d] %s:%d: ", omp_get_thread_num(), \ + __FILE__, __LINE__); \ + fprintf (stderr,__VA_ARGS__); \ + } +# else /*_OPENMP*/ +# define debug(level, ...) if (DEBUG_LEVEL >= level) { \ + fprintf (stderr,"%s:%d: ", __FILE__, __LINE__); \ + fprintf (stderr,__VA_ARGS__); \ + } +# endif +#else +# define debug(level, ...) +# define NDEBUG /* To supress the asserts */ +#endif + +#define warning(...) do{ \ + fprintf (stderr, "%s: Warning: ", invok_name); \ + fprintf (stderr, ## __VA_ARGS__); \ + } while(0) + +#define fatal(...) do{ \ + fprintf (stderr, "%s: Fatal error: ", invok_name); \ + fprintf (stderr, ## __VA_ARGS__); \ + exit(-1); \ + } while(0) + +/* Useful to debug. */ +#define show_double(VAR_) printf (#VAR_ " = %g\n", VAR_) +#define show_int(VAR_) printf (#VAR_ " = %d\n", VAR_) + +/* Beware of side-effects! */ +#define MYMAX(X_, Y_) ((X_) > (Y_)? (X_): (Y_)) +#define MYMIN(X_, Y_) ((X_) < (Y_)? (X_): (Y_)) +#define MAX_AT_LEVEL(X_, Y_, L_) MYMAX(X_, (Y_) << (L_)) +#define MIN_AT_LEVEL(X_, Y_, L_) MYMIN(X_, (Y_) << (L_)) +#define MAX_AT_LEVEL_WITH_SHIFT(X_, Y_, L_, S_) \ + MYMAX(X_, ((Y_) << (L_)) + ((L_) > 0? ((S_) << (L_ - 1)): 0)) +#define MIN_AT_LEVEL_WITH_SHIFT(X_, Y_, L_, S_) \ + MYMIN(X_, ((Y_) << (L_)) + ((L_) > 0? ((S_) << (L_ - 1)): 0)) + +#define XCHG(X1_, X2_) do { \ + typeof(X1_) TMP_; \ + TMP_ = X1_; \ + X1_ = X2_; \ + X2_ = TMP_; \ + } while(0) + + +#define SQ(X_) ((X_) * (X_)) + +///** @brief Information about each program parameter. */ +//typedef struct param_t param_t; +//struct param_t { + //char *name; + //char *desc; + //char *type; + //void *value; +//}; + +/** @brief These are the types for the global parameters. */ +typedef char* string; +typedef double* doublep; + +//#ifdef ALLOC_PARAMS +//# define decl_param(TYPE, NAME, DESC, DEFAULT) \ + //TYPE NAME = DEFAULT; \ + //param_t NAME ## _st = { \ + //#NAME, \ + //DESC, \ + //#TYPE, \ + //(void *) &NAME}; +//# define decl_deprec_param(TYPE, NAME, DESC, DEFAULT) \ + //TYPE NAME; \ + //param_t NAME ## _st = { \ + //#NAME, \ + //DESC, \ + //"deprecated", \ + //NULL}; +//#else +//# define decl_param(TYPE, NAME, DESC, DEFAULT) \ + //extern TYPE NAME; \ + //extern param_t NAME ## _st; +//# define decl_deprec_param(TYPE, NAME, DESC, DEFAULT) \ + //decl_param(TYPE, NAME, DESC, DEFAULT) +//#endif + +typedef double REAL; + +extern double *dr, *dz, dtheta; +/*!< The grid sizes */ +extern double *w2k, *wk; +/*!< See cstream.c */ + +#define decl_field_comp(_DIR) \ + double (*ext_e_ ## _DIR) (double r, double z, double theta) +/*!< The three components of the external field: ext_e_r, ext_e_z and + * ext_e_theta. */ + +extern decl_field_comp(r); +extern decl_field_comp(z); +extern decl_field_comp(theta); + +extern char *invok_name; + +extern const double twopi; +extern const double invfourpi; +extern const double invpi32; + +/********** + * misc.c * + **********/ +void *xmalloc (size_t size); +void *xrealloc (void *ptr, size_t size); +void *xcalloc (size_t count, size_t size); + +#define _CSTREAM_H_ +#endif diff --git a/include/grid.h b/include/grid.h new file mode 100644 index 0000000000000000000000000000000000000000..576499613c6134134a6eb13f58227bb4a901c547 --- /dev/null +++ b/include/grid.h @@ -0,0 +1,159 @@ +/** @file grid.h + * @brief Definitions for working with general grids. + */ +#ifndef _GRID_H_ + +#ifndef _TREE_H_ +# include "tree.h" +#endif + +#define RECT_COORDS int r0, r1, z0, z1, ntheta +/*!< Coordinate names for the grids */ + +#define BND_AT_R 0 +#define BND_AT_Z 2 +#define BND_MIN 0 +#define BND_MAX 1 + +#define BND_LEFT (BND_AT_R | BND_MIN) +#define BND_RIGHT (BND_AT_R | BND_MAX) +#define BND_BOTTOM (BND_AT_Z | BND_MIN) +#define BND_TOP (BND_AT_Z | BND_MAX) + +#define BND_MASK(B_) (1 << (B_)) +#define BND_NONE 0 +#define BND_MASK_LEFT BND_MASK(BND_LEFT) +#define BND_MASK_RIGHT BND_MASK(BND_RIGHT) +#define BND_MASK_BOTTOM BND_MASK(BND_BOTTOM) +#define BND_MASK_TOP BND_MASK(BND_TOP) +#define BND_MASK_ALL (BND_MASK_LEFT | BND_MASK_RIGHT\ + | BND_MASK_BOTTOM | BND_MASK_TOP) + +#define GRID_INSIDE (1 << (BND_TOP + 1)) + +/* Locations of the cell centers. */ +#define r_at(r_, level_) (((double) (r_) + 0.5) * dr[level_]) +#define z_at(z_, level_) (((double) (z_) + 0.5) * dz[level_]) +#define theta_at(theta_) ((double) (theta_) * dtheta) + +/* Locations of the electric field. */ +#define er_r_at(i_, level_) ((i_ + 1) * dr[level_]) +#define er_z_at(j_, level_) (((double) (j_) + 0.5) * dz[level_]) +#define ez_r_at(i_, level_) (((double) (i_) + 0.5) * dr[level_]) +#define ez_z_at(j_, level_) ((j_ + 1) * dz[level_]) +#define etheta_theta_at(i_) (((double) (i_) + 0.5) * dtheta) + + +/** We can produce easily a true 2d code by replacing r when it appears + * due to the cylindrical coordinates by this macros. This has a rather + * large performance penalty, so it is better to do that in compile time + */ + +/* Locations of the electric field. */ +#ifdef TRUE2D +# define cyl_q(X_) 1 +# define cyl_er_r_at(i_, level_) 1 +# define cyl_r_at(r_, level_) 1 +#else +# define cyl_q(X_) (X_) +# define cyl_er_r_at(i_, level_) er_r_at(i_, level_) +# define cyl_r_at(r_, level_) r_at(r_, level_) +#endif + +/* These are shortcuts to make the iteration over grid cells easier. + * Note that it is important that the inner loop has the smallest + * stride to minimize the cache faults. + */ +#define iter_grid_z(grid_, iz_) \ + for(iz_ = grid_->z0; iz_ < grid_->z1; iz_++) + +#define iter_grid_r(grid_, ir_) \ + for(ir_ = grid_->r0; ir_ < grid_->r1; ir_++) + +#define iter_grid_theta(grid_, it_) \ + for(it_ = 0; it_ < grid_->ntheta; it_++) + +#define iter_grid(grid_, ir_, iz_) \ + iter_grid_z(grid_, iz_) \ + iter_grid_r(grid_, ir_) + +#define iter_grid_3d(grid_, ir_, iz_, it_) \ + iter_grid_theta(grid_, it_) \ + iter_grid_z(grid_, iz_) \ + iter_grid_r(grid_, ir_) + + +/* Functions to iterate over the grids _including_ 1 extra boundary */ +#define iter_grid_z_1(grid_, iz_) \ + for(iz_ = grid_->z0 - 1; iz_ < grid_->z1 + 1; iz_++) + +#define iter_grid_r_1(grid_, ir_) \ + for(ir_ = grid_->r0 - 1; ir_ < grid_->r1 + 1; ir_++) + +#define iter_grid_1(grid_, ir_, iz_) \ + iter_grid_z_1(grid_, iz_) \ + iter_grid_r(grid_, ir_) + +#define iter_grid_3d_1(grid_, ir_, iz_, it_) \ + iter_grid_theta(grid_, it_) \ + iter_grid_z_1(grid_, iz_) \ + iter_grid_r_1(grid_, ir_) + + +/* These include n extra cells in the boundary. We avoid that when + * ntheta == 1 because we are in the 2D case and there are no boundaries + * in theta*/ +#define iter_grid_theta_n(grid_, it_, n_) \ + for(it_ = (grid_->ntheta == 1? 0: -n_); it_ < grid_->ntheta \ + + (grid_->ntheta == 1? 0: n_); it_++) + +#define iter_grid_z_n(grid_, iz_, n_) \ + for(iz_ = grid_->z0 - n_; iz_ < grid_->z1 + n_; iz_++) + +#define iter_grid_r_n(grid_, ir_, n_) \ + for(ir_ = grid_->r0 - n_; ir_ < grid_->r1 + n_; ir_++) + +#define iter_grid_n(grid_, ir_, iz_, n_) \ + iter_grid_z_n(grid_, iz_, n_) \ + iter_grid_r_n(grid_, ir_, n_) + +#define iter_grid_3d_n(grid_, ir_, iz_, it_, n_) \ + iter_grid_theta_n(grid_, it_, n_) \ + iter_grid_z_n(grid_, iz_, n_) \ + iter_grid_r_n(grid_, ir_, n_) + + +/* Iter through the parent indices that fill one grid. */ +#define iter_grid_parent(grid_, ir_, iz_) \ + for(ir_ = (grid_->r0 >> 1) + (grid_->r0 % 2); \ + ir_ < (grid_->r1 >> 1); ir_++) \ + for(iz_ = (grid_->z0 >> 1) + (grid_->z0 % 2); \ + iz_ < (grid_->z1 >> 1); iz_++) + + +/** @brief The cdr grids and poisson grids types are cdr_grid_t and + * pois_grid_t, defined in cdr.h and poisson.h. + * + * This structure contains the common parts of both structures and + * thus can be used in general routines that accept any kind of grid. + * The C standard promises that we can du this. + */ +typedef struct grid_t grid_t; +struct grid_t { + RECT_COORDS; + LEAF_FIELDS(grid_t); + /* ext_bound indicates which boundaries are external boundaries. + e.g. ext_bound & BND_LEFT_TOP tells us whether the left-top boundary + is an external one. */ + int ext_bound; +}; + +/** @brief To ease typing, you can write e.g. + * printf ("Solving grid (" grid_printf_str ")\n", grid_printf_args(grid)); + */ +#define grid_printf_str "{r0 = %d, z0 = %d, r1 = %d, z1 = %d, level = %d}" +#define grid_printf_args(G_) (G_)->r0, (G_)->z0, (G_)->r1, (G_)->z1, \ + (G_)->level + +#define _GRID_H_ +#endif diff --git a/include/interpol2.h b/include/interpol2.h new file mode 100644 index 0000000000000000000000000000000000000000..283035d293a23846a75f0f69ff8506c64143502f --- /dev/null +++ b/include/interpol2.h @@ -0,0 +1,65 @@ +/** @file interpol2.h + * @brief Header file for interpol2.c. + */ +#ifndef _INTERPOL2_H_ + +/* We will certainly never use a 16th order scheme, + * but in case we do, remember to change it here + */ +#define MAX_ORDER 16 + +#define MAX_INTERPOL_METHODS 9 + +typedef struct interpol_t interpol_t; +typedef struct interpol_method_t interpol_method_t; + +struct interpol_t +{ + double *coeffs; + double *stencil; + + /* The separation between stencil points. */ + double Lr, Lz; + + /* The interpolation method to use. */ + interpol_method_t *method; + + /* Origin of the interpolation polynomial, which is thus written in + powers of (r - r0) and (z - z0). */ + double r0, z0; +}; + +struct interpol_method_t +{ + double *matrix; + + /* p is the order of the polynomial plus one. + * q is the number of stencil points in one direction (the total + * number is, of course, q^2. */ + int p, q; + + /* Location of the origin with respect to the stencil in units of L. */ + int ir0, iz0; + + int masses; + + void (*set_coeffs) (interpol_t *this); + double (*apply) (interpol_t *this, double r, double z); +}; + +extern interpol_method_t interpol_zero; +extern interpol_method_t interpol_wackers; +extern interpol_method_t interpol_luque; +extern interpol_method_t interpol_quadratic; +extern interpol_method_t interpol_bilin; +extern interpol_method_t interpol_quadlog; +extern interpol_method_t interpol_zero_masses; +extern interpol_method_t interpol_wackers_masses; +extern interpol_method_t interpol_luque_masses; +extern interpol_method_t interpol_quadratic_masses; +extern interpol_method_t interpol_bilin_masses; + +extern interpol_method_t *interpol_methods_index[MAX_INTERPOL_METHODS]; + +#define _INTERPOL2_H_ +#endif diff --git a/include/libconfig.h b/include/libconfig.h new file mode 100644 index 0000000000000000000000000000000000000000..77962046fdfb452055f95cfaf2231bac93bd8ab7 --- /dev/null +++ b/include/libconfig.h @@ -0,0 +1,325 @@ +/** @file libconfig.h + * @brief Header file of library libconfig. */ + + +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#ifndef __libconfig_h +#define __libconfig_h + +#ifdef __cplusplus +extern "C" { +#endif /* __cplusplus */ + +#if defined(_WIN32) || defined(__WIN32__) || defined(WIN32) +#if defined(LIBCONFIG_STATIC) +#define LIBCONFIG_API +#elif defined(LIBCONFIG_EXPORTS) +#define LIBCONFIG_API __declspec(dllexport) +#else /* ! LIBCONFIG_EXPORTS */ +#define LIBCONFIG_API __declspec(dllimport) +#endif /* LIBCONFIG_STATIC */ +#else /* ! WIN32 */ +#define LIBCONFIG_API +#endif /* WIN32 */ + +#define LIBCONFIG_VER_MAJOR 1 +#define LIBCONFIG_VER_MINOR 4 +#define LIBCONFIG_VER_REVISION 9 + +#include + +#define CONFIG_TYPE_NONE 0 +#define CONFIG_TYPE_GROUP 1 +#define CONFIG_TYPE_INT 2 +#define CONFIG_TYPE_INT64 3 +#define CONFIG_TYPE_FLOAT 4 +#define CONFIG_TYPE_STRING 5 +#define CONFIG_TYPE_BOOL 6 +#define CONFIG_TYPE_ARRAY 7 +#define CONFIG_TYPE_LIST 8 + +#define CONFIG_FORMAT_DEFAULT 0 +#define CONFIG_FORMAT_HEX 1 + +#define CONFIG_OPTION_AUTOCONVERT 0x01 + +#define CONFIG_TRUE (1) +#define CONFIG_FALSE (0) + +typedef union config_value_t +{ + int ival; + long long llval; + double fval; + char *sval; + struct config_list_t *list; +} config_value_t; + +typedef struct config_setting_t +{ + char *name; + short type; + short format; + config_value_t value; + struct config_setting_t *parent; + struct config_t *config; + void *hook; + unsigned int line; + const char *file; +} config_setting_t; + +typedef enum +{ + CONFIG_ERR_NONE = 0, + CONFIG_ERR_FILE_IO = 1, + CONFIG_ERR_PARSE = 2 +} config_error_t; + +typedef struct config_list_t +{ + unsigned int length; + config_setting_t **elements; +} config_list_t; + +typedef struct config_t +{ + config_setting_t *root; + void (*destructor)(void *); + unsigned short flags; + unsigned short tab_width; + short default_format; + const char *include_dir; + const char *error_text; + const char *error_file; + int error_line; + config_error_t error_type; + const char **filenames; + unsigned int num_filenames; +} config_t; + +extern LIBCONFIG_API int config_read(config_t *config, FILE *stream); +extern LIBCONFIG_API void config_write(const config_t *config, FILE *stream); + +extern LIBCONFIG_API void config_set_default_format(config_t *config, + short format); + +extern LIBCONFIG_API void config_set_auto_convert(config_t *config, int flag); +extern LIBCONFIG_API int config_get_auto_convert(const config_t *config); + +extern LIBCONFIG_API int config_read_string(config_t *config, const char *str); + +extern LIBCONFIG_API int config_read_file(config_t *config, + const char *filename); +extern LIBCONFIG_API int config_write_file(config_t *config, + const char *filename); + +extern LIBCONFIG_API void config_set_destructor(config_t *config, + void (*destructor)(void *)); +extern LIBCONFIG_API void config_set_include_dir(config_t *config, + const char *include_dir); + +extern LIBCONFIG_API void config_init(config_t *config); +extern LIBCONFIG_API void config_destroy(config_t *config); + +extern LIBCONFIG_API int config_setting_get_int( + const config_setting_t *setting); +extern LIBCONFIG_API long long config_setting_get_int64( + const config_setting_t *setting); +extern LIBCONFIG_API double config_setting_get_float( + const config_setting_t *setting); +extern LIBCONFIG_API int config_setting_get_bool( + const config_setting_t *setting); +extern LIBCONFIG_API const char *config_setting_get_string( + const config_setting_t *setting); + +extern LIBCONFIG_API int config_setting_lookup_int( + const config_setting_t *setting, const char *name, int *value); +extern LIBCONFIG_API int config_setting_lookup_int64( + const config_setting_t *setting, const char *name, long long *value); +extern LIBCONFIG_API int config_setting_lookup_float( + const config_setting_t *setting, const char *name, double *value); +extern LIBCONFIG_API int config_setting_lookup_bool( + const config_setting_t *setting, const char *name, int *value); +extern LIBCONFIG_API int config_setting_lookup_string( + const config_setting_t *setting, const char *name, const char **value); + +extern LIBCONFIG_API int config_setting_set_int(config_setting_t *setting, + int value); +extern LIBCONFIG_API int config_setting_set_int64(config_setting_t *setting, + long long value); +extern LIBCONFIG_API int config_setting_set_float(config_setting_t *setting, + double value); +extern LIBCONFIG_API int config_setting_set_bool(config_setting_t *setting, + int value); +extern LIBCONFIG_API int config_setting_set_string(config_setting_t *setting, + const char *value); + +extern LIBCONFIG_API int config_setting_set_format(config_setting_t *setting, + short format); +extern LIBCONFIG_API short config_setting_get_format( + const config_setting_t *setting); + +extern LIBCONFIG_API int config_setting_get_int_elem( + const config_setting_t *setting, int idx); +extern LIBCONFIG_API long long config_setting_get_int64_elem( + const config_setting_t *setting, int idx); +extern LIBCONFIG_API double config_setting_get_float_elem( + const config_setting_t *setting, int idx); +extern LIBCONFIG_API int config_setting_get_bool_elem( + const config_setting_t *setting, int idx); +extern LIBCONFIG_API const char *config_setting_get_string_elem( + const config_setting_t *setting, int idx); + +extern LIBCONFIG_API config_setting_t *config_setting_set_int_elem( + config_setting_t *setting, int idx, int value); +extern LIBCONFIG_API config_setting_t *config_setting_set_int64_elem( + config_setting_t *setting, int idx, long long value); +extern LIBCONFIG_API config_setting_t *config_setting_set_float_elem( + config_setting_t *setting, int idx, double value); +extern LIBCONFIG_API config_setting_t *config_setting_set_bool_elem( + config_setting_t *setting, int idx, int value); +extern LIBCONFIG_API config_setting_t *config_setting_set_string_elem( + config_setting_t *setting, int idx, const char *value); + +#define /* const char * */ config_get_include_dir(/* const config_t * */ C) \ + ((C)->include_dir) + +#define /* int */ config_setting_type(/* const config_setting_t * */ S) \ + ((S)->type) + +#define /* int */ config_setting_is_group(/* const config_setting_t * */ S) \ + ((S)->type == CONFIG_TYPE_GROUP) +#define /* int */ config_setting_is_array(/* const config_setting_t * */ S) \ + ((S)->type == CONFIG_TYPE_ARRAY) +#define /* int */ config_setting_is_list(/* const config_setting_t * */ S) \ + ((S)->type == CONFIG_TYPE_LIST) + +#define /* int */ config_setting_is_aggregate( \ + /* const config_setting_t * */ S) \ + (((S)->type == CONFIG_TYPE_GROUP) || ((S)->type == CONFIG_TYPE_LIST) \ + || ((S)->type == CONFIG_TYPE_ARRAY)) + +#define /* int */ config_setting_is_number(/* const config_setting_t * */ S) \ + (((S)->type == CONFIG_TYPE_INT) \ + || ((S)->type == CONFIG_TYPE_INT64) \ + || ((S)->type == CONFIG_TYPE_FLOAT)) + +#define /* int */ config_setting_is_scalar(/* const config_setting_t * */ S) \ + (((S)->type == CONFIG_TYPE_BOOL) || ((S)->type == CONFIG_TYPE_STRING) \ + || config_setting_is_number(S)) + +#define /* const char * */ config_setting_name( \ + /* const config_setting_t * */ S) \ + ((S)->name) + +#define /* config_setting_t * */ config_setting_parent( \ + /* const config_setting_t * */ S) \ + ((S)->parent) + +#define /* int */ config_setting_is_root( \ + /* const config_setting_t * */ S) \ + ((S)->parent ? CONFIG_FALSE : CONFIG_TRUE) + +extern LIBCONFIG_API int config_setting_index(const config_setting_t *setting); + +extern LIBCONFIG_API int config_setting_length( + const config_setting_t *setting); +extern LIBCONFIG_API config_setting_t *config_setting_get_elem( + const config_setting_t *setting, unsigned int idx); + +extern LIBCONFIG_API config_setting_t *config_setting_get_member( + const config_setting_t *setting, const char *name); + +extern LIBCONFIG_API config_setting_t *config_setting_add( + config_setting_t *parent, const char *name, int type); +extern LIBCONFIG_API int config_setting_remove(config_setting_t *parent, + const char *name); +extern LIBCONFIG_API int config_setting_remove_elem(config_setting_t *parent, + unsigned int idx); +extern LIBCONFIG_API void config_setting_set_hook(config_setting_t *setting, + void *hook); + +#define config_setting_get_hook(S) ((S)->hook) + +extern LIBCONFIG_API config_setting_t *config_lookup(const config_t *config, + const char *path); +extern LIBCONFIG_API config_setting_t *config_lookup_from( + config_setting_t *setting, const char *path); + +extern LIBCONFIG_API int config_lookup_int(const config_t *config, + const char *path, int *value); +extern LIBCONFIG_API int config_lookup_int64(const config_t *config, + const char *path, + long long *value); +extern LIBCONFIG_API int config_lookup_float(const config_t *config, + const char *path, double *value); +extern LIBCONFIG_API int config_lookup_bool(const config_t *config, + const char *path, int *value); +extern LIBCONFIG_API int config_lookup_string(const config_t *config, + const char *path, + const char **value); + +#define /* config_setting_t * */ config_root_setting( \ + /* const config_t * */ C) \ + ((C)->root) + +#define /* void */ config_set_default_format(/* config_t * */ C, \ + /* short */ F) \ + (C)->default_format = (F) + +#define /* short */ config_get_default_format(/* config_t * */ C) \ + ((C)->default_format) + +#define /* void */ config_set_tab_width(/* config_t * */ C, \ + /* unsigned short */ W) \ + (C)->tab_width = ((W) & 0x0F) + +#define /* unsigned char */ config_get_tab_width(/* const config_t * */ C) \ + ((C)->tab_width) + +#define /* unsigned short */ config_setting_source_line( \ + /* const config_setting_t * */ S) \ + ((S)->line) + +#define /* const char */ config_setting_source_file( \ + /* const config_setting_t * */ S) \ + ((S)->file) + +#define /* const char * */ config_error_text(/* const config_t * */ C) \ + ((C)->error_text) + +#define /* const char * */ config_error_file(/* const config_t * */ C) \ + ((C)->error_file) + +#define /* int */ config_error_line(/* const config_t * */ C) \ + ((C)->error_line) + +#define /* config_error_t */ config_error_type(/* const config_t * */ C) \ + ((C)->error_type) + +#ifdef __cplusplus +} +#endif /* __cplusplus */ + +#endif /* __libconfig_h */ diff --git a/include/mapper.h b/include/mapper.h new file mode 100644 index 0000000000000000000000000000000000000000..e4fb31819e225f0dbcd65df45818fb3c9de84b84 --- /dev/null +++ b/include/mapper.h @@ -0,0 +1,92 @@ +/** @file mapper.h + * @brief Definitions for mapper objects. + * + * A mapper objects defines how and what to map between two grid families. + * For example, a mapper object can be used to map the charge from + * a @a cdr grid to a @a Poisson grid, or to map the @a potential of a Poisson + * grid into one of the components of the @a electric field in a @a cdr grid. + * For that, a mapper object has to implement some methods that tell us + * how to map things in the cases\n + * a) the source grid is coarser than the target grid (interpolation),\n + * b) the source and the target are at the same level (copy),\n + * c) the target grid is coarser (coarsening). + */ + +#ifndef _MAPPER_H_ + +typedef struct mapper_t mapper_t; + +#ifndef _INTERPOL2_H_ +# include "interpol2.h" +#endif + +#define _coarsen_params_ (mapper_t *mapper, grid_t *source, grid_t *target, \ + int ir, int iz, int itheta) +#define _copy_params_ (mapper_t *mapper, grid_t *source, grid_t *target, \ + int ir, int iz, int itheta) +#define _interpol_set_params_ (mapper_t *mapper, grid_t *source, \ + interpol_t *interpol, int ir, \ + int iz, int itheta) +#define _interpol_params_ (mapper_t *mapper, grid_t *source, grid_t *target, \ + interpol_t *interpol, int ir, int iz, int itheta) + + +struct mapper_t { + interpol_method_t *interpol_method; + + void (*coarsen) _coarsen_params_; + void (*copy) _copy_params_; + /* may return false if we are outside the source grid. */ + int (*interpol_set) _interpol_set_params_; + + void (*interpol) _interpol_params_; + + /* This is used for the interpolation of electric fields and indicates + * the staggering of the cells. When we call the interpolator to set + * the stencil at coordinates pr, pz, the fine-grid cells whose value will + * later be calculated ir, iz with + * pr << level_diff + shift_r << (level_diff - 1) <= ir + * < pr << level_diff + shift_r << (level_diff - 1) + * + * (and the equivalent for iz). + * Hence note that for interpolation in not-staggered grids, + * (i.e. charge, densities, ...) + * shift_r = shift_z = 0. + */ + int shift_r, shift_z; + + /* We provide this extra member to allow the easy creation of different + * mappers that share the same functions but have a slightly different + * behaviour. In particular this is used in cdr.c to define + * different interpolators for each species. In that case, extra is the + * species index. + */ + int extra; +}; + + +/** Usually, we will define functions called xxxx_coarsen, xxxx_copy, etc + to implement the above interface. We define these macros to facilitate + the declaration of such functions. */ +#define decl_mapper_funcs(_VAR) \ + void _VAR ## _coarsen _coarsen_params_; \ + void _VAR ## _copy _copy_params_; \ + int _VAR ## _interpol_set _interpol_set_params_; \ + void _VAR ## _interpol _interpol_params_ + +/** Useful to init a staggered mapper object */ +#define mk_mapper_staggered(_C, _INTERPOL_METHOD, _SHIFT_R, _SHIFT_Z) \ + {_INTERPOL_METHOD, _C ## _coarsen, _C ## _copy, \ + _C ## _interpol_set, _C ##_interpol, _SHIFT_R, _SHIFT_Z, 0} + +/** Useful to init a mapper object */ +#define mk_mapper(_C, _INTERPOL_METHOD) \ + mk_mapper_staggered (_C, _INTERPOL_METHOD, 0, 0) + +/** Mappers that only copy or interpolate. */ +#define mk_mapper_down(_C, _INTERPOL_METHOD) \ + {_INTERPOL_METHOD, NULL, _C ## _copy, \ + _C ## _interpol_set, _C ##_interpol, 0, 0, 0} + +#define _MAPPER_H_ +#endif diff --git a/include/parameters.h b/include/parameters.h new file mode 100644 index 0000000000000000000000000000000000000000..f90741aba7dc3e0f56d081a0fe70505f474413fd --- /dev/null +++ b/include/parameters.h @@ -0,0 +1,64 @@ +/** @file parameters.h + * @brief The declarations of all global parameters, i.e. those + * that the user should be able to set. + * + */ + +#include +#include +#include +#include +#include + +#ifndef _CSTREAM_H_ +# include "cstream.h" +#endif + +#ifndef _RZ_ARRAY_H_ +# include "rz_array.h" +#endif + +#ifndef _PARAMETERS_H_ + +/** @brief These are the global parameters. */ +char* prog_id; +char* output_dir; +char* kin_input; +char* load_file; +char* photoionization_file; + +int cdr_bnd_bottom,cdr_bnd_right,cdr_bnd_top, + cdr_brick_dr,cdr_brick_dz,cdr_max_level,cdr_interp_bnd,cdr_interp_in, + extra_photo_levels,extra_pois_levels,extra_photo_levels_2, + gridpoints_r,gridpoints_z, + has_photoionization, + max_disk_space,max_disk_space_mb,max_levels,max_ntheta, + perturb_max_k,photo_bnd_bottom,photo_bnd_bottom_2, + photo_bnd_right,photo_bnd_right_2, + photo_bnd_top,photo_bnd_top_2,photo_bnd_top_2_st, + photo_max_level,photo_max_level_2, + pois_bnd_bottom,pois_bnd_top,pois_bnd_right, + pois_inhom,pois_inhom_reflections,pois_max_level, + cdr_output_margin,pois_output_margin, + restart,ref_level_eabs,spec_total,sprite_module,sprite_sign; + +double attachment_rate,attachment_E0, + attempt_dt,diffusion_coeff, + background_ionization,background_increase_length, + constant_source,dens_decay_len, + end_t,E0_x,E0_y,E0_z,L_r,L_z, + needle_length,needle_radius,nu_a,nu_d,nu_f,nu_rt, + off_time,output_dt, + perturb_epsilon, + photo_max_error,photo_max_error_2, + pois_inhom_fixed_q,pois_max_error, + ref_threshold_charge,ref_threshold_dens,ref_threshold_eabs, + ref_threshold_edge, + rise_time,start_t, + seed_sigma_x,seed_sigma_y,seed_sigma_z,seed_N, + sprite_dens_0,sprite_dens_q, + warn_min_timestep; +int pois_output; + +#define _PARAMETERS_H_ +#endif diff --git a/include/photo.h b/include/photo.h new file mode 100644 index 0000000000000000000000000000000000000000..e7dbb90756e28733c9e93565db120c40ec541c2a --- /dev/null +++ b/include/photo.h @@ -0,0 +1,24 @@ +/** @file photo.h + * @brief Auxiliary header file for photo.c. + */ +#ifndef _PHOTO_H_ + +typedef struct photo_term_t photo_term_t; + +struct photo_term_t +{ + double A; + double lambda; + + /* We store the photoionization terms in a linked list. */ + photo_term_t *next; +}; + +/* Photoionization terms. */ +extern photo_term_t *photo_terms; + +#define photo_printf_str "{A = %g, lambda = %g}" +#define photo_printf_args(_T) (_T)->A, (_T)->lambda + +#define _PHOTO_H_ +#endif diff --git a/include/poisson.h b/include/poisson.h new file mode 100644 index 0000000000000000000000000000000000000000..f19c2ac75e24d475d55b4491034625ead869b79e --- /dev/null +++ b/include/poisson.h @@ -0,0 +1,76 @@ +/** @file poisson.h + * @brief Structures and functions for the Poisson solver + */ + +#ifndef _POISSON_H_ + +#include "cstream.h" +#include "rz_array.h" + +#ifndef _GRID_H_ +#include "grid.h" +#endif + +typedef struct pois_grid_t pois_grid_t; + +struct pois_grid_t { + RECT_COORDS; + LEAF_FIELDS(pois_grid_t); + int ext_bound; + + rz_array_t *phi; + rz_array_t *charge; + rz_array_t *error; +}; + +/*!< With this structure we define a "problem" for the Poisson/Helmholtz solver. + * Thus we differentiate between the electrostatic (Poisson) or the + * photo-ionization (Helmholtz) uses. + */ +typedef struct pois_problem_t pois_problem_t; + +struct pois_problem_t { + int max_level; + int extra_levels; + double max_error; + + int bnd_right; + int bnd_top; + int bnd_bottom; +}; + +typedef struct pois_boundaries_t { + REAL *left, *right, *top, *bottom; + int r, z; +} pois_boundaries_t; + +/*!< Note that the electric fields are computed here as the derivatives + * of \f$\phi\f$, and not _minus_ the derivatives. + * + * This is because our \f$\phi\f$ is not actually the electrostatic potential + * in its standard definition but its opposite. This simplifies the computations + * since we can use the charge as the source of the Poisson equation. + */ +#define UNCHECK_ER_RZ(grid_, ir_, iz_) \ + (((RZ(grid_->phi, (ir_) + 1, iz_) - RZ(grid_->phi, ir_, iz_)) \ + / dr[grid_->level])) + +#define UNCHECK_EZ_RZ(grid_, ir_, iz_) \ + (((RZ(grid_->phi, ir_, (iz_) + 1) - RZ(grid_->phi, ir_, iz_)) \ + / dz[grid_->level])) + +/*!< The easiest way (and not too performance costly) is to check the + * boundaries where the field can be calculated. + * + * Note that, if everything is OK, the 0 there that we set should never be + * used again (and hence any number would be ok (use NaN for debugging) */ +#define ER_RZ(grid_, ir_, iz_) \ + (((ir_) < ((grid_)->r1 + 1) && ((ir_) > ((grid_)->r0 - 2)))? \ + UNCHECK_ER_RZ(grid_, ir_, iz_): 0) + +#define EZ_RZ(grid_, ir_, iz_) \ + (((iz_) < ((grid_)->z1 + 1) && ((iz_) > ((grid_)->z0 - 2)))? \ + UNCHECK_EZ_RZ(grid_, ir_, iz_): 0) + +#define _POISSON_H_ +#endif diff --git a/include/proto.h b/include/proto.h new file mode 100644 index 0000000000000000000000000000000000000000..8ed54ad968fd3c9aa610ae55264bc39c51ac64f7 --- /dev/null +++ b/include/proto.h @@ -0,0 +1,263 @@ +/** @file proto.h + * @brief Function prototypes for exported functions. + */ + +#ifndef _RZ_ARRAY_H_ +# include "rz_array.h" +#endif + +/* rz_array.c */ +rz_array_t *rz_new_3d_a (int r0, int z0, int r1, int z1, int ntheta); +rz_array_t *rz_guest (rz_array_t *host, int r0, int z0, int r1, int z1); +void rz_set_zero (rz_array_t *array); +void rz_set_periodic (rz_array_t *array); +void rz_copy_bnd (rz_array_t *from, rz_array_t *to, + int sign, REAL *start_from, REAL *start_to, + int dim0, int inout_from, int inout_to, + int dim1, int dim1_0, int dim1_1, + int dim2, int dim2_0, int dim2_1); +void rz_set_bnd (rz_array_t *array, int sign, REAL *start, int dim0, int inout, + int dim1, int dim1_from, int dim1_to, + int dim2, int dim2_from, int dim2_to); +void rz_free (rz_array_t *array); +void rz_copy (rz_array_t *fro, int rfro, int zfro, + rz_array_t *to, int rto, int zto, + int rn, int zn); +void rz_copy_modes (rz_array_t *fro, int rfro, int zfro, + rz_array_t *to, int rto, int zto, + int rn, int zn, int nmode_fro, int nmode_to); +void rz_dump (rz_array_t *rz_array, const char *fname, const char *mode, + int r0, int z0, int r1, int z1); +void rz_dump_3d (rz_array_t *rz_array, const char *fname, const char *mode, + int r0, int z0, int r1, int z1, int ntheta); +void rz_axis_dump (const char *fname, int x0, int x1, double delta); + + +#ifndef _GRID_H_ +# include "grid.h" +#endif + +/* grid.c */ +int grid_max_depth_r (grid_t *grid); +double grid_rmin_r (grid_t *grid); +void grid_print_r (grid_t *grid, int indent); +int grid_contains (grid_t *grid, int i, int j, int check); +int grid_overlap (grid_t *grid1, grid_t *grid2, int buff1, int buff2, + int *left, int *bottom, int *right, int *top, + int *level_diff); +int grid_overlap_with_shifts (grid_t *grid1, grid_t *grid2, + int buff1, int buff2, + int *left, int *bottom, int *right, int *top, + int *level_diff, int shift_r, int shift_z); +void grid_inherit_ext_bound (grid_t *grid); +grid_t *grid_finest_containing_r (grid_t *grid, double r, double z); +int grid_howmany_children (grid_t *grid); +grid_t *grid_get_child (grid_t *grid, int n); + + +#ifndef _INTERPOL2_H_ +# include "interpol2.h" +#endif + +interpol_t *interpol_new_a (double Lr, double Lz, interpol_method_t *method); +void interpol_free (interpol_t *this); +void interpol_set_stencil (interpol_t *this, double r0, double z0, ...); +void interpol_set_stencil_at (grid_t *grid, + interpol_t *this, double r0, double z0, + rz_array_t *ar, + int ir, int iz, int itheta); +void interpol_set_coeffs (interpol_t *this); +double interpol_apply (interpol_t *this, double r, double z); + +#ifndef _MAPPER_H_ +# include "mapper.h" +#endif + +void map_grid (mapper_t **mappers, grid_t *source, grid_t *target, int ntheta, + int copy, int interpol, int coarsen, int s_buff, int t_buff); +void map_grid_r (mapper_t **mappers, grid_t *source, grid_t *target, + int ntheta, int copy, int interpol, int coarsen, + int s_buff, int t_buff); +void map_trees_r (mapper_t **mappers, grid_t *source, grid_t *target, + int ntheta, int copy, int interpol, int coarsen, + int s_buff, int t_buff); + +#ifndef _CDR_H_ +# include "cdr.h" +#endif + +#ifndef _POISSON_H_ +# include "poisson.h" +#endif + +/* cdr.c */ +void cdr_init (void); +void cdr_end (void); + +cdr_grid_t *cdr_new_3d_a (int r0, int z0, int r1, int z1, int ntheta); +cdr_grid_t *cdr_like_a (cdr_grid_t *grid); +cdr_grid_t *cdr_clone_a (cdr_grid_t *grid); +void cdr_set_periodic (cdr_grid_t *grid); +void cdr_free (cdr_grid_t *grid); +void cdr_free_r (cdr_grid_t *grid); +void cdr_calc_charge (cdr_grid_t *grid); +void cdr_calc_charge_r (cdr_grid_t *root); +void cdr_dft_charge_r (cdr_grid_t *grid, int sign); +cdr_grid_t *cdr_create_coarser_a (cdr_grid_t *grid); +cdr_grid_t *cdr_add_coarser_grids_a (cdr_grid_t *prev_root, int n); +void cdr_free_coarser_grids (cdr_grid_t *prev_root, int n); +void cdr_add_ext_field (cdr_grid_t *grid); +void cdr_add_ext_field_r (cdr_grid_t *grid); +void cdr_add_inhom_field_r (cdr_grid_t *cdr, double q); +void cdr_calc_eabs (cdr_grid_t *grid); +void cdr_calc_eabs_r (cdr_grid_t *grid); +void cdr_nonegative (cdr_grid_t *grid); +void cdr_nonegative_r (cdr_grid_t *grid); +pois_grid_t **cdr_calc_field_r (cdr_grid_t *grid, int return_pois); +void cdr_set_ext_bnd (cdr_grid_t *grid); +void cdr_set_ext_bnd_r (cdr_grid_t *grid); +void cdr_calc_d_dens (cdr_grid_t *grid); +void cdr_calc_d_dens_r (cdr_grid_t *grid); +void cdr_advect_diffu (cdr_grid_t *grid); +void cdr_advect_diffu_r (cdr_grid_t *grid); + +double cdr_courant (cdr_grid_t *grid); +void cdr_update (cdr_grid_t *orig, cdr_grid_t *dest, double h); +void cdr_rk2_update (cdr_grid_t *dens_0, cdr_grid_t *d_dens_1, + cdr_grid_t *d_dens_2, cdr_grid_t *dest, + double h); +void cdr_rk2_update_r (cdr_grid_t *dens_0, cdr_grid_t *d_dens_1, + cdr_grid_t *d_dens_2, cdr_grid_t *dest, + double h); +void cdr_self_update_r (cdr_grid_t *grid, double h); +void cdr_like_update_ar (cdr_grid_t *grid, cdr_grid_t *new_grid, double h); +double cdr_rk2 (cdr_grid_t *grid, double h, double t); + +void cdr_update_refined (cdr_grid_t **ptree); +void cdr_calc_maxs (cdr_grid_t *grid); +void cdr_refine (cdr_grid_t *grid); +void cdr_refine_r (cdr_grid_t *grid, cdr_grid_t *source); +void cdr_match_r (cdr_grid_t *grid1, cdr_grid_t *grid2); +void cdr_set_bnd (cdr_grid_t *grid); +void cdr_set_bnd_r (cdr_grid_t *grid); + +void cdr_restrict (cdr_grid_t *grid); +void cdr_restrict_r (cdr_grid_t *grid); + +void cdr_set_dens (cdr_grid_t *cdr, int species, int mode, double factor, + double (*f) (double, double, double)); +void cdr_init_dens (cdr_grid_t *cdr); +cdr_grid_t *cdr_scratch_init (void); + +mapper_t **cdr_mappers_a (interpol_method_t *interp_method); +void cdr_free_mappers (mapper_t **mappers); + +void cdr_dump (cdr_grid_t *grid, const char *prefix, const char *name); +void cdr_dump_r (cdr_grid_t *grid, const char *prefix, const char *name, + FILE *infp, double sim_time); +cdr_grid_t *cdr_load_tree_r (const char *prefix, const char *name, FILE *infp); +void cdr_dump_frames (cdr_grid_t *grid, const char *prefix, const char *name); + +/* poisson.c */ +void pois_init (void); +pois_grid_t *pois_new_a (int r0, int z0, int r1, int z1); +pois_grid_t *pois_new_3d_a (int r0, int z0, int r1, int z1, int ntheta); +void pois_free (pois_grid_t *grid); +void pois_free_r (pois_grid_t *grid); +pois_grid_t *pois_new_glob_a (int r0, int z0, int r1, int z1, int level); +pois_grid_t *pois_init_tree_a (int r0, int z0, int r1, int z1); +REAL *pois_boundary_a (pois_grid_t *grid, int boundary); +void pois_solve_grid (pois_grid_t *grid, pois_problem_t *prob, + double lambda, double s); +void pois_set_phi_boundaries (pois_grid_t *grid, REAL *boundaries[], + int left_uns, int right_neu, int bottom_neu, + int top_neu); +int pois_map_charge (pois_grid_t *pois, cdr_grid_t *cdr, int mode); +void pois_set_error (pois_grid_t *grid); +int pois_refine (pois_grid_t *grid, double threshold); +pois_grid_t **pois_solve_a (cdr_grid_t *cdr, pois_problem_t *prob); +pois_grid_t **pois_gen_solve_a (cdr_grid_t *cdr, pois_problem_t *prob, + mapper_t **mappers, double es); +pois_grid_t *pois_solve_mode (cdr_grid_t *tree, cdr_grid_t *cdr, + pois_problem_t *prob, int mode, double es); +void pois_solve_r (pois_grid_t *pois, cdr_grid_t *cdr, pois_problem_t *prob, + int mode, double es, double threshold); +double pois_phi_at (pois_grid_t *grid, double r, double z, double theta); +void pois_dump (pois_grid_t *grid, const char *prefix, const char *name); +void pois_dump_r (pois_grid_t *grid, const char *prefix, const char *name); +void pois_write_error_r (pois_grid_t *grid, FILE *fp); +void pois_error_measures (pois_grid_t *grid, double *L1, double *L2, + double *Lmax); +void pois_inhom_init (void); +double pois_inhom_phi (double r, double z); +double pois_inhom_er (double r, double z); +double pois_inhom_ez (double r, double z); +double pois_inhom_q_factor (pois_grid_t *pois); +void pois_add_inhom_phi_r (pois_grid_t *grid, double q); + +#ifndef _PHOTO_H_ +# include "photo.h" +#endif + +/* photo.c */ +void photo_init (); +void photo_register (double A, double lambda); +void photo_copy_list (photo_term_t *src, photo_term_t **dest); +void photo_unregister_all (void); +void photo_dft_r (cdr_grid_t *grid, int sign); +void photo_copy_source (cdr_grid_t *grid); +void photo_add_term (photo_term_t *term, cdr_grid_t *cdr); +void photo_add_term_r (photo_term_t *term, cdr_grid_t *cdr); +pois_grid_t **photo_calc_term (photo_term_t *term, cdr_grid_t *cdr, int i); +void photo_calc (photo_term_t *terms, cdr_grid_t *cdr); +void photo_load_file (char *fname); + +/* cstream.c */ +void init_parameters(void); +void cstream_init (void); +void cstream_end (void); +void cstream_set_field_at_time (double t); + +/* dft.c */ +void dft_transform (rz_array_t *in, rz_array_t *out, int sign); +void dft_diff (grid_t *grid, rz_array_t *f); +void dft_weight (cdr_grid_t *cdr, rz_array_t *var, double weights[], + double power); +void dft_out_weights (cdr_grid_t *grid, const char *prefix, double t); +void dft_perturb (cdr_grid_t *cdr, rz_array_t *var, double *epsilon_k); +void dft_dens_perturb_r (cdr_grid_t *grid, int species, double *epsilon_k); + + +#ifndef _REACTION_H_ +# include "reaction.h" +#endif + +/* reaction.c */ +int find_species_by_name(const char *spec_name); +void react_add (reaction_t *react); +void react_init (); +void react_apply_r (reaction_t *react, cdr_grid_t *grid, int overwrite); +void react_apply_all (cdr_grid_t *grid); + +#ifndef _REACT_TABLE_H_ +# include "react_table.h" +#endif + +/* kinetic module (usually minimal.c) */ +void kinetic_init (void); + +/* sprites module */ +double spr_density_at (double altitude); +void spr_init (); +void spr_hook (cdr_grid_t *grid); +void spr_update (double altitude); +double spr_head_altitude (cdr_grid_t *grid, int sign); + +/* rt.c */ +void kinetic_init (void); +void read_input_file(const char *f_kinetic_name, const char *filename); + + + + + diff --git a/include/react_table.h b/include/react_table.h new file mode 100644 index 0000000000000000000000000000000000000000..b897485d5d1f51956329cbc4ac70fcb9a25fd595 --- /dev/null +++ b/include/react_table.h @@ -0,0 +1,23 @@ +/** @file react_table.h + * @brief Maximum size of lookup tables. + */ +#ifndef _REACT_TABLE_H_ +#define MAX_TABLE_SIZE 500 + +typedef struct react_table react_table; + +struct react_table +{ + double e_min; + double e_step; + + double underflow; + double overflow; + + int steps; + + double values[MAX_TABLE_SIZE]; +}; + +#define _REACT_TABLE_H_ +#endif diff --git a/include/reaction.h b/include/reaction.h new file mode 100644 index 0000000000000000000000000000000000000000..dd2b9f3e6a666a7a99dcf165f673674142fcc2a6 --- /dev/null +++ b/include/reaction.h @@ -0,0 +1,53 @@ +/** @file reaction.c + * @brief Header file to define reactions. + */ +#ifndef _REACTION_H_ +#include "react_table.h" + +typedef struct reaction_t reaction_t; + +/* Maximum number of reactants that can enter into a reaction. */ +#define REACTION_MAX_IN 4 +#define REACTION_MAX_OUT 6 + +struct reaction_t { + /* Photoionization is an special reaction where all the other parameters + * are ignored. Be careful to put photoionization in the correct position + * of the reaction list. + */ + int is_photo; + + /* Number of species in and out. */ + int nin, nout; + + int input[REACTION_MAX_IN]; + int output[REACTION_MAX_OUT]; + + const char *inname[REACTION_MAX_IN]; + const char *outname[REACTION_MAX_OUT]; + + + void (*f) (double *in, int nin, double *out, int nout, double k, double dens, react_table *rt); + + /* For reactions where k(E) is given by a reaction table. Such reactions + * require 'f' to be f_react_table. 'k' is ignored for these reactions. + * 'rt' is initialized with 'NULL', while 'tablefile' contains the filename + * with the reaction table. + * + * This file is read in react_add(). + */ + react_table *rt; + + char *tablefile; + + double k; + + /* This allows us to define many simultaneous reactions. */ + reaction_t *next; +}; + +extern reaction_t *reactions_list; +extern reaction_t *reaction_index[]; + +#define _REACTION_H_ +#endif diff --git a/include/rz_array.h b/include/rz_array.h new file mode 100644 index 0000000000000000000000000000000000000000..5cd4b08809e2566805fedd09cb3c0e7a349334ba --- /dev/null +++ b/include/rz_array.h @@ -0,0 +1,86 @@ +/** @file rz_array.h + * @brief Definitions for 2D/3D arrays + */ + +#ifndef _RZ_ARRAY_H_ + +#include "cstream.h" + +typedef struct rz_array_t rz_array_t; + +struct rz_array_t { + REAL *data; + + int strides[3]; + int r0, z0, theta0, nr, nz; + int ntheta; + int dim; + + int len; + + rz_array_t *host; +}; + +#define R_INDX 0 +#define Z_INDX 1 +#define THETA_INDX 2 + +/* The 3D macros */ +#define RZTP_OK(_A, _R, _Z, _T) \ + ((_R) >= (_A)->r0 && (_R) < (_A)->nr + (_A)->r0 + 4 \ + && (_Z) >= (_A)->z0 && (_Z) < (_A)->nz + (_A)->z0 + 4 \ + && (_T) >= (_A)->theta0 && (_T) < (_A)->ntheta + (_A)->theta0 + 4) \ + +#define __RZTP(_A, _R, _Z, _T) ((_A)->data \ + + ((_R) - (_A)->r0) * (_A)->strides[R_INDX] \ + + ((_Z) - (_A)->z0) * (_A)->strides[Z_INDX] \ + + (((_T) - (_A)->theta0) * (_A)->strides[THETA_INDX])) + +#if defined (DEBUG_LEVEL) && DEBUG_LEVEL > 4 +/* Look, mum! I am also doing array bound checking. + * But, alas, since in some parts of the code we perform direct pointer + * arithmetic, this check will not detect all possible out-of-indexes + * (but we catch most of them). + */ +# define RZTP(_A, _R, _Z, _T) (RZTP_OK (_A, _R, _Z, _T)? \ + __RZTP (_A, _R, _Z, _T): \ + (fprintf (stderr, \ + "%s:%d: Out of bounds ir = %d, iz = %d, itheta = %d\n", \ + __FILE__, __LINE__, _R, _Z, _T), \ + fprintf (stderr, \ + "->r0 = %d ->z0 = %d ->theta0 = %d ->nr = %d ->nz = %d ->ntheta = %d\n", \ + (_A)->r0, (_A)->z0, (_A)->theta0, \ + (_A)->nr, (_A)->nz, (_A)->ntheta), \ + exit(-1), (double*) NULL)) +#else +# define RZTP(_A, _R, _Z, _T) __RZTP(_A, _R, _Z, _T) +#endif + +#define RZT(_A,_R,_Z,_T) (*RZTP(_A, _R, _Z, _T)) +#define RZTm(_A,_R,_Z,_T) ((fprintf (stderr, \ + "%s:%d: CHECK ir = %d, iz = %d, itheta = %d\n", \ + __FILE__, __LINE__, _R, _Z, _T), \ + fprintf (stderr, \ + "->r0 = %d ->z0 = %d ->theta0 = %d ->nr = %d ->nz = %d ->ntheta = %d\n", \ + (_A)->r0, (_A)->z0, (_A)->theta0, \ + (_A)->nr, (_A)->nz, (_A)->ntheta), \ + fprintf (stderr, \ + "->data = %g\n", \ + (_A)->data), \ + exit(-1), (double*) NULL)) + + +/* These are valid for 2D arrays. When applied to a 3D array, they + * return the value with theta=0. + */ +#define RZP(_A,_R,_Z) RZTP(_A, _R, _Z, (_A)->theta0) +#define RZ(_A,_R,_Z) RZT(_A, _R, _Z, (_A)->theta0) + +#define BND_CND_HNEUMANN 1 +#define BND_CND_HDIRICHLET -1 + +#define BND_INWARD -1 +#define BND_OUTWARD 1 + +#define _RZ_ARRAY_H_ +#endif diff --git a/include/species.h b/include/species.h new file mode 100644 index 0000000000000000000000000000000000000000..5587641dd44fa25dc2dafd73ffa26aadd2d48f36 --- /dev/null +++ b/include/species.h @@ -0,0 +1,62 @@ +/** @file species.h +/* @brief include file describing the structs specie_t and seed_t + */ + +#ifndef _SPECIES_H_ + +#include "cstream.h" + +/*!< Number of virtual species. */ +#define N_VIRTUAL_SPECIES 1 + +/*!< Information about each of the species. */ +typedef struct species_t { + double charge; + double mass; /* Zero or negative mass means immobile particles. */ + + const char *name; +} species_t; + +/*!< Initial seeds for species. Only used at start-up */ +typedef struct seed_t { + int species; + const char *kind_species; + double value; + int type; + const char *kind_type; + double x0; + double y0; + double z0; + double sigma_x; + double sigma_y; + double sigma_z; +} seed_t; + +extern species_t spec_electrons; +extern species_t spec_ions; + +/*!< species[i] points to a species_t structure for species number I */ +extern species_t *spec_index[]; + +extern seed_t *seed_index[]; + +int no_seed, no_reactions, no_species; + +/*!< These are the index of two @a special species (that sounds strange, uh?) + * + * For example, electrons and ions are the species that are initialized + * with a gaussian seed, and photo_ions those that are affected by photo- + * ionization. Their values are set in the kinetic model file (usually + * minimal.c, but more complex models are possible). + */ +int electrons, ions, photo_ions; + +/*!< There is also a @a virtual species: Just to make it easy to create + * reaction functions that depend on variables other than species densities. + * Now this trick is only used for @a eabs absolute value of the electric + * field. + */ +extern const int virt_eabs; + +#define _SPECIES_H_ +#endif diff --git a/include/tree.h b/include/tree.h new file mode 100644 index 0000000000000000000000000000000000000000..0b11ebe0ea8c24a8eee8a24dfc311196328f75ec --- /dev/null +++ b/include/tree.h @@ -0,0 +1,94 @@ +/** @file tree.h + * @brief Structures and function definitions to handle a tree structure. + */ + +/*!< These fields are included as the first fields of any structure that + * we want to convert into leaves of a tree. For people familiar with object + * orientation, this is equivalent to defining a class @a leaf and make + * other structures derive from it. + * The idea here is that we can share the code for the management of + * the tree structure of the grids both for the poisson and the cdr parts. + */ + +#ifndef _TREE_H_ + +#define LEAF_FIELDS(X) \ + X *parent; \ + X *next; \ + X *first_child; \ + int level; \ + +#define LEAF_ROOT 0 + +/*!< Iterate over all childs of a node. Simply write + * + * leaf_t leaf; + * + * iter_childs (node, leaf) { + * do_something (leaf); + * } + */ +#define iter_childs(ROOT, LEAF) for (LEAF = ROOT->first_child; LEAF; \ + LEAF = LEAF->next) + +/*!< iter_child may not work if in the loop body we make free(LEAF) + * (though this will go unnoticed most of the time). So when + * freeing grids, the following macro has to be used instead: + */ +#define free_childs(ROOT, LEAF, FREE) do { \ + grid_t *next__; \ + for (LEAF = ROOT->first_child; LEAF; LEAF = (typeof(LEAF)) next__) { \ + next__ = ((grid_t *) LEAF)->next; \ + FREE (LEAF); \ + } \ + } while(0) + +/*!< This is used to put into a leaf any set of values. */ +#define set_leaf(LEAF, PARENT, NEXT, FIRST_CHILD, LEVEL) do { \ + LEAF->parent = PARENT; \ + LEAF->next = NEXT; \ + LEAF->first_child = FIRST_CHILD; \ + LEAF->level = LEVEL; \ + } while(0) + +#define init_leaf(LEAF) set_leaf(LEAF, NULL, NULL, NULL, -1) + +/*!< Sometimes we have to remove all of a leaf's children. After freeing + * them with free_childs, call this one. + */ +#define set_childless(LEAF) (LEAF)->first_child = NULL + +/*!< Adds a child to a given leaf. */ +#define add_child(PARENT, CHILD) do { \ + set_leaf(CHILD, PARENT, PARENT->first_child, CHILD->first_child, \ + PARENT->level + 1); \ + PARENT->first_child = CHILD; \ + } while(0) + +/*!< Given a function name, creates a function with the same name plus `_r' + * that (tail- in the second case) recursively calls the first. + * Can only be applied on functions that receive as single parameter a + * grid of type `type'. + */ +#define mk_recursive(func, type) \ + void func ## _r (type *grid_) \ + { \ + type *child_; \ + func (grid_); \ + iter_childs (grid_, child_) { \ + func ## _r (child_); \ + } \ + } + +#define mk_tail_recursive(func, type) \ + void func ## _r (type *grid_) \ + { \ + type *child_; \ + iter_childs (grid_, child_) { \ + func ## _r (child_); \ + } \ + func (grid_); \ + } + +#define _TREE_H_ +#endif diff --git a/input/.default.cfg.swp b/input/.default.cfg.swp new file mode 100644 index 0000000000000000000000000000000000000000..9ac7b0dad19c9ba20b19952ee9a86eb819794299 GIT binary patch literal 16384 zcmeI3dx#xZ9mi*DAGS$sjG)x#>GqE#baVG^o?@-0Xr!U0t=puEio>~g&b{|!=W#QS zeWj1of)+%uVxOW_h_C)pDu$x}R7(-5Py-dKqP1WJOIuP5*1v-FbLNrVow>W4o5VlF zx$xmGb7s!@&G-DyZ_e*GcU#R{_wEzB8rv;C>n-cm*(Yv!;qv#5yt2)*x}l1tIljs# z)?N@cBIP&QGrHls%bk8l+Tr+o;HhxD-;-fGh{mXFDM`#%i2M|-!laO-v1Z*|B1^j>m_&*ehtUqPUt}k zz5sin32Whvw^`Qf@G3kHPr^gchl9|8{qPa^%R0+C4$r_Z;c<8nCg4hV54;O5fLGR9 z)}!zM+zVfY!yw_^um&!I5qNzK{leW4gAWJcGq4N(ewk(c0iJ{3z|Y_zxCS=CD7+um z!fTh(4oBhJ@G#s19()Kk!&UGBSO+KHYFR&r$KZ!>6uu5~up1`eYS;)H;M67P0MEj& z;Awaa9)=^}Lk}Fd33kGXi!JNV@H{*Rzku(+6nq|Tg-O^A8{wskEbF)MEIb3p-~qTE zcEC7X4OhUa3oYvj_yK$uz6D=_gD?i~g?GXRu;8y0bnb&M!4bF(y091ifiJxXe}vz` z(_sATD4f+t@bRUm#I<6y-wWcvZuyQK>TWL{y~Z-F@mxP`)qZy5Fh_466KUJDbQ9Cq zY&0jbv)h5^DL*#d?Fqvm6mc(9Q7>>E{*tk9m2@Hz2O?A*?W^=$?bD`2I{X$L_S+@}`D35Gf%=OLv8zcr6u*o(eNpU08vqRT^f} zwpJ!>&mi|HbXdu2j2uHd%?{?NV#0NCth|1#SoYdeQLOq6A@;M%Wjju!d-|yG0-EvWuqkXx2?jBq`!_ zs+#e%wwpLiT&`El?utP3(UL`rlp02&#>9Z7zTfy6%Bqn4UAq0qCk=NeRL_K(xXf$@ z!nk?KkbJg=4cVi4H;eXmZ3lnD}ENz|F!L&BNC`kLF6&x`A|T(@9CRC=QFYa(K{ww-O|lGd3bryV-VjM!PP1 zTBgru(_AuIE-|}gWiCU>#+7`3H2dxM6kF_Aw{0~my}ql=Z@}|T7U_ILc9L14W@Ro? zqj-qWjh!}@ELcUQ(aaadt3&1<@90pq;~<=Ci2R&l#KMboIe@P=WPYdBA+PfV@d)ud zx}D8OI##y1#=mfuk_{$;+S{v7knB%0lVSDun{hWr^xLehezT2@C}%SQCJU`!Nu@T@_Lj1 z-w$7gyWn={!42>xdHe}@8U6;x;U{n}9D#Y51_^s$6y6SN;1YNP4gUnUfeS`c2kK9) zK&?QnK&?Qn!2hKJ)MCZvY&TjIV+Yg|Z_!;+vMl9_`t08o)hC&kWM?SKkWO|2*9~S& zqOmE>)6Bk^T`GH4KZwn~KUA)kMR|3hW|j44M+{NgDy_6Z9aJ;=RHFQL&se}lEz*_E zdOnhAv=5cWS|v{%G~CCtK}-o_-qf)39*d3K;?at>ViR~4qkU5O)YQ!+sM&ttXIUIK z+NS=M&rE*TVrHDAJ`mE4b(}awYEsyh-hO%=rMj}@s~J|wTPB2F;uh495>hHQ#1!iE zw4{PJCYlRb)L@aat4dR{()3R>w^qxiH>)sC!j=epcP=YtiKK6o=w}US5qU~%N^6Bh z6?LH*!Q9Oy`<7fegnfhjr6}>`eP&4n!<*H@YlLWyHy@;pZIk15bT(1_j?>Yz z#%WB{=#XEN?h;ZK<-vG+cCsVdZjewK;*0z|mr{}N_e7M09V%^=`7{L~?e_wYtes(o zjRV`8gJyP8I+}Vxz6^b(oYMt?V%22_?JzyFGaK9HVNs=xM~qIttVwd^QO)vO~=2A;&S0OE3WWLs4*`<%vzyqKi<-JrLRO+ z@gM7PI5)7Il@4FJ?UjZcG_?yVFAlpD)j}n)Cs&`6(c%}6n@m+e#$FKhc?eQ3aMN() YMrC(w$@Ww?3=-ZU6kVF2oXysM0HUev6#xJL literal 0 HcmV?d00001 diff --git a/input/air760torr.photo b/input/air760torr.photo new file mode 100644 index 0000000000000000000000000000000000000000..2cf889a844050b2200a7188afa46524e866e6899 --- /dev/null +++ b/input/air760torr.photo @@ -0,0 +1,2 @@ +-8.28556e-10 -4.04047e-06 +-1.2328e-07 -0.000149679 diff --git a/input/default.cfg b/input/default.cfg new file mode 100644 index 0000000000000000000000000000000000000000..bce23673b06426b1b0762454aced6046d7228c5d --- /dev/null +++ b/input/default.cfg @@ -0,0 +1,506 @@ +name = "default"; +param = ( + { + type = "string"; + name = "prog_id"; + comment = "An identification name for this run"; + value = "example"; + }, + { + type = "string"; + name = "output_dir"; + comment = "Output directory. "; + value = "output/"; + }, + { + type = "string"; + name = "kin_input"; + comment = "Kinetics input file"; + value = "input/kinetic_example.cfg"; + }, + { + type = "int"; + name = "restart"; + comment = "If restart is TRUE, the simulation will continue with data from a previous run"; + value = 0; + }, + { + type = "string"; + name = "load_file"; + comment = "If restart is TRUE, the name of the file with data from previous run, otherwise empty"; + value = ""; + }, + { + type = "double"; + name = "output_dt"; + comment = "Time interval for output to be written to disk"; + value = 0.100; + }, + { + type = "int"; + name = "pois_output"; + comment = "Output of the Poisson grids, including the potential?"; + value = 0; + }, + { + type = "int"; + name = "cdr_output_margin"; + comment = "Margin outside the grids in the output of the cdr equation"; + value = 0; + }, + { + type = "int"; + name = "pois_output_margin"; + comment = "Margin outside the grids in the output of the poisson equation"; + value = 1; + }, + { + type = "double"; + name = "warn_min_timestep"; + comment = "If the time steps are smaller than this number, the program issues a warning"; + value = 1e-06; + }, + { + type = "int"; + name = "max_disk_space_mb"; + comment = "Maximum disk space, in Mb, to use"; + value = 1048576; + }, + { + type = "int"; + name = "gridpoints_r"; + comment = "Number of R gridpoints at level 0"; + value = 600; + }, + { + type = "int"; + name = "gridpoints_z"; + comment = "Number of Z gridpoints at level 0"; + value = 600; + }, + { + type = "int"; + name = "max_ntheta"; + comment = "Number of azimuthal gridcells and modes"; + value = 1; + }, + { + type = "double"; + name = "start_t"; + comment = "Initial time"; + value = 0.0; + }, + { + type = "double"; + name = "end_t"; + comment = "End time"; + value = 0.12; + }, + { + type = "double"; + name = "attempt_dt"; + comment = "Attempted timestep. The actual timestep may be larger"; + value = 50.0; + }, + { + type = "int"; + name = "extra_pois_levels"; + comment = "Extra levels for the Poisson solver"; + value = 2; + }, + { + type = "int"; + name = "max_levels"; + comment = "Maximum level of refinement. Use a big number here"; + value = 64; + }, + { + type = "double"; + name = "pois_max_error"; + comment = "Error threshold that leads to refinement in the Poisson code."; + value = 0.001; + }, + { + type = "int"; + name = "pois_max_level"; + comment = "Maximum level of refinement in the Poisson equation."; + value = 3; + }, + { + type = "int"; + name = "extra_photo_levels"; + comment = "Extra levels for the photo-ionization solver"; + value = -1; + }, + { + type = "int"; + name = "photo_max_level"; + comment = "Maximum level of refinement in the photo-ionization solver."; + value = 4; + }, + { + type = "double"; + name = "photo_max_error"; + comment = "Error threshold that leads to refinement in the photo-ionization code."; + value = 0.01; + }, + { + type = "int"; + name = "photo_bnd_right"; + comment = "Photo-ionization boundary condition at r = L_r. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "photo_bnd_bottom"; + comment = "Photo-ionization boundary condition at z = 0. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "photo_bnd_top"; + comment = "Photo-ionization boundary condition at z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "extra_photo_levels_2"; + comment = "Extra levels for the photo-ionization solver"; + value = -1; + }, + { + type = "int"; + name = "photo_max_level_2"; + comment = "Maximum level of refinement in the photo-ionization solver."; + value = 4; + }, + { + type = "double"; + name = "photo_max_error_2"; + comment = "Error threshold that leads to refinement in the photo-ionization code."; + value = 0.01; + }, + { + type = "int"; + name = "photo_bnd_right_2"; + comment = "Photo-ionization boundary condition at r = L_r. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "photo_bnd_bottom_2"; + comment = "Photo-ionization boundary condition at z = 0. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "photo_bnd_top_2"; + comment = "Photo-ionization boundary condition at z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "cdr_bnd_bottom"; + comment = "Particles boundary condition at z = 0. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = 1; + }, + { + type = "int"; + name = "cdr_bnd_top"; + comment = "Particles boundary condition at z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = 1; + }, + { + type = "int"; + name = "cdr_bnd_right"; + comment = "Particles boundary condition at r = L_r. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = 1; + }, + { + type = "int"; + name = "pois_bnd_right"; + comment = "Potential boundary condition at r = L_r. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "pois_bnd_bottom"; + comment = "Potential boundary condition at z = 0. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "pois_bnd_top"; + comment = "Potential boundary condition at z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "double"; + name = "nu_a"; + comment = "Maximum advection Courant number"; + value = 0.2; + }, + { + type = "double"; + name = "nu_d"; + comment = "Maximum diffusion Courant number"; + value = 0.2; + }, + { + type = "double"; + name = "nu_rt"; + comment = "Maximum ratio of dt/relaxation time"; + value = 0.2; + }, + { + type = "double"; + name = "nu_f"; + comment = "Maximum ratio of change of the densities (set to a very large number to ignore)"; + value = 1e+20; + }, + { + type = "double"; + name = "ref_threshold_eabs"; + comment = "Refinement threshold for the electric field"; + value = 0.2; + }, + { + type = "int"; + name = "ref_level_eabs"; + comment = "Maximum refinement level reached through ref_threshold_eabs"; + value = 4; + }, + { + type = "double"; + name = "ref_threshold_charge"; + comment = "Refinement threshold for the curvature of the charge"; + value = 0.004; + }, + { + type = "double"; + name = "ref_threshold_dens"; + comment = "Refinement threshold for the curvature of the densities"; + value = 0.004; + }, + { + type = "double"; + name = "ref_threshold_edge"; + comment = "Refinement threshold for the densities in the leading edge"; + value = 10000.0; + }, + { + type = "int"; + name = "cdr_brick_dr"; + comment = "r-length of the minimal refinement area in the cdr equation"; + value = 8; + }, + { + type = "int"; + name = "cdr_brick_dz"; + comment = "z-length of the minimal refinement area in the cdr equation"; + value = 8; + }, + { + type = "int"; + name = "cdr_max_level"; + comment = "Maximum level of refinement in the Fluid equation."; + value = 3; + }, + { + type = "int"; + name = "cdr_interp_in"; + comment = "Interpolation method for the grid interior (0=zero_masses, 1=quadratic_masses [default], 2=wackers_masses, 3=quadlog"; + value = 1; + }, + { + type = "int"; + name = "cdr_interp_bnd"; + comment = "Interpolation method for the grid boundaries (0=zero_masses, 1=quadratic_masses [default], 2=wackers_masses, 3=quadlog"; + value = 1; + }, + { + type = "double"; + name = "L_r"; + comment = "Length in r of the complete domain"; + value = 13044.0; + }, + { + type = "double"; + name = "L_z"; + comment = "Length in z of the complete domain"; + value = 13044.0; + }, + { + type = "double"; + name = "diffusion_coeff"; + comment = "Isotropic difussion coefficient"; + value = 0.1; + }, + { + type = "int"; + name = "has_photoionization"; + comment = "Whether the code includes photoionization or not"; + value = 1; + }, + { + type = "string"; + name = "photoionization_file"; + comment = "The name of a file from which we can read the photoionization parameters"; + value = "input/air760torr.photo"; + }, + { + type = "double"; + name = "attachment_rate"; + comment = "Rate of dissociative attachment"; + value = 0.0; + }, + { + type = "double"; + name = "attachment_E0"; + comment = "E0 in the exp(-E0/E) factor in the attachment expression."; + value = 0.0; + }, + { + type = "double"; + name = "E0_x"; + comment = "x component of the external electric field"; + value = 0.0; + }, + { + type = "double"; + name = "E0_y"; + comment = "y component of the external electric field"; + value = 0.0; + }, + { + type = "double"; + name = "E0_z"; + comment = "z component of the external electric field"; + value = -0.06; + }, + { + type = "double"; + name = "rise_time"; + comment = "Rise time of the electric field (0 for instantaneous rise)"; + value = 0.0; + }, + { + type = "double"; + name = "off_time"; + comment = "Time to switch off the electric field (0.0 means never)"; + value = 0.0; + }, + { + type = "double"; + name = "seed_sigma_x"; + comment = "x width of the initial seed"; + value = 0.0; + }, + { + type = "double"; + name = "seed_sigma_y"; + comment = "y width of the initial seed"; + value = 0.0; + }, + { + type = "double"; + name = "seed_sigma_z"; + comment = "z width of the initial seed"; + value = 0.0; + }, + { + type = "double"; + name = "seed_N"; + comment = "Number of electrons in the initial seed"; + value = 0.0; + }, + { + type = "double"; + name = "background_ionization"; + comment = "Initial at z=0 densities of electrons and ions"; + value = 0.0; + }, + { + type = "double"; + name = "background_increase_length"; + comment = "Length of exponential increase of the pre-ionization (for atmospherical models)"; + value = 0.0; + }, + { + type = "int"; + name = "pois_inhom"; + comment = "Use the point-plane geometry?"; + value = 1; + }, + { + type = "int"; + name = "pois_inhom_reflections"; + comment = "Number of mirror charges to use"; + value = 4; + }, + { + type = "double"; + name = "needle_length"; + comment = "Length of the needle"; + value = 2500.0; + }, + { + type = "double"; + name = "needle_radius"; + comment = "Radius of the needle"; + value = 400.0; + }, + { + type = "double"; + name = "pois_inhom_fixed_q"; + comment = "If nonzero, the charge is fixed, not floating (simulation of charged clouds close to the earth surface)"; + value = 0.0; + }, + { + type = "double"; + name = "constant_source"; + comment = "Constant ionization rate"; + value = 0.0; + }, + { + type = "double"; + name = "perturb_epsilon"; + comment = "Initial perturbation to the axisymmetric configuration"; + value = 0.0; + }, + { + type = "int"; + name = "perturb_max_k"; + comment = "Perturb only modes up to perturb_max_k (large number to perturb all)"; + value = 1024; + }, + { + type = "int"; + name = "sprite_module"; + comment = "1 if the sprite module is activated, 0 otherwise"; + value = 0; + }, + { + type = "double"; + name = "dens_decay_len"; + comment = "Lenght of exponential decay of the density w/r to altitude"; + value = 0.0; + }, + { + type = "double"; + name = "sprite_dens_0"; + comment = "Density at z = 0"; + value = 0.0; + }, + { + type = "double"; + name = "sprite_dens_q"; + comment = "Quenching density"; + value = 0.0; + }, + { + type = "int"; + name = "sprite_sign"; + comment = "Sign of the sprite head that we are following (the other will not be reliable"; + value = -1; + } ); diff --git a/input/default.diffusion b/input/default.diffusion new file mode 100644 index 0000000000000000000000000000000000000000..cf861a89b8c63c2371642f10b02ef6e817891253 --- /dev/null +++ b/input/default.diffusion @@ -0,0 +1,33 @@ +START +-2.91222e+00 +0.113943e+00 +27 +0.015 +0.13 +0.0152226306 +0.01566884 +0.0163744 +0.0164662 +0.0166058 +0.0169752 +0.0173472 +0.0176621 +0.0175883 +0.0172749 +0.0168534 +0.016438 +0.0159813 +0.0157487 +0.015716 +0.017053 +0.0214515 +0.0300934 +0.0415054 +0.0527951 +0.0619993 +0.0700603 +0.0774594 +0.0852778 +0.0944876 +0.104969 +0.117301 diff --git a/input/default.mobility b/input/default.mobility new file mode 100644 index 0000000000000000000000000000000000000000..3a563e7b4f3bd48465f4ed3d2e16ed1ff05b5fc1 --- /dev/null +++ b/input/default.mobility @@ -0,0 +1,33 @@ +START +-2.91222e+00 +0.113943e+00 +27 +7.0 +0.7 +6.5615252895 +5.9332719211 +5.35874 +4.75762 +4.14641 +3.56977 +3.06845 +2.66783 +2.36204 +2.12783 +1.95148 +1.81282 +1.70094 +1.60616 +1.51537 +1.43021 +1.34845 +1.27194 +1.20157 +1.13616 +1.07396 +1.013 +0.953511 +0.893685 +0.835274 +0.777726 +0.721898 diff --git a/input/elecionrecomb.reaction b/input/elecionrecomb.reaction new file mode 100644 index 0000000000000000000000000000000000000000..ad219b3474a6eb9837cdff4f54283ae085188b8c --- /dev/null +++ b/input/elecionrecomb.reaction @@ -0,0 +1,107 @@ +Reaction table for e-/ion recomb +START +-1.875061e+00 +2.477121e-02 +100 +2.832513e-04 +4.165086e-05 +2.832513e-04 +2.820940e-04 +2.809796e-04 +2.799495e-04 +2.789446e-04 +2.779923e-04 +2.771048e-04 +2.762805e-04 +2.753281e-04 +2.745195e-04 +2.738511e-04 +2.730554e-04 +2.723976e-04 +2.716144e-04 +2.709670e-04 +2.703241e-04 +2.696858e-04 +2.689257e-04 +2.682973e-04 +2.676732e-04 +2.669300e-04 +2.661929e-04 +2.653407e-04 +2.644967e-04 +2.635418e-04 +2.623626e-04 +2.609683e-04 +2.592563e-04 +2.572456e-04 +2.546361e-04 +2.515865e-04 +2.476529e-04 +2.430556e-04 +2.374798e-04 +2.310614e-04 +2.246205e-04 +2.165509e-04 +2.088780e-04 +2.009593e-04 +1.922445e-04 +1.847366e-04 +1.769207e-04 +1.699879e-04 +1.633851e-04 +1.567167e-04 +1.515880e-04 +1.465017e-04 +1.413611e-04 +1.374446e-04 +1.336814e-04 +1.296988e-04 +1.267332e-04 +1.237526e-04 +1.207668e-04 +1.182972e-04 +1.158218e-04 +1.133347e-04 +1.111256e-04 +1.090409e-04 +1.069977e-04 +1.048627e-04 +1.028859e-04 +1.010168e-04 +9.910057e-05 +9.718801e-05 +9.535394e-05 +9.359334e-05 +9.173594e-05 +8.992826e-05 +8.815666e-05 +8.638947e-05 +8.464569e-05 +8.289237e-05 +8.120892e-05 +7.946084e-05 +7.779045e-05 +7.610653e-05 +7.442029e-05 +7.274132e-05 +7.112438e-05 +6.950156e-05 +6.788331e-05 +6.627846e-05 +6.467677e-05 +6.312051e-05 +6.158037e-05 +6.003515e-05 +5.852255e-05 +5.702236e-05 +5.554281e-05 +5.406994e-05 +5.261364e-05 +5.119053e-05 +4.978070e-05 +4.837814e-05 +4.700004e-05 +4.564061e-05 +4.428529e-05 +4.296657e-05 +4.165086e-05 diff --git a/input/example_user_continue.cfg b/input/example_user_continue.cfg new file mode 100644 index 0000000000000000000000000000000000000000..4fe7cceb32cb0514da3a88600c1969b8ddc4ccd7 --- /dev/null +++ b/input/example_user_continue.cfg @@ -0,0 +1,506 @@ +name = "default"; +param = ( + { + type = "string"; + name = "prog_id"; + comment = "An identification name for this run"; + value = "example"; + }, + { + type = "string"; + name = "output_dir"; + comment = "Output directory"; + value = "output"; + }, + { + type = "string"; + name = "kin_input"; + comment = "Kinetics input file"; + value = "input/kinetic_example.cfg"; + }, + { + type = "int"; + name = "restart"; + comment = "If restart is 1 (TRUE), the simulation will continue with data from a previous run"; + value = 0; + }, + { + type = "string"; + name = "load_file"; + comment = "If restart is TRUE, the name of the file with data from previous run, otherwise empty"; + value = ""; + }, + { + type = "double"; + name = "output_dt"; + comment = "Time interval for output to be written to disk"; + value = 0.1; + }, + { + type = "int"; + name = "pois_output"; + comment = "Output of the Poisson grids, including the potential?"; + value = 0; + }, + { + type = "int"; + name = "cdr_output_margin"; + comment = "Margin outside the grids in the output of the cdr equation"; + value = 0; + }, + { + type = "int"; + name = "pois_output_margin"; + comment = "Margin outside the grids in the output of the poisson equation"; + value = 1; + }, + { + type = "double"; + name = "warn_min_timestep"; + comment = "If the time steps are smaller than this number, the program issues a warning"; + value = 1e-06; + }, + { + type = "int"; + name = "max_disk_space_mb"; + comment = "Maximum disk space, in Mb, to use"; + value = 1048576; + }, + { + type = "int"; + name = "gridpoints_r"; + comment = "Number of R gridpoints at level 0"; + value = 600; + }, + { + type = "int"; + name = "gridpoints_z"; + comment = "Number of Z gridpoints at level 0"; + value = 600; + }, + { + type = "int"; + name = "max_ntheta"; + comment = "Number of azimuthal gridcells and modes"; + value = 1; + }, + { + type = "double"; + name = "start_t"; + comment = "Initial time"; + value = 0.0; + }, + { + type = "double"; + name = "end_t"; + comment = "End time"; + value = 0.6; + }, + { + type = "double"; + name = "attempt_dt"; + comment = "Attempted timestep. The actual timestep may be larger"; + value = 50.0; + }, + { + type = "int"; + name = "extra_pois_levels"; + comment = "Extra levels for the Poisson solver"; + value = 2; + }, + { + type = "int"; + name = "max_levels"; + comment = "Maximum level of refinement. Use a big number here"; + value = 64; + }, + { + type = "double"; + name = "pois_max_error"; + comment = "Error threshold that leads to refinement in the Poisson code."; + value = 0.001; + }, + { + type = "int"; + name = "pois_max_level"; + comment = "Maximum level of refinement in the Poisson equation."; + value = 3; + }, + { + type = "int"; + name = "extra_photo_levels"; + comment = "Extra levels for the photo-ionization solver"; + value = -1; + }, + { + type = "int"; + name = "photo_max_level"; + comment = "Maximum level of refinement in the photo-ionization solver."; + value = 4; + }, + { + type = "double"; + name = "photo_max_error"; + comment = "Error threshold that leads to refinement in the photo-ionization code."; + value = 0.01; + }, + { + type = "int"; + name = "photo_bnd_right"; + comment = "Photo-ionization boundary condition at r = L_r. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "photo_bnd_bottom"; + comment = "Photo-ionization boundary condition at z = 0. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "photo_bnd_top"; + comment = "Photo-ionization boundary condition at z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "extra_photo_levels_2"; + comment = "Extra levels for the photo-ionization solver"; + value = -1; + }, + { + type = "int"; + name = "photo_max_level_2"; + comment = "Maximum level of refinement in the photo-ionization solver."; + value = 4; + }, + { + type = "double"; + name = "photo_max_error_2"; + comment = "Error threshold that leads to refinement in the photo-ionization code."; + value = 0.01; + }, + { + type = "int"; + name = "photo_bnd_right_2"; + comment = "Photo-ionization boundary condition at r = L_r. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "photo_bnd_bottom_2"; + comment = "Photo-ionization boundary condition at z = 0. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "photo_bnd_top_2"; + comment = "Photo-ionization boundary condition at z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "cdr_bnd_bottom"; + comment = "Particles boundary condition at z = 0. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = 1; + }, + { + type = "int"; + name = "cdr_bnd_top"; + comment = "Particles boundary condition at z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = 1; + }, + { + type = "int"; + name = "cdr_bnd_right"; + comment = "Particles boundary condition at r = L_r. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = 1; + }, + { + type = "int"; + name = "pois_bnd_right"; + comment = "Potential boundary condition at r = L_r. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "pois_bnd_bottom"; + comment = "Potential boundary condition at z = 0. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "pois_bnd_top"; + comment = "Potential boundary condition at z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "double"; + name = "nu_a"; + comment = "Maximum advection Courant number"; + value = 0.2; + }, + { + type = "double"; + name = "nu_d"; + comment = "Maximum diffusion Courant number"; + value = 0.2; + }, + { + type = "double"; + name = "nu_rt"; + comment = "Maximum ratio of dt/relaxation time"; + value = 0.2; + }, + { + type = "double"; + name = "nu_f"; + comment = "Maximum ratio of change of the densities (set to a very large number to ignore)"; + value = 1e+20; + }, + { + type = "double"; + name = "ref_threshold_eabs"; + comment = "Refinement threshold for the electric field"; + value = 0.2; + }, + { + type = "int"; + name = "ref_level_eabs"; + comment = "Maximum refinement level reached through ref_threshold_eabs"; + value = 4; + }, + { + type = "double"; + name = "ref_threshold_charge"; + comment = "Refinement threshold for the curvature of the charge"; + value = 0.004; + }, + { + type = "double"; + name = "ref_threshold_dens"; + comment = "Refinement threshold for the curvature of the densities"; + value = 0.004; + }, + { + type = "double"; + name = "ref_threshold_edge"; + comment = "Refinement threshold for the densities in the leading edge"; + value = 10000.0; + }, + { + type = "int"; + name = "cdr_brick_dr"; + comment = "r-length of the minimal refinement area in the cdr equation"; + value = 8; + }, + { + type = "int"; + name = "cdr_brick_dz"; + comment = "z-length of the minimal refinement area in the cdr equation"; + value = 8; + }, + { + type = "int"; + name = "cdr_max_level"; + comment = "Maximum level of refinement in the Fluid equation."; + value = 3; + }, + { + type = "int"; + name = "cdr_interp_in"; + comment = "Interpolation method for the grid interior (0=zero_masses, 1=quadratic_masses [default], 2=wackers_masses, 3=quadlog"; + value = 1; + }, + { + type = "int"; + name = "cdr_interp_bnd"; + comment = "Interpolation method for the grid boundaries (0=zero_masses, 1=quadratic_masses [default], 2=wackers_masses, 3=quadlog"; + value = 1; + }, + { + type = "double"; + name = "L_r"; + comment = "Length in r of the complete domain"; + value = 13044.0; + }, + { + type = "double"; + name = "L_z"; + comment = "Length in z of the complete domain"; + value = 13044.0; + }, + { + type = "double"; + name = "diffusion_coeff"; + comment = "Isotropic difussion coefficient"; + value = 0.1; + }, + { + type = "int"; + name = "has_photoionization"; + comment = "Whether the code includes photoionization or not"; + value = 1; + }, + { + type = "string"; + name = "photoionization_file"; + comment = "The name of a file from which we can read the photoionization parameters"; + value = "input/air760torr.photo"; + }, + { + type = "double"; + name = "attachment_rate"; + comment = "Rate of dissociative attachment"; + value = 0.0; + }, + { + type = "double"; + name = "attachment_E0"; + comment = "E0 in the exp(-E0/E) factor in the attachment expression."; + value = 0.0; + }, + { + type = "double"; + name = "E0_x"; + comment = "x component of the external electric field"; + value = 0.0; + }, + { + type = "double"; + name = "E0_y"; + comment = "y component of the external electric field"; + value = 0.0; + }, + { + type = "double"; + name = "E0_z"; + comment = "z component of the external electric field"; + value = -0.06; + }, + { + type = "double"; + name = "rise_time"; + comment = "Rise time of the electric field (0 for instantaneous rise)"; + value = 0.0; + }, + { + type = "double"; + name = "off_time"; + comment = "Time to switch off the electric field (0.0 means never)"; + value = 0.0; + }, + { + type = "double"; + name = "seed_sigma_x"; + comment = "x width of the initial seed"; + value = 0.0; + }, + { + type = "double"; + name = "seed_sigma_y"; + comment = "y width of the initial seed"; + value = 0.0; + }, + { + type = "double"; + name = "seed_sigma_z"; + comment = "z width of the initial seed"; + value = 0.0; + }, + { + type = "double"; + name = "seed_N"; + comment = "Number of electrons in the initial seed"; + value = 0.0; + }, + { + type = "double"; + name = "background_ionization"; + comment = "Initial at z=0 densities of electrons and ions"; + value = 0.0; + }, + { + type = "double"; + name = "background_increase_length"; + comment = "Length of exponential increase of the pre-ionization (for atmospherical models)"; + value = 0.0; + }, + { + type = "int"; + name = "pois_inhom"; + comment = "Use the point-plane geometry?"; + value = 1; + }, + { + type = "int"; + name = "pois_inhom_reflections"; + comment = "Number of mirror charges to use"; + value = 4; + }, + { + type = "double"; + name = "needle_length"; + comment = "Length of the needle"; + value = 2500.0; + }, + { + type = "double"; + name = "needle_radius"; + comment = "Radius of the needle"; + value = 400.0; + }, + { + type = "double"; + name = "pois_inhom_fixed_q"; + comment = "If nonzero, the charge is fixed, not floating (simulation of charged clouds close to the earth surface)"; + value = 0.0; + }, + { + type = "double"; + name = "constant_source"; + comment = "Constant ionization rate"; + value = 0.0; + }, + { + type = "double"; + name = "perturb_epsilon"; + comment = "Initial perturbation to the axisymmetric configuration"; + value = 0.0; + }, + { + type = "int"; + name = "perturb_max_k"; + comment = "Perturb only modes up to perturb_max_k (large number to perturb all)"; + value = 1024; + }, + { + type = "int"; + name = "sprite_module"; + comment = "1 if the sprite module is activated, 0 otherwise"; + value = 0; + }, + { + type = "double"; + name = "dens_decay_len"; + comment = "Lenght of exponential decay of the density w/r to altitude"; + value = 0.0; + }, + { + type = "double"; + name = "sprite_dens_0"; + comment = "Density at z = 0"; + value = 0.0; + }, + { + type = "double"; + name = "sprite_dens_q"; + comment = "Quenching density"; + value = 0.0; + }, + { + type = "int"; + name = "sprite_sign"; + comment = "Sign of the sprite head that we are following (the other will not be reliable"; + value = -1; + } ); diff --git a/input/example_user_init.cfg b/input/example_user_init.cfg new file mode 100644 index 0000000000000000000000000000000000000000..bd88d47f8051368fda0f206c6b91fcc6866f02f1 --- /dev/null +++ b/input/example_user_init.cfg @@ -0,0 +1,27 @@ +name = "user_init"; +param = ( + { + type = "string"; + name = "output_dir"; + comment = "Output directory"; + value = "output"; + }, + { + type = "int"; + name = "restart"; + comment = "If restart is 1 (TRUE), the simulation will continue with data from a previous run"; + value = 0; + }, + { + type = "string"; + name = "load_file"; + comment = "If restart is TRUE, the name of the file with data from previous run, otherwise empty"; + value = ""; + }, + { + type = "double"; + name = "end_t"; + comment = "End time"; + value = 0.600; + } +); diff --git a/input/extra_photo_files/10ppbO2.photo b/input/extra_photo_files/10ppbO2.photo new file mode 100644 index 0000000000000000000000000000000000000000..86905a2a13601b8d68eb0715ec62d57ae46cf5ff --- /dev/null +++ b/input/extra_photo_files/10ppbO2.photo @@ -0,0 +1,2 @@ +-4.14278e-17 -1.01012e-20 +-6.16399e-15 -3.74197e-19 diff --git a/input/extra_photo_files/1ppbO2.photo b/input/extra_photo_files/1ppbO2.photo new file mode 100644 index 0000000000000000000000000000000000000000..df4be88f544bd32c06b9290926f3664cb29d4aa7 --- /dev/null +++ b/input/extra_photo_files/1ppbO2.photo @@ -0,0 +1,2 @@ +-4.14278e-18 -1.01012e-22 +-6.16399e-16 -3.74197e-21 diff --git a/input/extra_photo_files/1ppmN2.photo b/input/extra_photo_files/1ppmN2.photo new file mode 100644 index 0000000000000000000000000000000000000000..1d1964ec1f31544e678b38cb5b855ce6e9932056 --- /dev/null +++ b/input/extra_photo_files/1ppmN2.photo @@ -0,0 +1,2 @@ +-4.14278e-09 -0.000101011 +-6.16398e-07 -0.00374197 diff --git a/input/extra_photo_files/1ppmO2.photo b/input/extra_photo_files/1ppmO2.photo new file mode 100644 index 0000000000000000000000000000000000000000..f4f538bd8aab334d649627cf7f8425aa0fc502d1 --- /dev/null +++ b/input/extra_photo_files/1ppmO2.photo @@ -0,0 +1,2 @@ +-4.14278e-15 -1.01012e-16 +-6.16399e-13 -3.74197e-15 diff --git a/input/extra_photo_files/air760torr-ml-60.photo b/input/extra_photo_files/air760torr-ml-60.photo new file mode 100644 index 0000000000000000000000000000000000000000..2cf889a844050b2200a7188afa46524e866e6899 --- /dev/null +++ b/input/extra_photo_files/air760torr-ml-60.photo @@ -0,0 +1,2 @@ +-8.28556e-10 -4.04047e-06 +-1.2328e-07 -0.000149679 diff --git a/input/extra_photo_files/air_1atm_3term.photo b/input/extra_photo_files/air_1atm_3term.photo new file mode 100644 index 0000000000000000000000000000000000000000..106c5d43c779a0ac18238f449bb5b079412c1b12 --- /dev/null +++ b/input/extra_photo_files/air_1atm_3term.photo @@ -0,0 +1,3 @@ +-3.064258211257769079e-09 -2.029823458382051625e-05 +-1.676017200059491931e-08 -2.080524917212339816e-04 +-1.680217549583392655e-08 -2.025357858924288772e-04 diff --git a/input/kinetic_example.cfg b/input/kinetic_example.cfg new file mode 100644 index 0000000000000000000000000000000000000000..5109262450b59728429fded9e074a7ead7c57ef8 --- /dev/null +++ b/input/kinetic_example.cfg @@ -0,0 +1,266 @@ +filename="kinetic_example.cfg"; + +######################### +## Species definitions ## +######################### + +species = ( + { + name="o2"; + mass=0.0; + charge=0.0; + }, + { + name="n2"; + mass=0.0; + charge=0.0; + }, + { + ## This is the generic neutral species used for compound reactions that take ## + ## any neutral as input. Make sure to set its density as the sum of the ## + ## densities of all actual neutral species in the seed section ## + name="neutral"; + mass=0.0; + charge=0.0; + }, + { + name="electrons"; + mass=1.0; + charge=-1.0; + }, + { + ## We don't distinguish between different positive ions, so one ## + ## generic ion, X+, is used ## + name="xplus"; + mass=0.0; + charge=1.0; + }, + { + name="o2minus"; + mass=0.0; + charge=-1.0; + }, + { + name="ominus"; + mass=0.0; + charge=-1.0; + }, + ## These dummy species are used for the photo-ionization code. ## + ## D+ represents N2+, D- is just to preserve the charge-balance. ## + { + name="dummyminus"; + mass=0.0; + charge=-1.0; + }, + { + name="dummyplus"; + mass=0.0; + charge=1.0; + } + ); + +###################### +## Seed definitions ## +###################### + +seed = ( + { + species="electrons"; + type="gaussian"; + value=1.0e6; + x0=0.; + y0=0.; + z0=13044.; + sigma_x=32.0; + sigma_y=32.0; + sigma_z=32.0; + }, + { + species="xplus"; + type="gaussian"; + value=1.0e6; + x0=0.; + y0=0.; + z0=13044.; + sigma_x=32.0; + sigma_y=32.0; + sigma_z=32.0; + }, + { + species="xplus"; + type="constant"; + value=0.0e-8; + }, + { + species="o2minus"; + type="constant"; + value=0.0e-8; + }, + { + species="n2"; + type="constant"; + value=4.16e4; + }, + { + species="o2"; + type="constant"; + value=1.04e4; + }, + { + species="dummyminus"; + type="constant"; + value=0.0; + }, + { + species="dummyplus"; + type="constant"; + value=0.0; + }, + { + ## The value for this seed should be the sum of the values for all ## + ## normal neutral seeds. ## + species="neutral"; + type="constant"; + value=5.2e4; + } + ); + ########################## + ## Reaction definitions ## + ########################## + + ## Impact ionization of N2: e + N2 -> 2 e + X+ + D+ + D- ## + ## Since the rate of N2-impact-ionization is a source-term for the ## + ## photoionization-equation, we use the dummy species to track this ## + ## reaction ## + +reactions = ( + { + nin=2; + nout=5; + specin0="n2"; + specin1="electrons"; + specout0="electrons"; + specout1="electrons"; + specout2="xplus"; + specout3="dummyminus"; + specout4="dummyplus"; + reacttable="input/n2ion.reaction"; + }, + { + ## Impact ionization of O2: e + O2 -> 2 e + X+ ## + nin=2; + nout=3; + specin0="o2"; + specin1="electrons"; + specout0="electrons"; + specout1="electrons"; + specout2="xplus"; + reacttable="input/o2ion.reaction"; + }, + { + ## Attachment to O2: e + O2 -> O- + neutral ## + nin=2; + nout=2; + specin0="o2"; + specin1="electrons"; + specout0="o2"; + specout1="neutral"; + reacttable="input/o2attach2.reaction"; + }, + { + ## Attachment to O2: e + O2 + O2 -> O2- + O2 ## + nin=3; + nout=2; + specin0="o2"; + specin1="o2"; + specin2="electrons"; + specout0="o2"; + specout1="o2minus"; + reacttable="input/o2attach3.reaction"; + }, + { + ## Attachment to O2: e + O2 + N2 -> O2- + N2 ## + nin=3; + nout=2; + specin0="o2"; + specin1="n2"; + specin2="electrons"; + specout0="o2minus"; + specout1="n2"; + reacttable="input/n2o2attach.reaction"; + }, + { + ## Detachment from O2-: O2- + O2 -> e + 2 O2 ## + nin=2; + nout=3; + specin0="o2"; + specin1="o2minus"; + specout0="o2"; + specout1="o2"; + specout2="electrons"; + reacttable="input/o2detach.reaction"; + }, + { + ## Detachment from O2-: O2- + N2 -> e + O2 + N2 ## + nin=2; + nout=3; + specin0="n2"; + specin1="o2minus"; + specout0="n2"; + specout1="electrons"; + specout2="o2"; + reacttable="input/o2n2detach.reaction"; + }, + { + ## Electron/ion recombination: e + X+ -> X ## + nin=2; + nout=1; + specin0="xplus"; + specin1="electrons"; + specout0="neutral"; + reacttable="input/elecionrecomb.reaction"; + }, + { + ## Ion/ion recombination: O- + X+ -> X ## + nin=2; + nout=1; + specin0="xplus"; + specin1="ominus"; + specout0="neutral"; + reacttable="input/ominusrecomb.reaction"; + }, + { + ## Ion/ion recombination: O- + X+ + X -> 2 X + O ## + nin=3; + nout=3; + specin0="xplus"; + specin1="ominus"; + specin2="neutral"; + specout0="neutral"; + specout1="neutral"; + specout2="neutral"; + reacttable="input/ominusneutralrecomb.reaction"; + }, + { + ## Ion/ion recombination: O2- + X+ -> O2 + X ## + nin=2; + nout=2; + specin0="xplus"; + specin1="o2minus"; + specout0="o2"; + specout1="neutral"; + reacttable="input/o2minusrecomb.reaction"; + }, + { + ## Ion/ion recombination: O2- + X+ + X -> O2 + X + X ## + nin=3; + nout=3; + specin0="xplus"; + specin1="o2minus"; + specin2="xplus"; + specout0="o2"; + specout1="neutral"; + specout2="neutral"; + reacttable="input/o2minusneutralrecomb.reaction"; + } + ); diff --git a/input/n2ion.reaction b/input/n2ion.reaction new file mode 100644 index 0000000000000000000000000000000000000000..5a01393906a32823361a0ba73f3d2fecaae037a3 --- /dev/null +++ b/input/n2ion.reaction @@ -0,0 +1,107 @@ +Reaction table automatically generated from BOLSIG+ output file. +START +-1.875061e+00 +2.477121e-02 +100 +0.000000e+00 +7.962270e-05 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +0.000000e+00 +2.509800e-20 +1.986690e-18 +1.522800e-17 +6.590340e-17 +2.569020e-16 +9.314460e-16 +3.142890e-15 +9.964470e-15 +2.975100e-14 +8.352840e-14 +2.268690e-13 +5.754210e-13 +1.406616e-12 +3.272610e-12 +7.346100e-12 +1.591890e-11 +3.200700e-11 +6.488820e-11 +1.230648e-10 +2.260230e-10 +4.108740e-10 +7.047180e-10 +1.191591e-09 +1.937340e-09 +3.080850e-09 +4.846170e-09 +7.257270e-09 +1.077240e-08 +1.583430e-08 +2.243310e-08 +3.142890e-08 +4.386510e-08 +5.936100e-08 +7.982010e-08 +1.064127e-07 +1.393362e-07 +1.810440e-07 +2.336370e-07 +2.977920e-07 +3.759060e-07 +4.709400e-07 +5.876880e-07 +7.260090e-07 +8.898510e-07 +1.084713e-06 +1.316235e-06 +1.583430e-06 +1.893630e-06 +2.258820e-06 +2.676180e-06 +3.152760e-06 +3.695610e-06 +4.314600e-06 +5.013960e-06 +5.799330e-06 +6.680580e-06 +7.663350e-06 +8.754690e-06 +9.968700e-06 +1.130679e-05 +1.277601e-05 +1.438200e-05 +1.614450e-05 +1.806210e-05 +2.014890e-05 +2.239080e-05 +2.481600e-05 +2.742450e-05 +3.023040e-05 +3.321960e-05 +3.642030e-05 +3.980430e-05 +4.341390e-05 +4.722090e-05 +5.121120e-05 +5.545530e-05 +5.986860e-05 +6.450750e-05 +6.937200e-05 +7.437750e-05 +7.962270e-05 diff --git a/input/n2o2attach.reaction b/input/n2o2attach.reaction new file mode 100644 index 0000000000000000000000000000000000000000..d11d2e8330cb5c91669361a2af37ef3e453539f2 --- /dev/null +++ b/input/n2o2attach.reaction @@ -0,0 +1,107 @@ +Reaction table for n2o2attach +START +-1.875061e+00 +2.477121e-02 +100 +1.140319e-14 +6.494882e-18 +1.140319e-14 +1.123645e-14 +1.107741e-14 +1.093172e-14 +1.079084e-14 +1.065844e-14 +1.053603e-14 +1.042318e-14 +1.029378e-14 +1.018477e-14 +1.009523e-14 +9.989342e-15 +9.902361e-15 +9.799470e-15 +9.714943e-15 +9.631502e-15 +9.549128e-15 +9.451661e-15 +9.371571e-15 +9.292491e-15 +9.198905e-15 +9.106721e-15 +9.000908e-15 +8.896923e-15 +8.780268e-15 +8.637639e-15 +8.471010e-15 +8.269400e-15 +8.036802e-15 +7.741594e-15 +7.406034e-15 +6.988029e-15 +6.520309e-15 +5.982445e-15 +5.402142e-15 +4.860259e-15 +4.236341e-15 +3.697318e-15 +3.193690e-15 +2.697856e-15 +2.316895e-15 +1.962896e-15 +1.682989e-15 +1.444318e-15 +1.229153e-15 +1.080266e-15 +9.460174e-16 +8.231209e-16 +7.376452e-16 +6.618123e-16 +5.879509e-16 +5.370181e-16 +4.891707e-16 +4.444573e-16 +4.098110e-16 +3.771202e-16 +3.462523e-16 +3.204347e-16 +2.974004e-16 +2.760346e-16 +2.549434e-16 +2.365003e-16 +2.199883e-16 +2.039614e-16 +1.888445e-16 +1.751434e-16 +1.626981e-16 +1.502923e-16 +1.389063e-16 +1.283815e-16 +1.184846e-16 +1.092858e-16 +1.005828e-16 +9.272182e-17 +8.505237e-17 +7.817462e-17 +7.166904e-17 +6.556717e-17 +5.988467e-17 +5.476700e-17 +4.996574e-17 +4.549766e-17 +4.136775e-17 +3.753138e-17 +3.406438e-17 +3.087433e-17 +2.790332e-17 +2.520707e-17 +2.273001e-17 +2.046973e-17 +1.839080e-17 +1.649454e-17 +1.478654e-17 +1.322840e-17 +1.180350e-17 +1.051842e-17 +9.356227e-18 +8.295947e-18 +7.353206e-18 +6.494882e-18 diff --git a/input/o2attach2.reaction b/input/o2attach2.reaction new file mode 100644 index 0000000000000000000000000000000000000000..fbe7ed8157d802378abc196f9d16635f01f22793 --- /dev/null +++ b/input/o2attach2.reaction @@ -0,0 +1,107 @@ +Reaction table automatically generated from BOLSIG+ output file. +START +-1.875061e+00 +2.477121e-02 +100 +8.103270e-10 +4.960380e-08 +8.103270e-10 +1.097544e-09 +1.453710e-09 +1.886580e-09 +2.406870e-09 +3.021630e-09 +3.733680e-09 +4.548660e-09 +5.455290e-09 +6.478950e-09 +7.619640e-09 +8.851980e-09 +1.018584e-08 +1.161840e-08 +1.314402e-08 +1.474860e-08 +1.642650e-08 +1.820310e-08 +2.000790e-08 +2.186910e-08 +2.375850e-08 +2.570430e-08 +2.766420e-08 +2.959590e-08 +3.155580e-08 +3.351570e-08 +3.547560e-08 +3.740730e-08 +3.931080e-08 +4.118610e-08 +4.303320e-08 +4.483800e-08 +4.661460e-08 +4.836300e-08 +5.006910e-08 +5.171880e-08 +5.332620e-08 +5.489130e-08 +5.642820e-08 +5.786640e-08 +5.924820e-08 +6.057360e-08 +6.181440e-08 +6.298470e-08 +6.405630e-08 +6.505740e-08 +6.595980e-08 +6.676350e-08 +6.746850e-08 +6.804660e-08 +6.854010e-08 +6.892080e-08 +6.918870e-08 +6.934380e-08 +6.940020e-08 +6.932970e-08 +6.917460e-08 +6.892080e-08 +6.858240e-08 +6.814530e-08 +6.763770e-08 +6.704550e-08 +6.641100e-08 +6.570600e-08 +6.495870e-08 +6.415500e-08 +6.333720e-08 +6.247710e-08 +6.160290e-08 +6.071460e-08 +5.982630e-08 +5.893800e-08 +5.804970e-08 +5.717550e-08 +5.632950e-08 +5.549760e-08 +5.467980e-08 +5.390430e-08 +5.317110e-08 +5.246610e-08 +5.178930e-08 +5.118300e-08 +5.059080e-08 +5.006910e-08 +4.958970e-08 +4.916670e-08 +4.880010e-08 +4.847580e-08 +4.822200e-08 +4.802460e-08 +4.788360e-08 +4.779900e-08 +4.778490e-08 +4.782720e-08 +4.795410e-08 +4.813740e-08 +4.837710e-08 +4.870140e-08 +4.912440e-08 +4.960380e-08 diff --git a/input/o2attach3.reaction b/input/o2attach3.reaction new file mode 100644 index 0000000000000000000000000000000000000000..c797b6c3fd4189a3043e5b05201f727c546c6921 --- /dev/null +++ b/input/o2attach3.reaction @@ -0,0 +1,107 @@ +Reaction table automatically generated from BOLSIG+ output file. +START +-1.875061e+00 +2.477121e-02 +100 +2.647486e-13 +2.074914e-15 +2.647486e-13 +2.433434e-13 +2.244565e-13 +2.085517e-13 +1.945025e-13 +1.815798e-13 +1.705790e-13 +1.607710e-13 +1.529512e-13 +1.451313e-13 +1.379741e-13 +1.318773e-13 +1.261781e-13 +1.210753e-13 +1.168340e-13 +1.127915e-13 +1.088153e-13 +1.047729e-13 +1.017907e-13 +9.894111e-14 +9.622404e-14 +9.317562e-14 +9.025974e-14 +8.840418e-14 +8.628354e-14 +8.409663e-14 +8.177718e-14 +7.952400e-14 +7.760217e-14 +7.581288e-14 +7.402359e-14 +7.210176e-14 +7.011366e-14 +6.825810e-14 +6.633627e-14 +6.453373e-14 +6.269805e-14 +6.088888e-14 +5.894717e-14 +5.715125e-14 +5.534208e-14 +5.349314e-14 +5.171711e-14 +4.992782e-14 +4.815841e-14 +4.638237e-14 +4.461959e-14 +4.285018e-14 +4.114042e-14 +3.945716e-14 +3.777390e-14 +3.613040e-14 +3.452004e-14 +3.292294e-14 +3.137222e-14 +2.986789e-14 +2.839669e-14 +2.697852e-14 +2.558685e-14 +2.425482e-14 +2.298244e-14 +2.176969e-14 +2.060334e-14 +1.947675e-14 +1.840318e-14 +1.737599e-14 +1.640845e-14 +1.549393e-14 +1.460591e-14 +1.377753e-14 +1.299555e-14 +1.225995e-14 +1.155749e-14 +1.090142e-14 +1.026522e-14 +9.675420e-15 +9.112125e-15 +8.581965e-15 +8.084940e-15 +7.607796e-15 +7.157160e-15 +6.739659e-15 +6.340051e-15 +5.965625e-15 +5.607105e-15 +5.269790e-15 +4.953020e-15 +4.652154e-15 +4.367193e-15 +4.096811e-15 +3.835708e-15 +3.598461e-15 +3.369830e-15 +3.154452e-15 +2.951666e-15 +2.759483e-15 +2.561335e-15 +2.389696e-15 +2.228660e-15 +2.074914e-15 diff --git a/input/o2detach.reaction b/input/o2detach.reaction new file mode 100644 index 0000000000000000000000000000000000000000..3b51bcd083d7407a41ebe4cf79942ddf46311ac0 --- /dev/null +++ b/input/o2detach.reaction @@ -0,0 +1,107 @@ +Reaction table for electron detachment: O2- + O2 -> e- + O2 + O2. +START +-1.875061e+00 +2.477121e-02 +100 +3.674894e-15 +1.081081e-05 +3.674894e-15 +3.754518e-15 +3.845705e-15 +3.950385e-15 +4.070882e-15 +4.210005e-15 +4.371175e-15 +4.558584e-15 +4.777414e-15 +5.034119e-15 +5.336803e-15 +5.695737e-15 +6.124063e-15 +6.638761e-15 +7.262007e-15 +8.023084e-15 +8.961114e-15 +1.012901e-14 +1.159926e-14 +1.347252e-14 +1.589057e-14 +1.905601e-14 +2.326289e-14 +2.894472e-14 +3.675117e-14 +4.767221e-14 +6.324223e-14 +8.588049e-14 +1.194673e-13 +1.703321e-13 +2.489705e-13 +3.730597e-13 +5.728112e-13 +9.005403e-13 +1.447876e-12 +2.376796e-12 +3.975561e-12 +6.759153e-12 +1.164819e-11 +2.028384e-11 +3.557277e-11 +6.261033e-11 +1.102028e-10 +1.932990e-10 +3.367295e-10 +5.807146e-10 +9.885782e-10 +1.656952e-09 +2.728403e-09 +4.405870e-09 +6.967599e-09 +1.078058e-08 +1.631002e-08 +2.412231e-08 +3.487954e-08 +4.932461e-08 +6.825740e-08 +9.250414e-08 +1.228830e-07 +1.601698e-07 +2.050673e-07 +2.581817e-07 +3.200074e-07 +3.909211e-07 +4.711856e-07 +5.609604e-07 +6.603179e-07 +7.692639e-07 +8.877590e-07 +1.015740e-06 +1.153142e-06 +1.299911e-06 +1.456027e-06 +1.621509e-06 +1.796428e-06 +1.980916e-06 +2.175164e-06 +2.379434e-06 +2.594054e-06 +2.819422e-06 +3.056005e-06 +3.304338e-06 +3.565025e-06 +3.838740e-06 +4.126222e-06 +4.428279e-06 +4.745787e-06 +5.079691e-06 +5.431004e-06 +5.800813e-06 +6.190275e-06 +6.600625e-06 +7.033173e-06 +7.489313e-06 +7.970524e-06 +8.478370e-06 +9.014512e-06 +9.580708e-06 +1.017882e-05 +1.081081e-05 diff --git a/input/o2ion.reaction b/input/o2ion.reaction new file mode 100644 index 0000000000000000000000000000000000000000..a9caf58addbe8c6d50c906a96e513f5927d1fc5c --- /dev/null +++ b/input/o2ion.reaction @@ -0,0 +1,107 @@ +Reaction table automatically generated from BOLSIG+ output file. +START +-1.875061e+00 +2.477121e-02 +100 +2.351880e-24 +9.382140e-05 +2.351880e-24 +5.592060e-22 +3.932490e-21 +9.133980e-21 +2.670540e-20 +9.533010e-20 +4.277940e-19 +1.880940e-18 +7.905870e-18 +3.079440e-17 +1.115310e-16 +3.766110e-16 +1.189335e-15 +3.532050e-15 +9.917940e-15 +2.629650e-14 +6.625590e-14 +1.591890e-13 +3.650490e-13 +8.022900e-13 +1.693410e-12 +3.444630e-12 +6.765180e-12 +1.284651e-11 +2.364570e-11 +4.227180e-11 +7.353150e-11 +1.246863e-10 +2.062830e-10 +3.337470e-10 +5.287500e-10 +8.213250e-10 +1.252503e-09 +1.876710e-09 +2.769240e-09 +4.024140e-09 +5.764080e-09 +8.148390e-09 +1.138152e-08 +1.570740e-08 +2.144610e-08 +2.897550e-08 +3.876090e-08 +5.139450e-08 +6.755310e-08 +8.802630e-08 +1.138011e-07 +1.459350e-07 +1.859790e-07 +2.350470e-07 +2.951130e-07 +3.680100e-07 +4.557120e-07 +5.607570e-07 +6.856830e-07 +8.330280e-07 +1.005894e-06 +1.207242e-06 +1.441020e-06 +1.710330e-06 +2.017710e-06 +2.367390e-06 +2.765010e-06 +3.211980e-06 +3.715350e-06 +4.276530e-06 +4.902570e-06 +5.594880e-06 +6.360510e-06 +7.203690e-06 +8.128650e-06 +9.139620e-06 +1.024647e-05 +1.144638e-05 +1.275204e-05 +1.417050e-05 +1.569330e-05 +1.734300e-05 +1.910550e-05 +2.100900e-05 +2.303940e-05 +2.522490e-05 +2.753730e-05 +3.001890e-05 +3.264150e-05 +3.543330e-05 +3.839430e-05 +4.153860e-05 +4.483800e-05 +4.832070e-05 +5.198670e-05 +5.586420e-05 +5.991090e-05 +6.416910e-05 +6.859650e-05 +7.326360e-05 +7.808580e-05 +8.313360e-05 +8.837880e-05 +9.382140e-05 diff --git a/input/o2minusneutralrecomb.reaction b/input/o2minusneutralrecomb.reaction new file mode 100644 index 0000000000000000000000000000000000000000..669092c42ec901f23bc34ad0039735e337d6c421 --- /dev/null +++ b/input/o2minusneutralrecomb.reaction @@ -0,0 +1,107 @@ +Reaction table for O2minus-neutral-ion recombination: O2- + X+ + X -> X. +START +-1.875061e+00 +2.477121e-02 +100 +1.257124e-07 +8.149557e-16 +1.257124e-07 +1.249125e-07 +1.240234e-07 +1.230362e-07 +1.219415e-07 +1.207293e-07 +1.193890e-07 +1.179097e-07 +1.162801e-07 +1.144888e-07 +1.125244e-07 +1.103758e-07 +1.080325e-07 +1.054852e-07 +1.027258e-07 +9.974824e-08 +9.654895e-08 +9.312742e-08 +8.948680e-08 +8.563446e-08 +8.158255e-08 +7.734835e-08 +7.295453e-08 +6.842922e-08 +6.380575e-08 +5.912213e-08 +5.442026e-08 +4.974474e-08 +4.514149e-08 +4.065615e-08 +3.633234e-08 +3.221001e-08 +2.832388e-08 +2.470216e-08 +2.136568e-08 +1.832742e-08 +1.559249e-08 +1.315858e-08 +1.101674e-08 +9.152495e-09 +7.547049e-09 +6.178604e-09 +5.023610e-09 +4.057890e-09 +3.257592e-09 +2.599938e-09 +2.063757e-09 +1.629830e-09 +1.281066e-09 +1.002533e-09 +7.813966e-10 +6.067805e-10 +4.695841e-10 +3.622795e-10 +2.787031e-10 +2.138546e-10 +1.637109e-10 +1.250588e-10 +9.534902e-11 +7.257123e-11 +5.514839e-11 +4.184934e-11 +3.171708e-11 +2.401056e-11 +1.815793e-11 +1.371927e-11 +1.035709e-11 +7.813096e-12 +5.890082e-12 +4.437744e-12 +3.341742e-12 +2.515230e-12 +1.892337e-12 +1.423164e-12 +1.069952e-12 +8.041597e-13 +6.042313e-13 +4.538993e-13 +3.408964e-13 +2.559776e-13 +1.921795e-13 +1.442600e-13 +1.082743e-13 +8.125542e-14 +6.097223e-14 +4.574776e-14 +3.432181e-14 +2.574762e-14 +1.931409e-14 +1.448721e-14 +1.086605e-14 +8.149626e-15 +6.112020e-15 +4.583688e-15 +3.437402e-15 +2.577700e-15 +1.932959e-15 +1.449446e-15 +1.086857e-15 +8.149557e-16 diff --git a/input/o2minusrecomb.reaction b/input/o2minusrecomb.reaction new file mode 100644 index 0000000000000000000000000000000000000000..96dd6fd79d0961c0ab2335d41c5e054e46671ef7 --- /dev/null +++ b/input/o2minusrecomb.reaction @@ -0,0 +1,107 @@ +Reaction table for O2minus-ion recombination: O2- + X+ -> X. +START +-1.875061e+00 +2.477121e-02 +100 +1.380485e-04 +7.323757e-08 +1.380485e-04 +1.376964e-04 +1.373036e-04 +1.368653e-04 +1.363769e-04 +1.358330e-04 +1.352278e-04 +1.345551e-04 +1.338081e-04 +1.329797e-04 +1.320623e-04 +1.310478e-04 +1.299278e-04 +1.286936e-04 +1.273363e-04 +1.258469e-04 +1.242165e-04 +1.224366e-04 +1.204991e-04 +1.183967e-04 +1.161233e-04 +1.136739e-04 +1.110456e-04 +1.082373e-04 +1.052505e-04 +1.020893e-04 +9.876079e-05 +9.527505e-05 +9.164540e-05 +8.788825e-05 +8.402290e-05 +8.007126e-05 +7.605739e-05 +7.200693e-05 +6.794649e-05 +6.390295e-05 +5.990272e-05 +5.597111e-05 +5.213166e-05 +4.840566e-05 +4.481168e-05 +4.136533e-05 +3.807910e-05 +3.496233e-05 +3.202130e-05 +2.925941e-05 +2.667741e-05 +2.427377e-05 +2.204494e-05 +1.998572e-05 +1.808960e-05 +1.634907e-05 +1.475590e-05 +1.330141e-05 +1.197670e-05 +1.077278e-05 +9.680803e-06 +8.692126e-06 +7.798424e-06 +6.991754e-06 +6.264602e-06 +5.609909e-06 +5.021085e-06 +4.492016e-06 +4.017047e-06 +3.590978e-06 +3.209042e-06 +2.866881e-06 +2.560524e-06 +2.286363e-06 +2.041125e-06 +1.821845e-06 +1.625847e-06 +1.450716e-06 +1.294273e-06 +1.154562e-06 +1.029821e-06 +9.184682e-07 +8.190856e-07 +7.304006e-07 +6.512731e-07 +5.806824e-07 +5.177147e-07 +4.615527e-07 +4.114653e-07 +3.667991e-07 +3.269704e-07 +2.914575e-07 +2.597945e-07 +2.315657e-07 +2.063997e-07 +1.839651e-07 +1.639662e-07 +1.461391e-07 +1.302484e-07 +1.160842e-07 +1.034593e-07 +9.220643e-08 +8.217680e-08 +7.323757e-08 diff --git a/input/o2n2detach.reaction b/input/o2n2detach.reaction new file mode 100644 index 0000000000000000000000000000000000000000..abbb4a315036f8e0ff30a4036cb921d61f25837b --- /dev/null +++ b/input/o2n2detach.reaction @@ -0,0 +1,107 @@ +Reaction table for electron detachment: O2- + N2 -> e- + O2 + N2. +START +-1.875061e+00 +2.477121e-02 +100 +1.875746e-16 +7.625682e-08 +1.875746e-16 +1.912100e-16 +1.953635e-16 +2.001189e-16 +2.055766e-16 +2.118570e-16 +2.191057e-16 +2.274997e-16 +2.372556e-16 +2.486409e-16 +2.619881e-16 +2.777140e-16 +2.963459e-16 +3.185566e-16 +3.452133e-16 +3.774448e-16 +4.167368e-16 +4.650658e-16 +5.250927e-16 +6.004437e-16 +6.961236e-16 +8.191316e-16 +9.793910e-16 +1.191170e-15 +1.475283e-15 +1.862544e-15 +2.399260e-15 +3.156063e-15 +4.242307e-15 +5.829773e-15 +8.192122e-15 +1.177113e-14 +1.728870e-14 +2.593732e-14 +3.970489e-14 +6.192883e-14 +9.823887e-14 +1.581513e-13 +2.577380e-13 +4.240328e-13 +7.021711e-13 +1.166694e-12 +1.938941e-12 +3.212929e-12 +5.292353e-12 +8.641115e-12 +1.394873e-11 +2.220980e-11 +3.481356e-11 +5.363536e-11 +8.111804e-11 +1.203285e-10 +1.749741e-10 +2.493674e-10 +3.483329e-10 +4.770585e-10 +6.409042e-10 +8.451856e-10 +1.094957e-09 +1.394817e-09 +1.748752e-09 +2.160038e-09 +2.631200e-09 +3.164024e-09 +3.759630e-09 +4.418568e-09 +5.140947e-09 +5.926575e-09 +6.775100e-09 +7.686138e-09 +8.659392e-09 +9.694755e-09 +1.079239e-08 +1.195279e-08 +1.317684e-08 +1.446583e-08 +1.582149e-08 +1.724601e-08 +1.874203e-08 +2.031264e-08 +2.196140e-08 +2.369231e-08 +2.550985e-08 +2.741891e-08 +2.942486e-08 +3.153351e-08 +3.375113e-08 +3.608445e-08 +3.854068e-08 +4.112751e-08 +4.385312e-08 +4.672624e-08 +4.975611e-08 +5.295254e-08 +5.632594e-08 +5.988734e-08 +6.364839e-08 +6.762148e-08 +7.181967e-08 +7.625682e-08 diff --git a/input/ominusneutralrecomb.reaction b/input/ominusneutralrecomb.reaction new file mode 100644 index 0000000000000000000000000000000000000000..13a18c78bd052da29bf4bfafc502ed1947037c31 --- /dev/null +++ b/input/ominusneutralrecomb.reaction @@ -0,0 +1,107 @@ +Reaction table for Ominus-neutral-ion recombination: O- + X+ + X -> X. +START +-1.875061e+00 +2.477121e-02 +100 +1.257124e-07 +8.149557e-16 +1.257124e-07 +1.249125e-07 +1.240234e-07 +1.230362e-07 +1.219415e-07 +1.207293e-07 +1.193890e-07 +1.179097e-07 +1.162801e-07 +1.144888e-07 +1.125244e-07 +1.103758e-07 +1.080325e-07 +1.054852e-07 +1.027258e-07 +9.974824e-08 +9.654895e-08 +9.312742e-08 +8.948680e-08 +8.563446e-08 +8.158255e-08 +7.734835e-08 +7.295453e-08 +6.842922e-08 +6.380575e-08 +5.912213e-08 +5.442026e-08 +4.974474e-08 +4.514149e-08 +4.065615e-08 +3.633234e-08 +3.221001e-08 +2.832388e-08 +2.470216e-08 +2.136568e-08 +1.832742e-08 +1.559249e-08 +1.315858e-08 +1.101674e-08 +9.152495e-09 +7.547049e-09 +6.178604e-09 +5.023610e-09 +4.057890e-09 +3.257592e-09 +2.599938e-09 +2.063757e-09 +1.629830e-09 +1.281066e-09 +1.002533e-09 +7.813966e-10 +6.067805e-10 +4.695841e-10 +3.622795e-10 +2.787031e-10 +2.138546e-10 +1.637109e-10 +1.250588e-10 +9.534902e-11 +7.257123e-11 +5.514839e-11 +4.184934e-11 +3.171708e-11 +2.401056e-11 +1.815793e-11 +1.371927e-11 +1.035709e-11 +7.813096e-12 +5.890082e-12 +4.437744e-12 +3.341742e-12 +2.515230e-12 +1.892337e-12 +1.423164e-12 +1.069952e-12 +8.041597e-13 +6.042313e-13 +4.538993e-13 +3.408964e-13 +2.559776e-13 +1.921795e-13 +1.442600e-13 +1.082743e-13 +8.125542e-14 +6.097223e-14 +4.574776e-14 +3.432181e-14 +2.574762e-14 +1.931409e-14 +1.448721e-14 +1.086605e-14 +8.149626e-15 +6.112020e-15 +4.583688e-15 +3.437402e-15 +2.577700e-15 +1.932959e-15 +1.449446e-15 +1.086857e-15 +8.149557e-16 diff --git a/input/ominusrecomb.reaction b/input/ominusrecomb.reaction new file mode 100644 index 0000000000000000000000000000000000000000..23fecba4ec2489081fde05f6c4b783afe1b025c4 --- /dev/null +++ b/input/ominusrecomb.reaction @@ -0,0 +1,107 @@ +Reaction table for Ominus-ion recombination: O- + X+ -> X. +START +-1.875061e+00 +2.477121e-02 +100 +1.380485e-04 +7.323757e-08 +1.380485e-04 +1.376964e-04 +1.373036e-04 +1.368653e-04 +1.363769e-04 +1.358330e-04 +1.352278e-04 +1.345551e-04 +1.338081e-04 +1.329797e-04 +1.320623e-04 +1.310478e-04 +1.299278e-04 +1.286936e-04 +1.273363e-04 +1.258469e-04 +1.242165e-04 +1.224366e-04 +1.204991e-04 +1.183967e-04 +1.161233e-04 +1.136739e-04 +1.110456e-04 +1.082373e-04 +1.052505e-04 +1.020893e-04 +9.876079e-05 +9.527505e-05 +9.164540e-05 +8.788825e-05 +8.402290e-05 +8.007126e-05 +7.605739e-05 +7.200693e-05 +6.794649e-05 +6.390295e-05 +5.990272e-05 +5.597111e-05 +5.213166e-05 +4.840566e-05 +4.481168e-05 +4.136533e-05 +3.807910e-05 +3.496233e-05 +3.202130e-05 +2.925941e-05 +2.667741e-05 +2.427377e-05 +2.204494e-05 +1.998572e-05 +1.808960e-05 +1.634907e-05 +1.475590e-05 +1.330141e-05 +1.197670e-05 +1.077278e-05 +9.680803e-06 +8.692126e-06 +7.798424e-06 +6.991754e-06 +6.264602e-06 +5.609909e-06 +5.021085e-06 +4.492016e-06 +4.017047e-06 +3.590978e-06 +3.209042e-06 +2.866881e-06 +2.560524e-06 +2.286363e-06 +2.041125e-06 +1.821845e-06 +1.625847e-06 +1.450716e-06 +1.294273e-06 +1.154562e-06 +1.029821e-06 +9.184682e-07 +8.190856e-07 +7.304006e-07 +6.512731e-07 +5.806824e-07 +5.177147e-07 +4.615527e-07 +4.114653e-07 +3.667991e-07 +3.269704e-07 +2.914575e-07 +2.597945e-07 +2.315657e-07 +2.063997e-07 +1.839651e-07 +1.639662e-07 +1.461391e-07 +1.302484e-07 +1.160842e-07 +1.034593e-07 +9.220643e-08 +8.217680e-08 +7.323757e-08 diff --git a/input/photo_values.cfg b/input/photo_values.cfg new file mode 100644 index 0000000000000000000000000000000000000000..575fab77fb3445115472025175606b34678691e9 --- /dev/null +++ b/input/photo_values.cfg @@ -0,0 +1,62 @@ +filename="photo_values.cfg"; + +events = + { + ## 10ppb02.photo ## + nin=2; + A0=-4.14278e-17; + A1=-6.16399e-15; + lambda0=-1.01012e-20; + lambda1=-3.74197e-19; + }, + { + ## 1ppbO2.photo + nin= 2; + A0=-4.14278e-18; + A1=-6.16399e-16; + lambda0=1.01012e-22; + lambda1=-3.74197e-21; + }, + { + ## 1ppmN2.photo + nin= 2; + A0=-4.14278e-09; + A1=-6.16398e-07; + lambda0=-0.000101011; + lambda1=-0.00374197; + }, + { + ## 1ppmO2.photo + nin= 2; + A0=-4.14278e-15; + A1=-6.16399e-13; + lambda0=-1.01012e-16; + lambda1=-3.74197e-15; + }, + { + ## air_1atm_3term + nin=3; + A0=-3.064258211257769079e-09; + A1=-1.676017200059491931e-08; + A2=-1.680217549583392655e-08; + lambda0=-2.029823458382051625e-05; + lambda1=-2.080524917212339816e-04; + lambda2=-2.025357858924288772e-04; + }, + { + ## air760torr-ml-60; equal to air760torr !! + nin=2; + A0=-8.28556e-10; + A1=-1.2328e-07; + lambda0=-4.04047e-06; + lambda1=-0.000149679; + }, + { + ## air760torr + nin=2; + A0=-8.28556e-10; + A1=-1.2328e-07; + lambda0=-4.04047e-06; + lambda1=-0.000149679; + } + ) diff --git a/input/user_continue.cfg b/input/user_continue.cfg new file mode 100644 index 0000000000000000000000000000000000000000..1e68f3bc28e419d0b0239758fc03ae514575fc51 --- /dev/null +++ b/input/user_continue.cfg @@ -0,0 +1,506 @@ +name = "default"; +param = ( + { + type = "string"; + name = "prog_id"; + comment = "An identification name for this run"; + value = "example"; + }, + { + type = "string"; + name = "output_dir"; + comment = "Output directory"; + value = "output"; + }, + { + type = "string"; + name = "kin_input"; + comment = "Kinetics input file"; + value = "input/kinetic_example.cfg"; + }, + { + type = "int"; + name = "restart"; + comment = "If restart is 1 (TRUE), the simulation will continue with data from a previous run"; + value = 0; + }, + { + type = "string"; + name = "load_file"; + comment = "If restart is TRUE, the name of the file with data from previous run, otherwise empty"; + value = ""; + }, + { + type = "double"; + name = "output_dt"; + comment = "Time interval for output to be written to disk"; + value = 0.1; + }, + { + type = "int"; + name = "pois_output"; + comment = "Output of the Poisson grids, including the potential?"; + value = 0; + }, + { + type = "int"; + name = "cdr_output_margin"; + comment = "Margin outside the grids in the output of the cdr equation"; + value = 0; + }, + { + type = "int"; + name = "pois_output_margin"; + comment = "Margin outside the grids in the output of the poisson equation"; + value = 1; + }, + { + type = "double"; + name = "warn_min_timestep"; + comment = "If the time steps are smaller than this number, the program issues a warning"; + value = 1e-06; + }, + { + type = "int"; + name = "max_disk_space_mb"; + comment = "Maximum disk space, in Mb, to use"; + value = 1048576; + }, + { + type = "int"; + name = "gridpoints_r"; + comment = "Number of R gridpoints at level 0"; + value = 600; + }, + { + type = "int"; + name = "gridpoints_z"; + comment = "Number of Z gridpoints at level 0"; + value = 600; + }, + { + type = "int"; + name = "max_ntheta"; + comment = "Number of azimuthal gridcells and modes"; + value = 1; + }, + { + type = "double"; + name = "start_t"; + comment = "Initial time"; + value = 0.0; + }, + { + type = "double"; + name = "end_t"; + comment = "End time"; + value = 0.45; + }, + { + type = "double"; + name = "attempt_dt"; + comment = "Attempted timestep. The actual timestep may be larger"; + value = 50.0; + }, + { + type = "int"; + name = "extra_pois_levels"; + comment = "Extra levels for the Poisson solver"; + value = 2; + }, + { + type = "int"; + name = "max_levels"; + comment = "Maximum level of refinement. Use a big number here"; + value = 64; + }, + { + type = "double"; + name = "pois_max_error"; + comment = "Error threshold that leads to refinement in the Poisson code."; + value = 0.001; + }, + { + type = "int"; + name = "pois_max_level"; + comment = "Maximum level of refinement in the Poisson equation."; + value = 3; + }, + { + type = "int"; + name = "extra_photo_levels"; + comment = "Extra levels for the photo-ionization solver"; + value = -1; + }, + { + type = "int"; + name = "photo_max_level"; + comment = "Maximum level of refinement in the photo-ionization solver."; + value = 4; + }, + { + type = "double"; + name = "photo_max_error"; + comment = "Error threshold that leads to refinement in the photo-ionization code."; + value = 0.01; + }, + { + type = "int"; + name = "photo_bnd_right"; + comment = "Photo-ionization boundary condition at r = L_r. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "photo_bnd_bottom"; + comment = "Photo-ionization boundary condition at z = 0. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "photo_bnd_top"; + comment = "Photo-ionization boundary condition at z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "extra_photo_levels_2"; + comment = "Extra levels for the photo-ionization solver"; + value = -1; + }, + { + type = "int"; + name = "photo_max_level_2"; + comment = "Maximum level of refinement in the photo-ionization solver."; + value = 4; + }, + { + type = "double"; + name = "photo_max_error_2"; + comment = "Error threshold that leads to refinement in the photo-ionization code."; + value = 0.01; + }, + { + type = "int"; + name = "photo_bnd_right_2"; + comment = "Photo-ionization boundary condition at r = L_r. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "photo_bnd_bottom_2"; + comment = "Photo-ionization boundary condition at z = 0. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "photo_bnd_top_2"; + comment = "Photo-ionization boundary condition at z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "cdr_bnd_bottom"; + comment = "Particles boundary condition at z = 0. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = 1; + }, + { + type = "int"; + name = "cdr_bnd_top"; + comment = "Particles boundary condition at z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = 1; + }, + { + type = "int"; + name = "cdr_bnd_right"; + comment = "Particles boundary condition at r = L_r. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = 1; + }, + { + type = "int"; + name = "pois_bnd_right"; + comment = "Potential boundary condition at r = L_r. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "pois_bnd_bottom"; + comment = "Potential boundary condition at z = 0. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "int"; + name = "pois_bnd_top"; + comment = "Potential boundary condition at z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet"; + value = -1; + }, + { + type = "double"; + name = "nu_a"; + comment = "Maximum advection Courant number"; + value = 0.2; + }, + { + type = "double"; + name = "nu_d"; + comment = "Maximum diffusion Courant number"; + value = 0.2; + }, + { + type = "double"; + name = "nu_rt"; + comment = "Maximum ratio of dt/relaxation time"; + value = 0.2; + }, + { + type = "double"; + name = "nu_f"; + comment = "Maximum ratio of change of the densities (set to a very large number to ignore)"; + value = 1e+20; + }, + { + type = "double"; + name = "ref_threshold_eabs"; + comment = "Refinement threshold for the electric field"; + value = 0.2; + }, + { + type = "int"; + name = "ref_level_eabs"; + comment = "Maximum refinement level reached through ref_threshold_eabs"; + value = 4; + }, + { + type = "double"; + name = "ref_threshold_charge"; + comment = "Refinement threshold for the curvature of the charge"; + value = 0.004; + }, + { + type = "double"; + name = "ref_threshold_dens"; + comment = "Refinement threshold for the curvature of the densities"; + value = 0.004; + }, + { + type = "double"; + name = "ref_threshold_edge"; + comment = "Refinement threshold for the densities in the leading edge"; + value = 10000.0; + }, + { + type = "int"; + name = "cdr_brick_dr"; + comment = "r-length of the minimal refinement area in the cdr equation"; + value = 8; + }, + { + type = "int"; + name = "cdr_brick_dz"; + comment = "z-length of the minimal refinement area in the cdr equation"; + value = 8; + }, + { + type = "int"; + name = "cdr_max_level"; + comment = "Maximum level of refinement in the Fluid equation."; + value = 3; + }, + { + type = "int"; + name = "cdr_interp_in"; + comment = "Interpolation method for the grid interior (0=zero_masses, 1=quadratic_masses [default], 2=wackers_masses, 3=quadlog"; + value = 1; + }, + { + type = "int"; + name = "cdr_interp_bnd"; + comment = "Interpolation method for the grid boundaries (0=zero_masses, 1=quadratic_masses [default], 2=wackers_masses, 3=quadlog"; + value = 1; + }, + { + type = "double"; + name = "L_r"; + comment = "Length in r of the complete domain"; + value = 13044.0; + }, + { + type = "double"; + name = "L_z"; + comment = "Length in z of the complete domain"; + value = 13044.0; + }, + { + type = "double"; + name = "diffusion_coeff"; + comment = "Isotropic difussion coefficient"; + value = 0.1; + }, + { + type = "int"; + name = "has_photoionization"; + comment = "Whether the code includes photoionization or not"; + value = 1; + }, + { + type = "string"; + name = "photoionization_file"; + comment = "The name of a file from which we can read the photoionization parameters"; + value = "input/air760torr.photo"; + }, + { + type = "double"; + name = "attachment_rate"; + comment = "Rate of dissociative attachment"; + value = 0.0; + }, + { + type = "double"; + name = "attachment_E0"; + comment = "E0 in the exp(-E0/E) factor in the attachment expression."; + value = 0.0; + }, + { + type = "double"; + name = "E0_x"; + comment = "x component of the external electric field"; + value = 0.0; + }, + { + type = "double"; + name = "E0_y"; + comment = "y component of the external electric field"; + value = 0.0; + }, + { + type = "double"; + name = "E0_z"; + comment = "z component of the external electric field"; + value = -0.06; + }, + { + type = "double"; + name = "rise_time"; + comment = "Rise time of the electric field (0 for instantaneous rise)"; + value = 0.0; + }, + { + type = "double"; + name = "off_time"; + comment = "Time to switch off the electric field (0.0 means never)"; + value = 0.0; + }, + { + type = "double"; + name = "seed_sigma_x"; + comment = "x width of the initial seed"; + value = 0.0; + }, + { + type = "double"; + name = "seed_sigma_y"; + comment = "y width of the initial seed"; + value = 0.0; + }, + { + type = "double"; + name = "seed_sigma_z"; + comment = "z width of the initial seed"; + value = 0.0; + }, + { + type = "double"; + name = "seed_N"; + comment = "Number of electrons in the initial seed"; + value = 0.0; + }, + { + type = "double"; + name = "background_ionization"; + comment = "Initial at z=0 densities of electrons and ions"; + value = 0.0; + }, + { + type = "double"; + name = "background_increase_length"; + comment = "Length of exponential increase of the pre-ionization (for atmospherical models)"; + value = 0.0; + }, + { + type = "int"; + name = "pois_inhom"; + comment = "Use the point-plane geometry?"; + value = 1; + }, + { + type = "int"; + name = "pois_inhom_reflections"; + comment = "Number of mirror charges to use"; + value = 4; + }, + { + type = "double"; + name = "needle_length"; + comment = "Length of the needle"; + value = 2500.0; + }, + { + type = "double"; + name = "needle_radius"; + comment = "Radius of the needle"; + value = 400.0; + }, + { + type = "double"; + name = "pois_inhom_fixed_q"; + comment = "If nonzero, the charge is fixed, not floating (simulation of charged clouds close to the earth surface)"; + value = 0.0; + }, + { + type = "double"; + name = "constant_source"; + comment = "Constant ionization rate"; + value = 0.0; + }, + { + type = "double"; + name = "perturb_epsilon"; + comment = "Initial perturbation to the axisymmetric configuration"; + value = 0.0; + }, + { + type = "int"; + name = "perturb_max_k"; + comment = "Perturb only modes up to perturb_max_k (large number to perturb all)"; + value = 1024; + }, + { + type = "int"; + name = "sprite_module"; + comment = "1 if the sprite module is activated, 0 otherwise"; + value = 0; + }, + { + type = "double"; + name = "dens_decay_len"; + comment = "Lenght of exponential decay of the density w/r to altitude"; + value = 0.0; + }, + { + type = "double"; + name = "sprite_dens_0"; + comment = "Density at z = 0"; + value = 0.0; + }, + { + type = "double"; + name = "sprite_dens_q"; + comment = "Quenching density"; + value = 0.0; + }, + { + type = "int"; + name = "sprite_sign"; + comment = "Sign of the sprite head that we are following (the other will not be reliable"; + value = -1; + } ); diff --git a/input/user_init.cfg b/input/user_init.cfg new file mode 100644 index 0000000000000000000000000000000000000000..e4b8d1b7f7c506d16b1141f8348393058546edee --- /dev/null +++ b/input/user_init.cfg @@ -0,0 +1,27 @@ +name = "user_init"; +param = ( + { + type = "string"; + name = "output_dir"; + comment = "Output directory"; + value = "output"; + }, + { + type = "int"; + name = "restart"; + comment = "If restart is 1 (TRUE), the simulation will continue with data from a previous run"; + value = 0; + }, + { + type = "string"; + name = "load_file"; + comment = "If restart is TRUE, the name of the file with data from previous run, otherwise empty"; + value = ""; + }, + { + type = "double"; + name = "end_t"; + comment = "End time"; + value = 0.450; + } +); diff --git a/libconfig-1.4.9/AUTHORS b/libconfig-1.4.9/AUTHORS new file mode 100644 index 0000000000000000000000000000000000000000..f3f746557ebf09490b9268e09e772652964e5153 --- /dev/null +++ b/libconfig-1.4.9/AUTHORS @@ -0,0 +1,5 @@ + +Mark Lindner - Lead developer & maintainer. +Daniel Marjamäki - Enhancements & bugfixes. +Andrew Tytula - Windows port. +Glenn Herteg - Enhancements, bugfixes, documentation corrections. diff --git a/libconfig-1.4.9/COPYING.LIB b/libconfig-1.4.9/COPYING.LIB new file mode 100644 index 0000000000000000000000000000000000000000..b124cf581250c210960185e8fbf6c967a0538721 --- /dev/null +++ b/libconfig-1.4.9/COPYING.LIB @@ -0,0 +1,510 @@ + + GNU LESSER GENERAL PUBLIC LICENSE + Version 2.1, February 1999 + + Copyright (C) 1991, 1999 Free Software Foundation, Inc. + 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA + Everyone is permitted to copy and distribute verbatim copies + of this license document, but changing it is not allowed. + +[This is the first released version of the Lesser GPL. It also counts + as the successor of the GNU Library Public License, version 2, hence + the version number 2.1.] + + Preamble + + The licenses for most software are designed to take away your +freedom to share and change it. By contrast, the GNU General Public +Licenses are intended to guarantee your freedom to share and change +free software--to make sure the software is free for all its users. + + This license, the Lesser General Public License, applies to some +specially designated software packages--typically libraries--of the +Free Software Foundation and other authors who decide to use it. You +can use it too, but we suggest you first think carefully about whether +this license or the ordinary General Public License is the better +strategy to use in any particular case, based on the explanations +below. + + When we speak of free software, we are referring to freedom of use, +not price. Our General Public Licenses are designed to make sure that +you have the freedom to distribute copies of free software (and charge +for this service if you wish); that you receive source code or can get +it if you want it; that you can change the software and use pieces of +it in new free programs; and that you are informed that you can do +these things. + + To protect your rights, we need to make restrictions that forbid +distributors to deny you these rights or to ask you to surrender these +rights. These restrictions translate to certain responsibilities for +you if you distribute copies of the library or if you modify it. + + For example, if you distribute copies of the library, whether gratis +or for a fee, you must give the recipients all the rights that we gave +you. You must make sure that they, too, receive or can get the source +code. If you link other code with the library, you must provide +complete object files to the recipients, so that they can relink them +with the library after making changes to the library and recompiling +it. And you must show them these terms so they know their rights. + + We protect your rights with a two-step method: (1) we copyright the +library, and (2) we offer you this license, which gives you legal +permission to copy, distribute and/or modify the library. + + To protect each distributor, we want to make it very clear that +there is no warranty for the free library. Also, if the library is +modified by someone else and passed on, the recipients should know +that what they have is not the original version, so that the original +author's reputation will not be affected by problems that might be +introduced by others. + + Finally, software patents pose a constant threat to the existence of +any free program. We wish to make sure that a company cannot +effectively restrict the users of a free program by obtaining a +restrictive license from a patent holder. Therefore, we insist that +any patent license obtained for a version of the library must be +consistent with the full freedom of use specified in this license. + + Most GNU software, including some libraries, is covered by the +ordinary GNU General Public License. This license, the GNU Lesser +General Public License, applies to certain designated libraries, and +is quite different from the ordinary General Public License. We use +this license for certain libraries in order to permit linking those +libraries into non-free programs. + + When a program is linked with a library, whether statically or using +a shared library, the combination of the two is legally speaking a +combined work, a derivative of the original library. The ordinary +General Public License therefore permits such linking only if the +entire combination fits its criteria of freedom. The Lesser General +Public License permits more lax criteria for linking other code with +the library. + + We call this license the "Lesser" General Public License because it +does Less to protect the user's freedom than the ordinary General +Public License. It also provides other free software developers Less +of an advantage over competing non-free programs. These disadvantages +are the reason we use the ordinary General Public License for many +libraries. However, the Lesser license provides advantages in certain +special circumstances. + + For example, on rare occasions, there may be a special need to +encourage the widest possible use of a certain library, so that it +becomes a de-facto standard. To achieve this, non-free programs must +be allowed to use the library. A more frequent case is that a free +library does the same job as widely used non-free libraries. In this +case, there is little to gain by limiting the free library to free +software only, so we use the Lesser General Public License. + + In other cases, permission to use a particular library in non-free +programs enables a greater number of people to use a large body of +free software. For example, permission to use the GNU C Library in +non-free programs enables many more people to use the whole GNU +operating system, as well as its variant, the GNU/Linux operating +system. + + Although the Lesser General Public License is Less protective of the +users' freedom, it does ensure that the user of a program that is +linked with the Library has the freedom and the wherewithal to run +that program using a modified version of the Library. + + The precise terms and conditions for copying, distribution and +modification follow. Pay close attention to the difference between a +"work based on the library" and a "work that uses the library". The +former contains code derived from the library, whereas the latter must +be combined with the library in order to run. + + GNU LESSER GENERAL PUBLIC LICENSE + TERMS AND CONDITIONS FOR COPYING, DISTRIBUTION AND MODIFICATION + + 0. This License Agreement applies to any software library or other +program which contains a notice placed by the copyright holder or +other authorized party saying it may be distributed under the terms of +this Lesser General Public License (also called "this License"). +Each licensee is addressed as "you". + + A "library" means a collection of software functions and/or data +prepared so as to be conveniently linked with application programs +(which use some of those functions and data) to form executables. + + The "Library", below, refers to any such software library or work +which has been distributed under these terms. A "work based on the +Library" means either the Library or any derivative work under +copyright law: that is to say, a work containing the Library or a +portion of it, either verbatim or with modifications and/or translated +straightforwardly into another language. (Hereinafter, translation is +included without limitation in the term "modification".) + + "Source code" for a work means the preferred form of the work for +making modifications to it. For a library, complete source code means +all the source code for all modules it contains, plus any associated +interface definition files, plus the scripts used to control +compilation and installation of the library. + + Activities other than copying, distribution and modification are not +covered by this License; they are outside its scope. The act of +running a program using the Library is not restricted, and output from +such a program is covered only if its contents constitute a work based +on the Library (independent of the use of the Library in a tool for +writing it). Whether that is true depends on what the Library does +and what the program that uses the Library does. + + 1. You may copy and distribute verbatim copies of the Library's +complete source code as you receive it, in any medium, provided that +you conspicuously and appropriately publish on each copy an +appropriate copyright notice and disclaimer of warranty; keep intact +all the notices that refer to this License and to the absence of any +warranty; and distribute a copy of this License along with the +Library. + + You may charge a fee for the physical act of transferring a copy, +and you may at your option offer warranty protection in exchange for a +fee. + + 2. You may modify your copy or copies of the Library or any portion +of it, thus forming a work based on the Library, and copy and +distribute such modifications or work under the terms of Section 1 +above, provided that you also meet all of these conditions: + + a) The modified work must itself be a software library. + + b) You must cause the files modified to carry prominent notices + stating that you changed the files and the date of any change. + + c) You must cause the whole of the work to be licensed at no + charge to all third parties under the terms of this License. + + d) If a facility in the modified Library refers to a function or a + table of data to be supplied by an application program that uses + the facility, other than as an argument passed when the facility + is invoked, then you must make a good faith effort to ensure that, + in the event an application does not supply such function or + table, the facility still operates, and performs whatever part of + its purpose remains meaningful. + + (For example, a function in a library to compute square roots has + a purpose that is entirely well-defined independent of the + application. Therefore, Subsection 2d requires that any + application-supplied function or table used by this function must + be optional: if the application does not supply it, the square + root function must still compute square roots.) + +These requirements apply to the modified work as a whole. If +identifiable sections of that work are not derived from the Library, +and can be reasonably considered independent and separate works in +themselves, then this License, and its terms, do not apply to those +sections when you distribute them as separate works. But when you +distribute the same sections as part of a whole which is a work based +on the Library, the distribution of the whole must be on the terms of +this License, whose permissions for other licensees extend to the +entire whole, and thus to each and every part regardless of who wrote +it. + +Thus, it is not the intent of this section to claim rights or contest +your rights to work written entirely by you; rather, the intent is to +exercise the right to control the distribution of derivative or +collective works based on the Library. + +In addition, mere aggregation of another work not based on the Library +with the Library (or with a work based on the Library) on a volume of +a storage or distribution medium does not bring the other work under +the scope of this License. + + 3. You may opt to apply the terms of the ordinary GNU General Public +License instead of this License to a given copy of the Library. To do +this, you must alter all the notices that refer to this License, so +that they refer to the ordinary GNU General Public License, version 2, +instead of to this License. (If a newer version than version 2 of the +ordinary GNU General Public License has appeared, then you can specify +that version instead if you wish.) Do not make any other change in +these notices. + + Once this change is made in a given copy, it is irreversible for +that copy, so the ordinary GNU General Public License applies to all +subsequent copies and derivative works made from that copy. + + This option is useful when you wish to copy part of the code of +the Library into a program that is not a library. + + 4. You may copy and distribute the Library (or a portion or +derivative of it, under Section 2) in object code or executable form +under the terms of Sections 1 and 2 above provided that you accompany +it with the complete corresponding machine-readable source code, which +must be distributed under the terms of Sections 1 and 2 above on a +medium customarily used for software interchange. + + If distribution of object code is made by offering access to copy +from a designated place, then offering equivalent access to copy the +source code from the same place satisfies the requirement to +distribute the source code, even though third parties are not +compelled to copy the source along with the object code. + + 5. A program that contains no derivative of any portion of the +Library, but is designed to work with the Library by being compiled or +linked with it, is called a "work that uses the Library". Such a +work, in isolation, is not a derivative work of the Library, and +therefore falls outside the scope of this License. + + However, linking a "work that uses the Library" with the Library +creates an executable that is a derivative of the Library (because it +contains portions of the Library), rather than a "work that uses the +library". The executable is therefore covered by this License. +Section 6 states terms for distribution of such executables. + + When a "work that uses the Library" uses material from a header file +that is part of the Library, the object code for the work may be a +derivative work of the Library even though the source code is not. +Whether this is true is especially significant if the work can be +linked without the Library, or if the work is itself a library. The +threshold for this to be true is not precisely defined by law. + + If such an object file uses only numerical parameters, data +structure layouts and accessors, and small macros and small inline +functions (ten lines or less in length), then the use of the object +file is unrestricted, regardless of whether it is legally a derivative +work. (Executables containing this object code plus portions of the +Library will still fall under Section 6.) + + Otherwise, if the work is a derivative of the Library, you may +distribute the object code for the work under the terms of Section 6. +Any executables containing that work also fall under Section 6, +whether or not they are linked directly with the Library itself. + + 6. As an exception to the Sections above, you may also combine or +link a "work that uses the Library" with the Library to produce a +work containing portions of the Library, and distribute that work +under terms of your choice, provided that the terms permit +modification of the work for the customer's own use and reverse +engineering for debugging such modifications. + + You must give prominent notice with each copy of the work that the +Library is used in it and that the Library and its use are covered by +this License. You must supply a copy of this License. If the work +during execution displays copyright notices, you must include the +copyright notice for the Library among them, as well as a reference +directing the user to the copy of this License. Also, you must do one +of these things: + + a) Accompany the work with the complete corresponding + machine-readable source code for the Library including whatever + changes were used in the work (which must be distributed under + Sections 1 and 2 above); and, if the work is an executable linked + with the Library, with the complete machine-readable "work that + uses the Library", as object code and/or source code, so that the + user can modify the Library and then relink to produce a modified + executable containing the modified Library. (It is understood + that the user who changes the contents of definitions files in the + Library will not necessarily be able to recompile the application + to use the modified definitions.) + + b) Use a suitable shared library mechanism for linking with the + Library. A suitable mechanism is one that (1) uses at run time a + copy of the library already present on the user's computer system, + rather than copying library functions into the executable, and (2) + will operate properly with a modified version of the library, if + the user installs one, as long as the modified version is + interface-compatible with the version that the work was made with. + + c) Accompany the work with a written offer, valid for at least + three years, to give the same user the materials specified in + Subsection 6a, above, for a charge no more than the cost of + performing this distribution. + + d) If distribution of the work is made by offering access to copy + from a designated place, offer equivalent access to copy the above + specified materials from the same place. + + e) Verify that the user has already received a copy of these + materials or that you have already sent this user a copy. + + For an executable, the required form of the "work that uses the +Library" must include any data and utility programs needed for +reproducing the executable from it. However, as a special exception, +the materials to be distributed need not include anything that is +normally distributed (in either source or binary form) with the major +components (compiler, kernel, and so on) of the operating system on +which the executable runs, unless that component itself accompanies +the executable. + + It may happen that this requirement contradicts the license +restrictions of other proprietary libraries that do not normally +accompany the operating system. Such a contradiction means you cannot +use both them and the Library together in an executable that you +distribute. + + 7. You may place library facilities that are a work based on the +Library side-by-side in a single library together with other library +facilities not covered by this License, and distribute such a combined +library, provided that the separate distribution of the work based on +the Library and of the other library facilities is otherwise +permitted, and provided that you do these two things: + + a) Accompany the combined library with a copy of the same work + based on the Library, uncombined with any other library + facilities. This must be distributed under the terms of the + Sections above. + + b) Give prominent notice with the combined library of the fact + that part of it is a work based on the Library, and explaining + where to find the accompanying uncombined form of the same work. + + 8. You may not copy, modify, sublicense, link with, or distribute +the Library except as expressly provided under this License. Any +attempt otherwise to copy, modify, sublicense, link with, or +distribute the Library is void, and will automatically terminate your +rights under this License. However, parties who have received copies, +or rights, from you under this License will not have their licenses +terminated so long as such parties remain in full compliance. + + 9. You are not required to accept this License, since you have not +signed it. However, nothing else grants you permission to modify or +distribute the Library or its derivative works. These actions are +prohibited by law if you do not accept this License. Therefore, by +modifying or distributing the Library (or any work based on the +Library), you indicate your acceptance of this License to do so, and +all its terms and conditions for copying, distributing or modifying +the Library or works based on it. + + 10. Each time you redistribute the Library (or any work based on the +Library), the recipient automatically receives a license from the +original licensor to copy, distribute, link with or modify the Library +subject to these terms and conditions. You may not impose any further +restrictions on the recipients' exercise of the rights granted herein. +You are not responsible for enforcing compliance by third parties with +this License. + + 11. If, as a consequence of a court judgment or allegation of patent +infringement or for any other reason (not limited to patent issues), +conditions are imposed on you (whether by court order, agreement or +otherwise) that contradict the conditions of this License, they do not +excuse you from the conditions of this License. If you cannot +distribute so as to satisfy simultaneously your obligations under this +License and any other pertinent obligations, then as a consequence you +may not distribute the Library at all. For example, if a patent +license would not permit royalty-free redistribution of the Library by +all those who receive copies directly or indirectly through you, then +the only way you could satisfy both it and this License would be to +refrain entirely from distribution of the Library. + +If any portion of this section is held invalid or unenforceable under +any particular circumstance, the balance of the section is intended to +apply, and the section as a whole is intended to apply in other +circumstances. + +It is not the purpose of this section to induce you to infringe any +patents or other property right claims or to contest validity of any +such claims; this section has the sole purpose of protecting the +integrity of the free software distribution system which is +implemented by public license practices. Many people have made +generous contributions to the wide range of software distributed +through that system in reliance on consistent application of that +system; it is up to the author/donor to decide if he or she is willing +to distribute software through any other system and a licensee cannot +impose that choice. + +This section is intended to make thoroughly clear what is believed to +be a consequence of the rest of this License. + + 12. If the distribution and/or use of the Library is restricted in +certain countries either by patents or by copyrighted interfaces, the +original copyright holder who places the Library under this License +may add an explicit geographical distribution limitation excluding those +countries, so that distribution is permitted only in or among +countries not thus excluded. In such case, this License incorporates +the limitation as if written in the body of this License. + + 13. The Free Software Foundation may publish revised and/or new +versions of the Lesser General Public License from time to time. +Such new versions will be similar in spirit to the present version, +but may differ in detail to address new problems or concerns. + +Each version is given a distinguishing version number. If the Library +specifies a version number of this License which applies to it and +"any later version", you have the option of following the terms and +conditions either of that version or of any later version published by +the Free Software Foundation. If the Library does not specify a +license version number, you may choose any version ever published by +the Free Software Foundation. + + 14. If you wish to incorporate parts of the Library into other free +programs whose distribution conditions are incompatible with these, +write to the author to ask for permission. For software which is +copyrighted by the Free Software Foundation, write to the Free +Software Foundation; we sometimes make exceptions for this. Our +decision will be guided by the two goals of preserving the free status +of all derivatives of our free software and of promoting the sharing +and reuse of software generally. + + NO WARRANTY + + 15. BECAUSE THE LIBRARY IS LICENSED FREE OF CHARGE, THERE IS NO +WARRANTY FOR THE LIBRARY, TO THE EXTENT PERMITTED BY APPLICABLE LAW. +EXCEPT WHEN OTHERWISE STATED IN WRITING THE COPYRIGHT HOLDERS AND/OR +OTHER PARTIES PROVIDE THE LIBRARY "AS IS" WITHOUT WARRANTY OF ANY +KIND, EITHER EXPRESSED OR IMPLIED, INCLUDING, BUT NOT LIMITED TO, THE +IMPLIED WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR +PURPOSE. THE ENTIRE RISK AS TO THE QUALITY AND PERFORMANCE OF THE +LIBRARY IS WITH YOU. SHOULD THE LIBRARY PROVE DEFECTIVE, YOU ASSUME +THE COST OF ALL NECESSARY SERVICING, REPAIR OR CORRECTION. + + 16. IN NO EVENT UNLESS REQUIRED BY APPLICABLE LAW OR AGREED TO IN +WRITING WILL ANY COPYRIGHT HOLDER, OR ANY OTHER PARTY WHO MAY MODIFY +AND/OR REDISTRIBUTE THE LIBRARY AS PERMITTED ABOVE, BE LIABLE TO YOU +FOR DAMAGES, INCLUDING ANY GENERAL, SPECIAL, INCIDENTAL OR +CONSEQUENTIAL DAMAGES ARISING OUT OF THE USE OR INABILITY TO USE THE +LIBRARY (INCLUDING BUT NOT LIMITED TO LOSS OF DATA OR DATA BEING +RENDERED INACCURATE OR LOSSES SUSTAINED BY YOU OR THIRD PARTIES OR A +FAILURE OF THE LIBRARY TO OPERATE WITH ANY OTHER SOFTWARE), EVEN IF +SUCH HOLDER OR OTHER PARTY HAS BEEN ADVISED OF THE POSSIBILITY OF SUCH +DAMAGES. + + END OF TERMS AND CONDITIONS + + How to Apply These Terms to Your New Libraries + + If you develop a new library, and you want it to be of the greatest +possible use to the public, we recommend making it free software that +everyone can redistribute and change. You can do so by permitting +redistribution under these terms (or, alternatively, under the terms +of the ordinary General Public License). + + To apply these terms, attach the following notices to the library. +It is safest to attach them to the start of each source file to most +effectively convey the exclusion of warranty; and each file should +have at least the "copyright" line and a pointer to where the full +notice is found. + + + + Copyright (C) + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public + License as published by the Free Software Foundation; either + version 2.1 of the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Lesser General Public + License along with this library; if not, write to the Free Software + Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA + +Also add information on how to contact you by electronic and paper mail. + +You should also get your employer (if you work as a programmer) or +your school, if any, to sign a "copyright disclaimer" for the library, +if necessary. Here is a sample; alter the names: + + Yoyodyne, Inc., hereby disclaims all copyright interest in the + library `Frob' (a library for tweaking knobs) written by James + Random Hacker. + + , 1 April 1990 + Ty Coon, President of Vice + +That's all there is to it! + + diff --git a/libconfig-1.4.9/ChangeLog b/libconfig-1.4.9/ChangeLog new file mode 100644 index 0000000000000000000000000000000000000000..52125e9fbe9e0e1c8a86bf5a5d4c3a357baeabfc --- /dev/null +++ b/libconfig-1.4.9/ChangeLog @@ -0,0 +1,623 @@ + ----- version 1.4.9 ------ + +2012-09-28 Mark Lindner + + * lib/libconfigcpp.c++ - Fixed compiler warnings in constructor + initializers + * tinytest/tiytest.c, tinytest/tinytest.h - added tt_file_exists(); + added alternate implementations of some test macros since MSVC does + not support C99 fully; added comparators for text files (ignoring + line endings) + * tests/tests.c - use tt_file_exists() rather than access(); alias + snprintf to _snprintf for MSVC; compare files as text files rather + than as binary files + * lib/scanner.l - fixed parsing issue when backslash in string is + followed by invalid escape character; reported by Jimmy Scott + * lib/scanner.c - regenerated + * lib/libconfig.h, lib/libconfig.h++, lib/Makefile.am, + doc/libconfig.texi, configure.ac - bump version numbers + * aclocal.m4, ac_config.h - regenerated + * m4/*, aux-build/*, libtool - updated to newer + +2011-12-30 Mark Lindner + + * debian/control - updates from Jonathan McCrohan + + ----- version 1.4.8 ------ + +2011-08-04 Mark Lindner + + * tests/Makefile.am - marked 'libconfig_tests' as non-installable + * lib/scanner.l, lib/grammar.y - grammar changes to make trailing + semicolons optional (and to allow commas as an alternative) + * lib/libconfig.c - bugfixes for lack of auto-conversion handling in + the config_lookup*() functions (reported by Feng Yu), and some + fixes for compiler warnings + * lib/Makefile.am - bump .so version + * configure.ac - bump version, add '-Wno-unused-parameter' compiler + switch to disable "unused parameter" warnings + * doc/libconfig.texi - documentation updates; added a chapter that + calls attention to the bundled example programs + * lib/libconfig.h, lib/libconfig.h++ - bump versions + + ----- version 1.4.7 ------ + +2011-03-11 Mark Lindner + + * doc/libconfig.texi - fixed typo; updated docs + * TODO - updated list + * lib/libconfig.c, lib/libconfig.h, lib/libconfigcpp.c++, + lib/libconfig.h++ - added config{get,set}_default_format(), + Config::{get,set}DefaultFormat() + +2011-03-10 Mark Lindner + + * lib/libconfig.c - fixed memory leak when encountering a parse error + in an @include'd file + * lib/libconfig.h, lib/libconfig.h++, lib/Makefile.am, configure.ac, + doc/libconfig.texi - bump versions + + ----- version 1.4.6 ------ + +2010-09-10 Mark Lindner + + * doc/libconfig.texi - documentation updates + * lib/libconfig.c, lib/libconfigcpp.c++, lib/libconfig.h, + lib/libconfig.h++, lib/wincompat.h, lib/scanctx.c - added support + for specifying an include directory + * m4/* - added local m4 directory + * contrib/* - added user-contributed files + +2010-09-07 Mark Lindner + + * lib/scanner.l - bugfix for parse error when there is a missing + newline at the end of the file + * lib/libconfig.h, lib/libconfig.h++, lib/Makefile.am - bump version + * tinytest/* - added a simple unit testing framework + * tests/* - added preliminary unit tests + * configure.ac, ac_config.h, ac_config.h.in, Makefile.am, + lib/Makefile.am, libtool, doc/libconfig.texi - bump versions/dates + * lib/grammar.h, lib/grammar.c - regenerated with newer version of + Bison + * lib/libconfig.c - bugfix: explicitly set starting line number to 1 + when parsing from strings; otherwise line numbers reported in parse + errors are undefined + + ----- version 1.4.5 ------ + +2010-05-04 Mark Lindner + + * lib/libconfig.h, lib/libconfig.h++, lib/Makefile.am - bumped version + numbers; removed #include for and added one for + * lib/libconfigcpp.c++ - bugfix: properly handle TypeInt64 in add() and + assertType() + * aux-build/*, ac_config.h, configure.ac, ac_config.h.in, libtool - + regenerated with newer autotools + * libconfig.c - added declaration of libconfig_yylex_init_extra() to + eliminate compiler warning + * scanner.l - added #define YY_NO_INPUT to prevent compiler warning + * libconfig.texi - Added example code for operator=() + + ----- version 1.4.4 ------ + +2010-04-12 Mark Lindner + + * lib/Makefile.am - fixed shared library version info + * lib/libconfig.h++ - added Setting::c_str() method + * configure.ac, ac_config.h, libconfig.spec, lib/libconfig.h, + lib/libconfig.h++ - bump versions + * lib/wincompat.h - fixed MinGW build error + * doc/libconfig.texi - doc updates + * README - added MinGW info + + ----- version 1.4.3 ------ + +2010-02-13 Mark Lindner + + * lib/scanner.l - bugfix for matching @include with preceding + whitespace + + ----- version 1.4.2 ------ + +2010-01-19 Mark Lindner + + * lib/libconfigcpp.c++, lib/libconfig.h++ - bugfix for crash; added + copy constructor for ParseException (from Frederic Heitzmann) + * lib/libconfig.h, lib/libconfig.h++, lib/Makefile.am, + ac_config.h, libconfig.spec, configure.ac - bump versions + +2010-01-09 Mark Lindner + + * lib/libconfigcpp.c++ - bugfix in ParseException constructor (from + Ilya Dogolazky) + * debian/* - more cleanup, and added debug rules (from Ilya Dogolazky) + + ----- version 1.4.1 ------ + +2009-12-31 Mark Lindner + + * lib/libconfig.c - bugfix for crash; removed unnecessary buffer delete + in __config_read() + * examples/c/Makefile.am, examples/c++/Makefile.am - fixed build issue + * configure.ac, Makefile.am - Added `--disable-examples' configure + option + * configure.ac, lib/Makefile.am, libconfig.spec, ac_config.h - bumped + version numbers + + ----- version 1.4 ------ + +2009-10-24 Mark Lindner + + * grammar.y, scanner.l - properly report @include errors + * exmaples/example4.cpp - new example added + +2009-10-14 Mark Lindner + + * debian/* - more fixes; from Klaus Schneider-Zapp + * libconfig.c - when writing strings, escape only control characters + with \x + + ----- version 1.4b4 ------ + +2009-09-09 Mark Lindner + + * lib/Makefile.am - fixed MinGW build issues + + ----- version 1.4b3 ------ + +2009-09-04 Mark Lindner + + * lib/libconfig.c, lib/scanner.l, lib/grammar.y - fixed all memory + leaks reported by Valgrind; removed an unncessary strdup()/free(). + +2009-09-01 Mark Lindner + + * lib/libconfig.c, lib/libconfig.h, lib/libconfigcpp.c++, + lib/libconfig.h++ - added config_error_type() and fixed a segfault + when throwing a ParseException. + * doc/libconfig.texi - doc updates + + ----- version 1.4b2 ------ + +2009-08-29 Mark Lindner + + * examples/* - added new example programs to replace the less + practical ones in samples/ + +2009-08-25 Mark Lindner + + * lib/libconfig.c, lib/libconfig.h, lib/libconfigcpp.c++, + lib/libconfig.h++ - added config_set_tab_width(), + config_get_tab_width() and Config::setTabWidth(), + Config::getTabWidth(). + * doc/libconfig.texi - doc updates + + ----- version 1.4b1 ------ + +2009-08-21 Mark Lindner + + * lib/libconfig.h++, lib/libconfigcpp.c++ - broke the public + dependency on libconfig.h; updated VC++ projects on Windows so that + the C++ DLL no longer exports any of the C API functions + * debian/* - updated for version 1.4 + * lib/libconfig.c - fixed an isprint() assertion on Windows + +2009-08-20 Mark Lindner + + * lib/parsectx.c, lib/parsectx.h, lib/scanctx.c, lib/scanctx.h, + lib/strbuf.c, lib/strbuf.h - code refactoring to reduce library size + lib/Makefile.am - fixed 'make install' error + + ----- version 1.4b ------ + +2009-08-16 Mark Lindner + + * lib/libconfig.c, lib/libconfig.h, lib/scanctx.c, lib/scanctx.h, + lib/grammar.y, lib/grammar.c, lib/grammar.h - added + config_read_string(); added config_setting_source_file() and + management of list of input file names; added #ifdef guard for + DllMain() function so that it's not included for static library + builds + * lib/libconfigcpp.c++, lib/libconfig.h++ - added filename to + ParseException; bugfix in Setting::setFormat(); made what() methods + of exceptions public; added Setting::getSourceFile(), + Config::readString(). + * doc/libconfig.texi - documentation updates + * lib/Makefile.am - bump .so version + * ac_config.h, configure.ac, libtool - bump version + +2009-07-19 Mark Lindner + + * lib/libconfig.c, lib/libconfig.h, lib/libconfigcpp.c++, + lib/libconfig.h++ - added config_read_string() and + Config::readString() functions (contributed by Matthias Weisser). + +2009-07-02 Mark Lindner + + * lib/parsectx.c, lib/parsectx.h, lib/scanctx.c, lib/scanctx.h, + lib/scanner.l, lib/grammar.y, lib/private.h, lib/Makefile.am, + lib/libconfig.c, lib/libconfig.h - replaced ugly C code in scanner.l + for processing strings with a new scanner state and + associated rules; added support for hex character literals (\xNN) in + strings; refactored scanner and parser context into separate source + files; added preliminary support for include files ("@include" + directive). + +2009-05-27 Mark Lindner + + * ltmain.sh, ac_config.h, ac_config.h.in, configure.ac, libconfig.spec, + libtool - upgraded to newer versions of autotools + * grammar.y, grammar.h, grammar.c, libconfigcpp.c++, libconfig.h++, + libconfig.c, libconfig.h - added LIBCONFIG_VER_* macros, changed API + to replace 'long' and 'unsigned long' with 'int' and 'unsigned int' + to resolve a portability problem; added 'const' to declarations of + getLine() and getError() methods on ParseException + * - directory structure reorg + + ----- version 1.3.2 ------ + +2009-02-18 Mark Lindner + + * libconfig.vcproj, libconfig++.vcproj - #define _STDLIB_H to + eliminate 'inconsistent dll linkage' warnings for free & malloc + +2009-02-17 Mark Lindner + + * libconfig.c, libconfig.h - added config_setting_lookup*() functions; + modified config_lookup_*() functions to have more consistent API + (return status, and accept value-result param) + * debian/* - updates and cleanup (from Klaus Schneider-Zapp) + * libconfig.spec, Makefile.am, ac_config.h - update version number + * doc/libconfig.texi - documentation updates + * samples/c/sample1.c - patch from Rodolfo Giometti + * samples/c/stub.c - fixed relative to API changes + +2008-12-06 Mark Lindner + + * libconfig.c - fix memory leak in config_setting_remove_elem(); + reported by Timi Tuohenmaa + * configure.ac - fix incorrect processing of --enable-cxx option; + reported by Thomas Gazzola + +2008-09-11 Mark Lindner + + * debian/libconfigduo2.postinst - fix typo in test stmt + + ----- version 1.3.1 ------ + +2008-09-07 Mark Lindner + + * scanner.l, wincompat.h - workarounds for problems with parsing and + formatting of 64-bit integers on MinGW + * scanner.c - regenerated + +2008-09-05 Mark Lindner + + * libconfig.spec - updated for 1.3.1 + * Makefile.am - fix version + * scanner.l - add fromhex() function, since strtoull() seems broken + on MinGW + +2008-08-25 Mark Lindner + + * libconfigcpp.c++, libconfig.h++ - derive exceptions from + std::exception + +2008-08-10 Mark Lindner + + * wincompat.h - fix MinGW build issue + * configure.ac, ac_config.h, Makefile.am - bump version + * doc/libconfig.texi - doc updates + * libconfigcpp.c++, libconfig.h++ - include path information in + setting exceptions + * libconfig.c - force "C" locale for parsing & formatting + + ----- version 1.3 ------ + +2008-04-07 Mark Lindner + + * libconfig.spec - updated for 1.3 + +2008-04-03 Mark Lindner + + * scanner.l, grammar.y, libconfig.c, libconfig.h, wincompat.h - + fix/add comment headers, add C90 portability fixes from + Chris Pickett (C-style comments, renamed 'index' to 'idx' to + resolve name clash) + * scanner.c, grammar.c - regenerated + * configure.ac - enable more gcc warnings + * libconfigcpp.c++, libconfig.h++ - added getPath(), fixed impl of + isRoot(), add portability fixes from Chris Pickett (renamed 'index' + to 'idx' to resolve name clash), moved exception constructors into + source file; changed SettingExistsException to SettingNameException + to be more broad in scope + * Makefile.am - add wincompat.h to sources; add missing debian files + to EXTRA_DIST + * test.cfg - added example 64-bit integer settings + * samples/* - expanded some examples + * doc/libconfig.texi - documentation updates + * Makefile.am, *msvc7* - added (generated) VS2003 projects/solution + +2008-03-22 Mark Lindner + + * debian/* - updates from Klaus Schneider + +2008-03-22 Mark Lindner + + * scanner.l, grammar.y, libconfig.h++, libconfig.c, libconfig.h, + wincompat.h, libconfigcpp.c++, grammar.c, scanner.c, grammar.h - + add support for 64-bit integer values + * libconfig.texi - documentation updates + * Makefile.am, ac_config.h, configure.ac, libtool - bump version + * libconfig.h - add config_setting_parent(), config_setting_is_root() + * libconfigcpp.c++, libconfig.h++ - add isRoot(), getParent() to + Setting + +2008-03-15 Mark Lindner + + * scanner.l - made 'true' and 'false' tokens completely + case-insensitive + * libconfigcpp.cc, libconfig.hh - added alias files for Windows + * libconfig.c, libconfig.h - modified __config_write_value() to write + out floating point values in a more human-readable form; added name + validation; added config_setting_remove_elem() and + config_setting_index() + * libconfigcpp.c++, libconfig.h++ - added remove(unsigned int) and + getIndex() to Setting + * libconfig.texi - documentation updates + + ----- version 1.2.1 ------ + +2007-12-21 Mark Lindner + + * libconfig.c - source cleanup + * config.guess, config.sub, ltmain.sh, libtool - updated to newer + * configure.ac, Makefile.am, ac_config.h.in, ac_config.h + - MinGW-related fixes + + ----- version 1.2 ------ + +2007-10-15 Mark Lindner + + * libconfig.h++, libconfigcpp.c++ - renamed "SettingFormat" to + "Setting::Format" to reduce namespace pollution + +2007-10-13 Mark Lindner + + * scanner.l - updated regexp for float to allow for values which have + an exponent but no decimal point + * grammar.y - capture input line number when parsing settings + * libconfig.c, libconfig.h - added config_setting_is*() macros; + added config_setting_source_line(); added line member to + config_setting_t struct + * libconfig.c++, libconfig.h++ - renamed "SettingType" enum to + Setting::Type to reduce namespace pollution; added getSourceLine() + * samples/* - various updates + * debian/changelog - added entry + * ac_config.h, configure.ac, libtool, Makefile.am - new version # + * TODO - updates + * doc/libconfig.texi - documentation updates + +2007-10-12 Mark Lindner + + * libconfig.c, libconfig.h - added config_set_auto_convert(), + config_get_auto_convert(), and number auto-conversion logic + * libconfigcpp.c++, libconfig.h++ - add setAutoConvert(), + getAutoConvert(), lookupValue() that takes std::string&, + corrected return values of assignment operators + * debian/rules - made file executable + * debian/libconfigduo-dev.install - add pkgconfig files to list + +2007-09-22 Mark Lindner + + * libconfig.c, libconfig.h - change 'type' and 'format' members of + config_setting_t to short, thereby saving 4 bytes + +2007-09-22 Mark Lindner + + * doc/libconfig.texi - add @direntry to fix install-info warnings + * libconfig.spec.in, Makefile.am, configure.ac - added RPM support + (from Deneys S. Maartens) + +2007-09-18 Mark Lindner + + * libconfig.h - remove DLL_EXPORT; add LIBCONFIG_STATIC to fix + static linking on Windows + +2007-09-18 Deneys S. Maartens + + * samples/c/Makefile.am, samples/c++/Makefile.am - Add + AM_CPPFLAGS to fix distcheck build failure + * Makefile.am - expand wildcards in EXTRA_DIST to fix distcheck + build failure + + ----- version 1.1.3 ------ + +2007-08-03 Mark Lindner + + * libconfigcpp.c++ - bugfix in unsigned cast operators (incorrect value + clipping logic) + * debian/control - made some corrections + + ----- version 1.1.2 ------ + +2007-07-01 Mark Lindner + + * debian/* added debian package files from Klaus Schneider + * libconfig.h++ - added new predicate is() functions + * libconfig.h - fix comments + * doc/libconfig.texi - documentation updates + * ac_config.h, configure.ac, Makefile.am - new version # + + ----- version 1.1.1 ------ + +2007-06-15 Mark Lindner + + * scanner.l - bugfix in string parsing + * test.cfg - added test case + + ----- version 1.1 ------ + +2007-04-18 Mark Lindner + + * libconfigcpp.c++ - bugfix in add(SettingType) + * stubcpp.cpp - add more ad-hoc tests + +2007-04-05 Mark Lindner + + * scanner.l - Add string concatenation patch from Glenn Herteg. + Add \f as a whitespace character. + * grammar.y - add mode directive emacs + * libconfigcpp.c++, libconfig.h++ - add exists() and lookupValue() + methods; add Setting::operator std::string() + * libconfig.texi - documentation updates + + ----- version 1.0.1 ------ + +2006-11-26 Mark Lindner + + * samples/c/Makefile.am, samples/c++/Makefile.am - fix linker error + * libconfig.texi - documentation update + + ----- version 1.0 ------ + +2006-10-19 Mark Lindner + + * libconfigcpp.c++ - bugfix in add() for lists + +2006-10-11 Mark Lindner + + * scanner.l - allow asterisk in setting names (submitted by + James McCann) + * libconfig.texi - documentation updates + * configure.ac, Makefile.am, samples/Makefile.am - add --disable-cxx + configure option; conditionally build/install C++ components + +2006-10-01 Mark Lindner + + * - samples cleanup + +2006-09-14 Mark Lindner + + * libconfig.c - Change %.8f to %e for double values in + __config_write_value(). Submitted by Filipe Maia. + +2006-08-31 Mark Lindner + + * Makefile.am - changed bin_PROGRAMS to noinst_PROGRAMS; the stub + programs are for testing and should not be installed. + +2006-08-26 Mark Lindner + + * libconfig.texi - documentation corrections & updates + * stub.c, stubcpp.c++ - check return value of fopen(); fix compiler + warnings + * configure.ac, Makefile.am - add -Wall to CFLAGS only for gcc; + add test.cfg to EXTRA_DIST + * grammar.y, libconfigcpp.c++ - fix compiler warnings + * libconfig.c - use CONFIG_TRUE & CONFIG_FALSE rather than 1 & 0 + for success/failure return values. + + ----- version 0.9 ------ + +2006-07-29 Mark Lindner + + * - major grammar redesign: groups are now values instead of + distinct syntax constructs; this allows groups to be elements of + lists + * libconfig.texi - documentation updates; added new chapter containing + the BNF grammar + * test.cfg - modified to reflect new syntax and to demonstrate lists + +2006-06-23 Mark Lindner + + * - added support for lists (collections of + heterogeneous values of any type) + * libconfig.c - pretty-printing fixes in config_write() + +2006-06-08 Mark Lindner + + * libconfig.h++ - added private copy constructor & assignment operator + (from Josef Meile) + * ligconfigcpp.c++, libconfig.h++ - added cast operators for unsigned + int and unsigned long (from Scott Frazer) + * - add support for value formats; the only non-default + format currently supported is hexadecimal format for integer values + (based on patch from Scott Frazer) + +2006-04-15 Mark Lindner + + * - added pkg-config support + +2006-03-31 mlindner + + * - cleaned up config.tab.h mess (this file was obsolete, + and superseded by grammar.h ... problem identified by Scott Frazer) + +2006-03-30 mlindner + + * grammar.y - fixed includes for windows (missing decl of malloc/free) + * libconfig.c - fixed several signed/unsigned warnings + * doc/libconfig.texi - documentation updates, formatting fix + * scanner.l - allow lowercase 'true' and 'false' in addition to + 'TRUE' and 'FALSE' + +2006-03-27 Mark Lindner + + * libconfigcpp.c++ - added missing break statements in switch (from + Lukas Zweifel) + * libconfig.c - don't strdup() a NULL string (from Lukas Zweifel) + * grammar.c, grammar.h - regenerated with bison 2.1 + +2006-03-20 Mark Lindner + + * scanner.l - added '%option nounistd' and regenerated with newest + version of flex; Windows doesn't have unistd.h. + +2006-03-17 Mark Lindner + + * grammar.y - bugfix; error & abort parsing if duplicate setting name + encountered (previously caused a crash ... reported by Tobias Witek) + * scanner.l - bugfix; multi-line C-style comments were causing line + number counting to be thrown off, because the newlines were being + "eaten" + * - various fixes to support building of DLLs on Windows. + +2005-11-26 Mark Lindner + + * grammar.y, scanner.l - always strdup() yytext, and free the memory + in the grammar rules. + +2005-11-22 Mark Lindner + + * libconfigcpp.c++, libconfig.h++, libconfig.c, libconfig.h - + Added Daniel's enhancements: methods & functions for reading/writing + files, fixes for various memory leaks, etc. + * samples/* - Added Daniel's example code. + * docs/libconfig.texi - Updated documentation + +2005-09-28 Mark Lindner + + * libconfigcpp.c++, libconfig.h++, libconfig.c, libconfig.h + Enhanced API to support modification of a configuration. + * libconfig.texi - updated manual + +2005-06-02 Mark Lindner + + * libconfigcpp.c++, libconfig.h++ - Added getName() method; + fixed operator[](int) to work with groups; this allows iteration over + a group's child settings. Added a missing break statement (bugfix + submitted by Pablo Barrera Gonzalez). Added operator int() and + operator float() to Setting; note that these may cause loss of + precision since the actual values are stored internally as long + and double, respectively. + + * libconfig.h - added config_setting_name() macro + + * libconfig.c - maintain two lists of children at each node; a sorted + list and an unsorted list (to preserve the order of the settings as + they appear in the file). + + * scanner.l - fixed scanner rule for comments. '#' no longer has to + be in column 0 to be recognized as a comment. Added support for C + and C++ style comments. diff --git a/libconfig-1.4.9/INSTALL b/libconfig-1.4.9/INSTALL new file mode 100644 index 0000000000000000000000000000000000000000..095b1eb406356f57c8d90c89f53681bbb36124a7 --- /dev/null +++ b/libconfig-1.4.9/INSTALL @@ -0,0 +1,231 @@ +Installation Instructions +************************* + +Copyright (C) 1994, 1995, 1996, 1999, 2000, 2001, 2002, 2004 Free +Software Foundation, Inc. + +This file is free documentation; the Free Software Foundation gives +unlimited permission to copy, distribute and modify it. + +Basic Installation +================== + +These are generic installation instructions. + + The `configure' shell script attempts to guess correct values for +various system-dependent variables used during compilation. It uses +those values to create a `Makefile' in each directory of the package. +It may also create one or more `.h' files containing system-dependent +definitions. Finally, it creates a shell script `config.status' that +you can run in the future to recreate the current configuration, and a +file `config.log' containing compiler output (useful mainly for +debugging `configure'). + + It can also use an optional file (typically called `config.cache' +and enabled with `--cache-file=config.cache' or simply `-C') that saves +the results of its tests to speed up reconfiguring. (Caching is +disabled by default to prevent problems with accidental use of stale +cache files.) + + If you need to do unusual things to compile the package, please try +to figure out how `configure' could check whether to do them, and mail +diffs or instructions to the address given in the `README' so they can +be considered for the next release. If you are using the cache, and at +some point `config.cache' contains results you don't want to keep, you +may remove or edit it. + + The file `configure.ac' (or `configure.in') is used to create +`configure' by a program called `autoconf'. You only need +`configure.ac' if you want to change it or regenerate `configure' using +a newer version of `autoconf'. + +The simplest way to compile this package is: + + 1. `cd' to the directory containing the package's source code and type + `./configure' to configure the package for your system. If you're + using `csh' on an old version of System V, you might need to type + `sh ./configure' instead to prevent `csh' from trying to execute + `configure' itself. + + Running `configure' takes awhile. While running, it prints some + messages telling which features it is checking for. + + 2. Type `make' to compile the package. + + 3. Optionally, type `make check' to run any self-tests that come with + the package. + + 4. Type `make install' to install the programs and any data files and + documentation. + + 5. You can remove the program binaries and object files from the + source code directory by typing `make clean'. To also remove the + files that `configure' created (so you can compile the package for + a different kind of computer), type `make distclean'. There is + also a `make maintainer-clean' target, but that is intended mainly + for the package's developers. If you use it, you may have to get + all sorts of other programs in order to regenerate files that came + with the distribution. + +Compilers and Options +===================== + +Some systems require unusual options for compilation or linking that the +`configure' script does not know about. Run `./configure --help' for +details on some of the pertinent environment variables. + + You can give `configure' initial values for configuration parameters +by setting variables in the command line or in the environment. Here +is an example: + + ./configure CC=c89 CFLAGS=-O2 LIBS=-lposix + + *Note Defining Variables::, for more details. + +Compiling For Multiple Architectures +==================================== + +You can compile the package for more than one kind of computer at the +same time, by placing the object files for each architecture in their +own directory. To do this, you must use a version of `make' that +supports the `VPATH' variable, such as GNU `make'. `cd' to the +directory where you want the object files and executables to go and run +the `configure' script. `configure' automatically checks for the +source code in the directory that `configure' is in and in `..'. + + If you have to use a `make' that does not support the `VPATH' +variable, you have to compile the package for one architecture at a +time in the source code directory. After you have installed the +package for one architecture, use `make distclean' before reconfiguring +for another architecture. + +Installation Names +================== + +By default, `make install' will install the package's files in +`/usr/local/bin', `/usr/local/man', etc. You can specify an +installation prefix other than `/usr/local' by giving `configure' the +option `--prefix=PREFIX'. + + You can specify separate installation prefixes for +architecture-specific files and architecture-independent files. If you +give `configure' the option `--exec-prefix=PREFIX', the package will +use PREFIX as the prefix for installing programs and libraries. +Documentation and other data files will still use the regular prefix. + + In addition, if you use an unusual directory layout you can give +options like `--bindir=DIR' to specify different values for particular +kinds of files. Run `configure --help' for a list of the directories +you can set and what kinds of files go in them. + + If the package supports it, you can cause programs to be installed +with an extra prefix or suffix on their names by giving `configure' the +option `--program-prefix=PREFIX' or `--program-suffix=SUFFIX'. + +Optional Features +================= + +Some packages pay attention to `--enable-FEATURE' options to +`configure', where FEATURE indicates an optional part of the package. +They may also pay attention to `--with-PACKAGE' options, where PACKAGE +is something like `gnu-as' or `x' (for the X Window System). The +`README' should mention any `--enable-' and `--with-' options that the +package recognizes. + + For packages that use the X Window System, `configure' can usually +find the X include and library files automatically, but if it doesn't, +you can use the `configure' options `--x-includes=DIR' and +`--x-libraries=DIR' to specify their locations. + +Specifying the System Type +========================== + +There may be some features `configure' cannot figure out automatically, +but needs to determine by the type of machine the package will run on. +Usually, assuming the package is built to be run on the _same_ +architectures, `configure' can figure that out, but if it prints a +message saying it cannot guess the machine type, give it the +`--build=TYPE' option. TYPE can either be a short name for the system +type, such as `sun4', or a canonical name which has the form: + + CPU-COMPANY-SYSTEM + +where SYSTEM can have one of these forms: + + OS KERNEL-OS + + See the file `config.sub' for the possible values of each field. If +`config.sub' isn't included in this package, then this package doesn't +need to know the machine type. + + If you are _building_ compiler tools for cross-compiling, you should +use the `--target=TYPE' option to select the type of system they will +produce code for. + + If you want to _use_ a cross compiler, that generates code for a +platform different from the build platform, you should specify the +"host" platform (i.e., that on which the generated programs will +eventually be run) with `--host=TYPE'. + +Sharing Defaults +================ + +If you want to set default values for `configure' scripts to share, you +can create a site shell script called `config.site' that gives default +values for variables like `CC', `cache_file', and `prefix'. +`configure' looks for `PREFIX/share/config.site' if it exists, then +`PREFIX/etc/config.site' if it exists. Or, you can set the +`CONFIG_SITE' environment variable to the location of the site script. +A warning: not all `configure' scripts look for a site script. + +Defining Variables +================== + +Variables not defined in a site shell script can be set in the +environment passed to `configure'. However, some packages may run +configure again during the build, and the customized values of these +variables may be lost. In order to avoid this problem, you should set +them in the `configure' command line, using `VAR=value'. For example: + + ./configure CC=/usr/local2/bin/gcc + +will cause the specified gcc to be used as the C compiler (unless it is +overridden in the site shell script). + +`configure' Invocation +====================== + +`configure' recognizes the following options to control how it operates. + +`--help' +`-h' + Print a summary of the options to `configure', and exit. + +`--version' +`-V' + Print the version of Autoconf used to generate the `configure' + script, and exit. + +`--cache-file=FILE' + Enable the cache: use and save the results of the tests in FILE, + traditionally `config.cache'. FILE defaults to `/dev/null' to + disable caching. + +`--config-cache' +`-C' + Alias for `--cache-file=config.cache'. + +`--quiet' +`--silent' +`-q' + Do not print messages saying which checks are being made. To + suppress all normal output, redirect it to `/dev/null' (any error + messages will still be shown). + +`--srcdir=DIR' + Look for the package's source code in directory DIR. Usually + `configure' can determine that directory automatically. + +`configure' also accepts some other, not widely useful, options. Run +`configure --help' for more details. + diff --git a/libconfig-1.4.9/Makefile b/libconfig-1.4.9/Makefile new file mode 100644 index 0000000000000000000000000000000000000000..6d860099be2bd0441e29462e906e22c6c6258a55 --- /dev/null +++ b/libconfig-1.4.9/Makefile @@ -0,0 +1,774 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# Makefile. Generated from Makefile.in by configure. + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + + + +pkgdatadir = $(datadir)/libconfig +pkgincludedir = $(includedir)/libconfig +pkglibdir = $(libdir)/libconfig +pkglibexecdir = $(libexecdir)/libconfig +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = x86_64-unknown-linux-gnu +host_triplet = x86_64-unknown-linux-gnu +target_triplet = x86_64-unknown-linux-gnu +am__append_1 = examples +subdir = . +DIST_COMMON = README $(am__configure_deps) $(srcdir)/Makefile.am \ + $(srcdir)/Makefile.in $(srcdir)/ac_config.h.in \ + $(srcdir)/libconfig.spec.in $(top_srcdir)/configure AUTHORS \ + COPYING.LIB ChangeLog INSTALL NEWS TODO aux-build/compile \ + aux-build/config.guess aux-build/config.sub aux-build/depcomp \ + aux-build/install-sh aux-build/ltmain.sh aux-build/missing \ + aux-build/mkinstalldirs aux-build/texinfo.tex aux-build/ylwrap +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +am__CONFIG_DISTCLEAN_FILES = config.status config.cache config.log \ + configure.lineno config.status.lineno +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = ac_config.h +CONFIG_CLEAN_FILES = libconfig.spec +CONFIG_CLEAN_VPATH_FILES = +SOURCES = +DIST_SOURCES = +RECURSIVE_TARGETS = all-recursive check-recursive dvi-recursive \ + html-recursive info-recursive install-data-recursive \ + install-dvi-recursive install-exec-recursive \ + install-html-recursive install-info-recursive \ + install-pdf-recursive install-ps-recursive install-recursive \ + installcheck-recursive installdirs-recursive pdf-recursive \ + ps-recursive uninstall-recursive +RECURSIVE_CLEAN_TARGETS = mostlyclean-recursive clean-recursive \ + distclean-recursive maintainer-clean-recursive +AM_RECURSIVE_TARGETS = $(RECURSIVE_TARGETS:-recursive=) \ + $(RECURSIVE_CLEAN_TARGETS:-recursive=) tags TAGS ctags CTAGS \ + distdir dist dist-all distcheck +ETAGS = etags +CTAGS = ctags +DIST_SUBDIRS = lib doc tinytest tests examples +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +distdir = $(PACKAGE)-$(VERSION) +top_distdir = $(distdir) +am__remove_distdir = \ + { test ! -d "$(distdir)" \ + || { find "$(distdir)" -type d ! -perm -200 -exec chmod u+w {} ';' \ + && rm -fr "$(distdir)"; }; } +am__relativize = \ + dir0=`pwd`; \ + sed_first='s,^\([^/]*\)/.*$$,\1,'; \ + sed_rest='s,^[^/]*/*,,'; \ + sed_last='s,^.*/\([^/]*\)$$,\1,'; \ + sed_butlast='s,/*[^/]*$$,,'; \ + while test -n "$$dir1"; do \ + first=`echo "$$dir1" | sed -e "$$sed_first"`; \ + if test "$$first" != "."; then \ + if test "$$first" = ".."; then \ + dir2=`echo "$$dir0" | sed -e "$$sed_last"`/"$$dir2"; \ + dir0=`echo "$$dir0" | sed -e "$$sed_butlast"`; \ + else \ + first2=`echo "$$dir2" | sed -e "$$sed_first"`; \ + if test "$$first2" = "$$first"; then \ + dir2=`echo "$$dir2" | sed -e "$$sed_rest"`; \ + else \ + dir2="../$$dir2"; \ + fi; \ + dir0="$$dir0"/"$$first"; \ + fi; \ + fi; \ + dir1=`echo "$$dir1" | sed -e "$$sed_rest"`; \ + done; \ + reldir="$$dir2" +DIST_ARCHIVES = $(distdir).tar.gz +GZIP_ENV = --best +distuninstallcheck_listfiles = find . -type f -print +distcleancheck_listfiles = find . -type f -print +ACLOCAL = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run aclocal-1.11 +AMTAR = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run tar +AR = ar +AS = as +AUTOCONF = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoconf +AUTOHEADER = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoheader +AUTOMAKE = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run automake-1.11 +AWK = gawk +CC = gcc +CCDEPMODE = depmode=gcc3 +CFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter +CPP = gcc -E +CPPFLAGS = +CXX = g++ +CXXCPP = g++ -E +CXXDEPMODE = depmode=gcc3 +CXXFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wno-unused-parameter +CYGPATH_W = echo +DEFS = -DHAVE_CONFIG_H +DEPDIR = .deps +DLLTOOL = false +DSYMUTIL = +DUMPBIN = +ECHO_C = +ECHO_N = -n +ECHO_T = +EGREP = /usr/bin/grep -E +EXEEXT = +FGREP = /usr/bin/grep -F +GREP = /usr/bin/grep +INSTALL = /usr/bin/install -c +INSTALL_DATA = ${INSTALL} -m 644 +INSTALL_PROGRAM = ${INSTALL} +INSTALL_SCRIPT = ${INSTALL} +INSTALL_STRIP_PROGRAM = $(install_sh) -c -s +LD = /usr/bin/ld -m elf_x86_64 +LDFLAGS = +LEX = flex +LEXLIB = +LEX_OUTPUT_ROOT = lex.yy +LIBOBJS = +LIBS = +LIBTOOL = $(SHELL) $(top_builddir)/libtool +LIPO = +LN_S = ln -s +LTLIBOBJS = +MAKEINFO = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run makeinfo +MANIFEST_TOOL = : +MKDIR_P = /usr/bin/mkdir -p +NM = /usr/bin/nm -B +NMEDIT = +OBJDUMP = objdump +OBJEXT = o +OTOOL = +OTOOL64 = +PACKAGE = libconfig +PACKAGE_BUGREPORT = hyperrealm@gmail.com +PACKAGE_NAME = libconfig +PACKAGE_STRING = libconfig 1.4.9 +PACKAGE_TARNAME = libconfig +PACKAGE_URL = http://www.hyperrealm.com/main.php?s=libconfig +PACKAGE_VERSION = 1.4.9 +PATH_SEPARATOR = : +RANLIB = ranlib +SED = /usr/bin/sed +SET_MAKE = +SHELL = /bin/sh +STRIP = strip +VERSION = 1.4.9 +YACC = bison -y +YFLAGS = +abs_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +abs_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +abs_top_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +abs_top_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +ac_ct_AR = ar +ac_ct_CC = gcc +ac_ct_CXX = g++ +ac_ct_DUMPBIN = +am__include = include +am__leading_dot = . +am__quote = +am__tar = ${AMTAR} chof - "$$tardir" +am__untar = ${AMTAR} xf - +bindir = ${exec_prefix}/bin +build = x86_64-unknown-linux-gnu +build_alias = +build_cpu = x86_64 +build_os = linux-gnu +build_vendor = unknown +builddir = . +datadir = ${datarootdir} +datarootdir = ${prefix}/share +docdir = ${datarootdir}/doc/${PACKAGE_TARNAME} +dvidir = ${docdir} +exec_prefix = ${prefix} +host = x86_64-unknown-linux-gnu +host_alias = +host_cpu = x86_64 +host_os = linux-gnu +host_vendor = unknown +htmldir = ${docdir} +includedir = ${prefix}/include +infodir = ${datarootdir}/info +install_sh = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/install-sh +libdir = ${exec_prefix}/lib +libexecdir = ${exec_prefix}/libexec +localedir = ${datarootdir}/locale +localstatedir = ${prefix}/var +mandir = ${datarootdir}/man +mkdir_p = /usr/bin/mkdir -p +oldincludedir = /usr/include +pdfdir = ${docdir} +prefix = /usr/local +program_transform_name = s,x,x, +psdir = ${docdir} +sbindir = ${exec_prefix}/sbin +sharedstatedir = ${prefix}/com +srcdir = . +sysconfdir = ${prefix}/etc +target = x86_64-unknown-linux-gnu +target_alias = +target_cpu = x86_64 +target_os = linux-gnu +target_vendor = unknown +top_build_prefix = +top_builddir = . +top_srcdir = . +ACLOCAL_AMFLAGS = -I m4 +SUBDIRS = lib doc tinytest tests $(am__append_1) +EXTRA_DIST = \ + m4/*.m4 \ + *.sln \ + test.cfg \ + TODO \ + debian/changelog \ + debian/compat \ + debian/control \ + debian/copyright \ + debian/docs \ + debian/libconfig++9-dev.install \ + debian/libconfig++9.install \ + debian/libconfig9-dev.docs \ + debian/libconfig9-dev.install \ + debian/libconfig9.info \ + debian/libconfig9.install \ + debian/rules \ + debian/shlibs \ + debian/watch \ + libconfig.spec \ + contrib + +all: ac_config.h + $(MAKE) $(AM_MAKEFLAGS) all-recursive + +.SUFFIXES: +am--refresh: + @: +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + echo ' cd $(srcdir) && $(AUTOMAKE) --gnu'; \ + $(am__cd) $(srcdir) && $(AUTOMAKE) --gnu \ + && exit 0; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + echo ' $(SHELL) ./config.status'; \ + $(SHELL) ./config.status;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + $(SHELL) ./config.status --recheck + +$(top_srcdir)/configure: $(am__configure_deps) + $(am__cd) $(srcdir) && $(AUTOCONF) +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + $(am__cd) $(srcdir) && $(ACLOCAL) $(ACLOCAL_AMFLAGS) +$(am__aclocal_m4_deps): + +ac_config.h: stamp-h1 + @if test ! -f $@; then \ + rm -f stamp-h1; \ + $(MAKE) $(AM_MAKEFLAGS) stamp-h1; \ + else :; fi + +stamp-h1: $(srcdir)/ac_config.h.in $(top_builddir)/config.status + @rm -f stamp-h1 + cd $(top_builddir) && $(SHELL) ./config.status ac_config.h +$(srcdir)/ac_config.h.in: $(am__configure_deps) + ($(am__cd) $(top_srcdir) && $(AUTOHEADER)) + rm -f stamp-h1 + touch $@ + +distclean-hdr: + -rm -f ac_config.h stamp-h1 +libconfig.spec: $(top_builddir)/config.status $(srcdir)/libconfig.spec.in + cd $(top_builddir) && $(SHELL) ./config.status $@ + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +distclean-libtool: + -rm -f libtool config.lt + +# This directory's subdirectories are mostly independent; you can cd +# into them and run `make' without going through this Makefile. +# To change the values of `make' variables: instead of editing Makefiles, +# (1) if the variable is set in `config.status', edit `config.status' +# (which will cause the Makefiles to be regenerated when you run `make'); +# (2) otherwise, pass the desired values on the `make' command line. +$(RECURSIVE_TARGETS): + @fail= failcom='exit 1'; \ + for f in x $$MAKEFLAGS; do \ + case $$f in \ + *=* | --[!k]*);; \ + *k*) failcom='fail=yes';; \ + esac; \ + done; \ + dot_seen=no; \ + target=`echo $@ | sed s/-recursive//`; \ + list='$(SUBDIRS)'; for subdir in $$list; do \ + echo "Making $$target in $$subdir"; \ + if test "$$subdir" = "."; then \ + dot_seen=yes; \ + local_target="$$target-am"; \ + else \ + local_target="$$target"; \ + fi; \ + ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) $$local_target) \ + || eval $$failcom; \ + done; \ + if test "$$dot_seen" = "no"; then \ + $(MAKE) $(AM_MAKEFLAGS) "$$target-am" || exit 1; \ + fi; test -z "$$fail" + +$(RECURSIVE_CLEAN_TARGETS): + @fail= failcom='exit 1'; \ + for f in x $$MAKEFLAGS; do \ + case $$f in \ + *=* | --[!k]*);; \ + *k*) failcom='fail=yes';; \ + esac; \ + done; \ + dot_seen=no; \ + case "$@" in \ + distclean-* | maintainer-clean-*) list='$(DIST_SUBDIRS)' ;; \ + *) list='$(SUBDIRS)' ;; \ + esac; \ + rev=''; for subdir in $$list; do \ + if test "$$subdir" = "."; then :; else \ + rev="$$subdir $$rev"; \ + fi; \ + done; \ + rev="$$rev ."; \ + target=`echo $@ | sed s/-recursive//`; \ + for subdir in $$rev; do \ + echo "Making $$target in $$subdir"; \ + if test "$$subdir" = "."; then \ + local_target="$$target-am"; \ + else \ + local_target="$$target"; \ + fi; \ + ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) $$local_target) \ + || eval $$failcom; \ + done && test -z "$$fail" +tags-recursive: + list='$(SUBDIRS)'; for subdir in $$list; do \ + test "$$subdir" = . || ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) tags); \ + done +ctags-recursive: + list='$(SUBDIRS)'; for subdir in $$list; do \ + test "$$subdir" = . || ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) ctags); \ + done + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: tags-recursive $(HEADERS) $(SOURCES) ac_config.h.in $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + if ($(ETAGS) --etags-include --version) >/dev/null 2>&1; then \ + include_option=--etags-include; \ + empty_fix=.; \ + else \ + include_option=--include; \ + empty_fix=; \ + fi; \ + list='$(SUBDIRS)'; for subdir in $$list; do \ + if test "$$subdir" = .; then :; else \ + test ! -f $$subdir/TAGS || \ + set "$$@" "$$include_option=$$here/$$subdir/TAGS"; \ + fi; \ + done; \ + list='$(SOURCES) $(HEADERS) ac_config.h.in $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: ctags-recursive $(HEADERS) $(SOURCES) ac_config.h.in $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) ac_config.h.in $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + $(am__remove_distdir) + test -d "$(distdir)" || mkdir "$(distdir)" + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done + @list='$(DIST_SUBDIRS)'; for subdir in $$list; do \ + if test "$$subdir" = .; then :; else \ + test -d "$(distdir)/$$subdir" \ + || $(MKDIR_P) "$(distdir)/$$subdir" \ + || exit 1; \ + fi; \ + done + @list='$(DIST_SUBDIRS)'; for subdir in $$list; do \ + if test "$$subdir" = .; then :; else \ + dir1=$$subdir; dir2="$(distdir)/$$subdir"; \ + $(am__relativize); \ + new_distdir=$$reldir; \ + dir1=$$subdir; dir2="$(top_distdir)"; \ + $(am__relativize); \ + new_top_distdir=$$reldir; \ + echo " (cd $$subdir && $(MAKE) $(AM_MAKEFLAGS) top_distdir="$$new_top_distdir" distdir="$$new_distdir" \\"; \ + echo " am__remove_distdir=: am__skip_length_check=: am__skip_mode_fix=: distdir)"; \ + ($(am__cd) $$subdir && \ + $(MAKE) $(AM_MAKEFLAGS) \ + top_distdir="$$new_top_distdir" \ + distdir="$$new_distdir" \ + am__remove_distdir=: \ + am__skip_length_check=: \ + am__skip_mode_fix=: \ + distdir) \ + || exit 1; \ + fi; \ + done + $(MAKE) $(AM_MAKEFLAGS) \ + top_distdir="$(top_distdir)" distdir="$(distdir)" \ + dist-hook + -test -n "$(am__skip_mode_fix)" \ + || find "$(distdir)" -type d ! -perm -755 \ + -exec chmod u+rwx,go+rx {} \; -o \ + ! -type d ! -perm -444 -links 1 -exec chmod a+r {} \; -o \ + ! -type d ! -perm -400 -exec chmod a+r {} \; -o \ + ! -type d ! -perm -444 -exec $(install_sh) -c -m a+r {} {} \; \ + || chmod -R a+r "$(distdir)" +dist-gzip: distdir + tardir=$(distdir) && $(am__tar) | GZIP=$(GZIP_ENV) gzip -c >$(distdir).tar.gz + $(am__remove_distdir) + +dist-bzip2: distdir + tardir=$(distdir) && $(am__tar) | bzip2 -9 -c >$(distdir).tar.bz2 + $(am__remove_distdir) + +dist-lzma: distdir + tardir=$(distdir) && $(am__tar) | lzma -9 -c >$(distdir).tar.lzma + $(am__remove_distdir) + +dist-xz: distdir + tardir=$(distdir) && $(am__tar) | xz -c >$(distdir).tar.xz + $(am__remove_distdir) + +dist-tarZ: distdir + tardir=$(distdir) && $(am__tar) | compress -c >$(distdir).tar.Z + $(am__remove_distdir) + +dist-shar: distdir + shar $(distdir) | GZIP=$(GZIP_ENV) gzip -c >$(distdir).shar.gz + $(am__remove_distdir) + +dist-zip: distdir + -rm -f $(distdir).zip + zip -rq $(distdir).zip $(distdir) + $(am__remove_distdir) + +dist dist-all: distdir + tardir=$(distdir) && $(am__tar) | GZIP=$(GZIP_ENV) gzip -c >$(distdir).tar.gz + $(am__remove_distdir) + +# This target untars the dist file and tries a VPATH configuration. Then +# it guarantees that the distribution is self-contained by making another +# tarfile. +distcheck: dist + case '$(DIST_ARCHIVES)' in \ + *.tar.gz*) \ + GZIP=$(GZIP_ENV) gzip -dc $(distdir).tar.gz | $(am__untar) ;;\ + *.tar.bz2*) \ + bzip2 -dc $(distdir).tar.bz2 | $(am__untar) ;;\ + *.tar.lzma*) \ + lzma -dc $(distdir).tar.lzma | $(am__untar) ;;\ + *.tar.xz*) \ + xz -dc $(distdir).tar.xz | $(am__untar) ;;\ + *.tar.Z*) \ + uncompress -c $(distdir).tar.Z | $(am__untar) ;;\ + *.shar.gz*) \ + GZIP=$(GZIP_ENV) gzip -dc $(distdir).shar.gz | unshar ;;\ + *.zip*) \ + unzip $(distdir).zip ;;\ + esac + chmod -R a-w $(distdir); chmod a+w $(distdir) + mkdir $(distdir)/_build + mkdir $(distdir)/_inst + chmod a-w $(distdir) + test -d $(distdir)/_build || exit 0; \ + dc_install_base=`$(am__cd) $(distdir)/_inst && pwd | sed -e 's,^[^:\\/]:[\\/],/,'` \ + && dc_destdir="$${TMPDIR-/tmp}/am-dc-$$$$/" \ + && am__cwd=`pwd` \ + && $(am__cd) $(distdir)/_build \ + && ../configure --srcdir=.. --prefix="$$dc_install_base" \ + $(DISTCHECK_CONFIGURE_FLAGS) \ + && $(MAKE) $(AM_MAKEFLAGS) \ + && $(MAKE) $(AM_MAKEFLAGS) dvi \ + && $(MAKE) $(AM_MAKEFLAGS) check \ + && $(MAKE) $(AM_MAKEFLAGS) install \ + && $(MAKE) $(AM_MAKEFLAGS) installcheck \ + && $(MAKE) $(AM_MAKEFLAGS) uninstall \ + && $(MAKE) $(AM_MAKEFLAGS) distuninstallcheck_dir="$$dc_install_base" \ + distuninstallcheck \ + && chmod -R a-w "$$dc_install_base" \ + && ({ \ + (cd ../.. && umask 077 && mkdir "$$dc_destdir") \ + && $(MAKE) $(AM_MAKEFLAGS) DESTDIR="$$dc_destdir" install \ + && $(MAKE) $(AM_MAKEFLAGS) DESTDIR="$$dc_destdir" uninstall \ + && $(MAKE) $(AM_MAKEFLAGS) DESTDIR="$$dc_destdir" \ + distuninstallcheck_dir="$$dc_destdir" distuninstallcheck; \ + } || { rm -rf "$$dc_destdir"; exit 1; }) \ + && rm -rf "$$dc_destdir" \ + && $(MAKE) $(AM_MAKEFLAGS) dist \ + && rm -rf $(DIST_ARCHIVES) \ + && $(MAKE) $(AM_MAKEFLAGS) distcleancheck \ + && cd "$$am__cwd" \ + || exit 1 + $(am__remove_distdir) + @(echo "$(distdir) archives ready for distribution: "; \ + list='$(DIST_ARCHIVES)'; for i in $$list; do echo $$i; done) | \ + sed -e 1h -e 1s/./=/g -e 1p -e 1x -e '$$p' -e '$$x' +distuninstallcheck: + @$(am__cd) '$(distuninstallcheck_dir)' \ + && test `$(distuninstallcheck_listfiles) | wc -l` -le 1 \ + || { echo "ERROR: files left after uninstall:" ; \ + if test -n "$(DESTDIR)"; then \ + echo " (check DESTDIR support)"; \ + fi ; \ + $(distuninstallcheck_listfiles) ; \ + exit 1; } >&2 +distcleancheck: distclean + @if test '$(srcdir)' = . ; then \ + echo "ERROR: distcleancheck can only run from a VPATH build" ; \ + exit 1 ; \ + fi + @test `$(distcleancheck_listfiles) | wc -l` -eq 0 \ + || { echo "ERROR: files left in build directory after distclean:" ; \ + $(distcleancheck_listfiles) ; \ + exit 1; } >&2 +check-am: all-am +check: check-recursive +all-am: Makefile ac_config.h +installdirs: installdirs-recursive +installdirs-am: +install: install-recursive +install-exec: install-exec-recursive +install-data: install-data-recursive +uninstall: uninstall-recursive + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-recursive +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-recursive + +clean-am: clean-generic clean-libtool mostlyclean-am + +distclean: distclean-recursive + -rm -f $(am__CONFIG_DISTCLEAN_FILES) + -rm -f Makefile +distclean-am: clean-am distclean-generic distclean-hdr \ + distclean-libtool distclean-tags + +dvi: dvi-recursive + +dvi-am: + +html: html-recursive + +html-am: + +info: info-recursive + +info-am: + +install-data-am: + +install-dvi: install-dvi-recursive + +install-dvi-am: + +install-exec-am: + +install-html: install-html-recursive + +install-html-am: + +install-info: install-info-recursive + +install-info-am: + +install-man: + +install-pdf: install-pdf-recursive + +install-pdf-am: + +install-ps: install-ps-recursive + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-recursive + -rm -f $(am__CONFIG_DISTCLEAN_FILES) + -rm -rf $(top_srcdir)/autom4te.cache + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-recursive + +mostlyclean-am: mostlyclean-generic mostlyclean-libtool + +pdf: pdf-recursive + +pdf-am: + +ps: ps-recursive + +ps-am: + +uninstall-am: + +.MAKE: $(RECURSIVE_CLEAN_TARGETS) $(RECURSIVE_TARGETS) all \ + ctags-recursive install-am install-strip tags-recursive + +.PHONY: $(RECURSIVE_CLEAN_TARGETS) $(RECURSIVE_TARGETS) CTAGS GTAGS \ + all all-am am--refresh check check-am clean clean-generic \ + clean-libtool ctags ctags-recursive dist dist-all dist-bzip2 \ + dist-gzip dist-hook dist-lzma dist-shar dist-tarZ dist-xz \ + dist-zip distcheck distclean distclean-generic distclean-hdr \ + distclean-libtool distclean-tags distcleancheck distdir \ + distuninstallcheck dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-info install-info-am install-man \ + install-pdf install-pdf-am install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + installdirs-am maintainer-clean maintainer-clean-generic \ + mostlyclean mostlyclean-generic mostlyclean-libtool pdf pdf-am \ + ps ps-am tags tags-recursive uninstall uninstall-am + + +.PHONY: dist-rpm + +dist-rpm: distcheck + rpmbuild -ta $(distdir).tar.gz + +dist-hook: + rm -rf `find $(distdir)/contrib -name .svn` + +test: + cd tests && ./libconfig_tests + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/Makefile.am b/libconfig-1.4.9/Makefile.am new file mode 100644 index 0000000000000000000000000000000000000000..50ef4faa857ecfa5b9ec29392bf0c7c67236b41a --- /dev/null +++ b/libconfig-1.4.9/Makefile.am @@ -0,0 +1,41 @@ + +ACLOCAL_AMFLAGS = -I m4 + +SUBDIRS = lib doc tinytest tests + +if BUILDEXAMPLES +SUBDIRS += examples +endif + +.PHONY: dist-rpm + +dist-rpm: distcheck + rpmbuild -ta $(distdir).tar.gz + +EXTRA_DIST = \ + m4/*.m4 \ + *.sln \ + test.cfg \ + TODO \ + debian/changelog \ + debian/compat \ + debian/control \ + debian/copyright \ + debian/docs \ + debian/libconfig++9-dev.install \ + debian/libconfig++9.install \ + debian/libconfig9-dev.docs \ + debian/libconfig9-dev.install \ + debian/libconfig9.info \ + debian/libconfig9.install \ + debian/rules \ + debian/shlibs \ + debian/watch \ + libconfig.spec \ + contrib + +dist-hook: + rm -rf `find $(distdir)/contrib -name .svn` + +test: + cd tests && ./libconfig_tests diff --git a/libconfig-1.4.9/Makefile.in b/libconfig-1.4.9/Makefile.in new file mode 100644 index 0000000000000000000000000000000000000000..037e19cf0af5623e0f9746f57cbcf380158dec36 --- /dev/null +++ b/libconfig-1.4.9/Makefile.in @@ -0,0 +1,774 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# @configure_input@ + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + +@SET_MAKE@ +VPATH = @srcdir@ +pkgdatadir = $(datadir)/@PACKAGE@ +pkgincludedir = $(includedir)/@PACKAGE@ +pkglibdir = $(libdir)/@PACKAGE@ +pkglibexecdir = $(libexecdir)/@PACKAGE@ +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = @build@ +host_triplet = @host@ +target_triplet = @target@ +@BUILDEXAMPLES_TRUE@am__append_1 = examples +subdir = . +DIST_COMMON = README $(am__configure_deps) $(srcdir)/Makefile.am \ + $(srcdir)/Makefile.in $(srcdir)/ac_config.h.in \ + $(srcdir)/libconfig.spec.in $(top_srcdir)/configure AUTHORS \ + COPYING.LIB ChangeLog INSTALL NEWS TODO aux-build/compile \ + aux-build/config.guess aux-build/config.sub aux-build/depcomp \ + aux-build/install-sh aux-build/ltmain.sh aux-build/missing \ + aux-build/mkinstalldirs aux-build/texinfo.tex aux-build/ylwrap +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +am__CONFIG_DISTCLEAN_FILES = config.status config.cache config.log \ + configure.lineno config.status.lineno +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = ac_config.h +CONFIG_CLEAN_FILES = libconfig.spec +CONFIG_CLEAN_VPATH_FILES = +SOURCES = +DIST_SOURCES = +RECURSIVE_TARGETS = all-recursive check-recursive dvi-recursive \ + html-recursive info-recursive install-data-recursive \ + install-dvi-recursive install-exec-recursive \ + install-html-recursive install-info-recursive \ + install-pdf-recursive install-ps-recursive install-recursive \ + installcheck-recursive installdirs-recursive pdf-recursive \ + ps-recursive uninstall-recursive +RECURSIVE_CLEAN_TARGETS = mostlyclean-recursive clean-recursive \ + distclean-recursive maintainer-clean-recursive +AM_RECURSIVE_TARGETS = $(RECURSIVE_TARGETS:-recursive=) \ + $(RECURSIVE_CLEAN_TARGETS:-recursive=) tags TAGS ctags CTAGS \ + distdir dist dist-all distcheck +ETAGS = etags +CTAGS = ctags +DIST_SUBDIRS = lib doc tinytest tests examples +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +distdir = $(PACKAGE)-$(VERSION) +top_distdir = $(distdir) +am__remove_distdir = \ + { test ! -d "$(distdir)" \ + || { find "$(distdir)" -type d ! -perm -200 -exec chmod u+w {} ';' \ + && rm -fr "$(distdir)"; }; } +am__relativize = \ + dir0=`pwd`; \ + sed_first='s,^\([^/]*\)/.*$$,\1,'; \ + sed_rest='s,^[^/]*/*,,'; \ + sed_last='s,^.*/\([^/]*\)$$,\1,'; \ + sed_butlast='s,/*[^/]*$$,,'; \ + while test -n "$$dir1"; do \ + first=`echo "$$dir1" | sed -e "$$sed_first"`; \ + if test "$$first" != "."; then \ + if test "$$first" = ".."; then \ + dir2=`echo "$$dir0" | sed -e "$$sed_last"`/"$$dir2"; \ + dir0=`echo "$$dir0" | sed -e "$$sed_butlast"`; \ + else \ + first2=`echo "$$dir2" | sed -e "$$sed_first"`; \ + if test "$$first2" = "$$first"; then \ + dir2=`echo "$$dir2" | sed -e "$$sed_rest"`; \ + else \ + dir2="../$$dir2"; \ + fi; \ + dir0="$$dir0"/"$$first"; \ + fi; \ + fi; \ + dir1=`echo "$$dir1" | sed -e "$$sed_rest"`; \ + done; \ + reldir="$$dir2" +DIST_ARCHIVES = $(distdir).tar.gz +GZIP_ENV = --best +distuninstallcheck_listfiles = find . -type f -print +distcleancheck_listfiles = find . -type f -print +ACLOCAL = @ACLOCAL@ +AMTAR = @AMTAR@ +AR = @AR@ +AS = @AS@ +AUTOCONF = @AUTOCONF@ +AUTOHEADER = @AUTOHEADER@ +AUTOMAKE = @AUTOMAKE@ +AWK = @AWK@ +CC = @CC@ +CCDEPMODE = @CCDEPMODE@ +CFLAGS = @CFLAGS@ +CPP = @CPP@ +CPPFLAGS = @CPPFLAGS@ +CXX = @CXX@ +CXXCPP = @CXXCPP@ +CXXDEPMODE = @CXXDEPMODE@ +CXXFLAGS = @CXXFLAGS@ +CYGPATH_W = @CYGPATH_W@ +DEFS = @DEFS@ +DEPDIR = @DEPDIR@ +DLLTOOL = @DLLTOOL@ +DSYMUTIL = @DSYMUTIL@ +DUMPBIN = @DUMPBIN@ +ECHO_C = @ECHO_C@ +ECHO_N = @ECHO_N@ +ECHO_T = @ECHO_T@ +EGREP = @EGREP@ +EXEEXT = @EXEEXT@ +FGREP = @FGREP@ +GREP = @GREP@ +INSTALL = @INSTALL@ +INSTALL_DATA = @INSTALL_DATA@ +INSTALL_PROGRAM = @INSTALL_PROGRAM@ +INSTALL_SCRIPT = @INSTALL_SCRIPT@ +INSTALL_STRIP_PROGRAM = @INSTALL_STRIP_PROGRAM@ +LD = @LD@ +LDFLAGS = @LDFLAGS@ +LEX = @LEX@ +LEXLIB = @LEXLIB@ +LEX_OUTPUT_ROOT = @LEX_OUTPUT_ROOT@ +LIBOBJS = @LIBOBJS@ +LIBS = @LIBS@ +LIBTOOL = @LIBTOOL@ +LIPO = @LIPO@ +LN_S = @LN_S@ +LTLIBOBJS = @LTLIBOBJS@ +MAKEINFO = @MAKEINFO@ +MANIFEST_TOOL = @MANIFEST_TOOL@ +MKDIR_P = @MKDIR_P@ +NM = @NM@ +NMEDIT = @NMEDIT@ +OBJDUMP = @OBJDUMP@ +OBJEXT = @OBJEXT@ +OTOOL = @OTOOL@ +OTOOL64 = @OTOOL64@ +PACKAGE = @PACKAGE@ +PACKAGE_BUGREPORT = @PACKAGE_BUGREPORT@ +PACKAGE_NAME = @PACKAGE_NAME@ +PACKAGE_STRING = @PACKAGE_STRING@ +PACKAGE_TARNAME = @PACKAGE_TARNAME@ +PACKAGE_URL = @PACKAGE_URL@ +PACKAGE_VERSION = @PACKAGE_VERSION@ +PATH_SEPARATOR = @PATH_SEPARATOR@ +RANLIB = @RANLIB@ +SED = @SED@ +SET_MAKE = @SET_MAKE@ +SHELL = @SHELL@ +STRIP = @STRIP@ +VERSION = @VERSION@ +YACC = @YACC@ +YFLAGS = @YFLAGS@ +abs_builddir = @abs_builddir@ +abs_srcdir = @abs_srcdir@ +abs_top_builddir = @abs_top_builddir@ +abs_top_srcdir = @abs_top_srcdir@ +ac_ct_AR = @ac_ct_AR@ +ac_ct_CC = @ac_ct_CC@ +ac_ct_CXX = @ac_ct_CXX@ +ac_ct_DUMPBIN = @ac_ct_DUMPBIN@ +am__include = @am__include@ +am__leading_dot = @am__leading_dot@ +am__quote = @am__quote@ +am__tar = @am__tar@ +am__untar = @am__untar@ +bindir = @bindir@ +build = @build@ +build_alias = @build_alias@ +build_cpu = @build_cpu@ +build_os = @build_os@ +build_vendor = @build_vendor@ +builddir = @builddir@ +datadir = @datadir@ +datarootdir = @datarootdir@ +docdir = @docdir@ +dvidir = @dvidir@ +exec_prefix = @exec_prefix@ +host = @host@ +host_alias = @host_alias@ +host_cpu = @host_cpu@ +host_os = @host_os@ +host_vendor = @host_vendor@ +htmldir = @htmldir@ +includedir = @includedir@ +infodir = @infodir@ +install_sh = @install_sh@ +libdir = @libdir@ +libexecdir = @libexecdir@ +localedir = @localedir@ +localstatedir = @localstatedir@ +mandir = @mandir@ +mkdir_p = @mkdir_p@ +oldincludedir = @oldincludedir@ +pdfdir = @pdfdir@ +prefix = @prefix@ +program_transform_name = @program_transform_name@ +psdir = @psdir@ +sbindir = @sbindir@ +sharedstatedir = @sharedstatedir@ +srcdir = @srcdir@ +sysconfdir = @sysconfdir@ +target = @target@ +target_alias = @target_alias@ +target_cpu = @target_cpu@ +target_os = @target_os@ +target_vendor = @target_vendor@ +top_build_prefix = @top_build_prefix@ +top_builddir = @top_builddir@ +top_srcdir = @top_srcdir@ +ACLOCAL_AMFLAGS = -I m4 +SUBDIRS = lib doc tinytest tests $(am__append_1) +EXTRA_DIST = \ + m4/*.m4 \ + *.sln \ + test.cfg \ + TODO \ + debian/changelog \ + debian/compat \ + debian/control \ + debian/copyright \ + debian/docs \ + debian/libconfig++9-dev.install \ + debian/libconfig++9.install \ + debian/libconfig9-dev.docs \ + debian/libconfig9-dev.install \ + debian/libconfig9.info \ + debian/libconfig9.install \ + debian/rules \ + debian/shlibs \ + debian/watch \ + libconfig.spec \ + contrib + +all: ac_config.h + $(MAKE) $(AM_MAKEFLAGS) all-recursive + +.SUFFIXES: +am--refresh: + @: +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + echo ' cd $(srcdir) && $(AUTOMAKE) --gnu'; \ + $(am__cd) $(srcdir) && $(AUTOMAKE) --gnu \ + && exit 0; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + echo ' $(SHELL) ./config.status'; \ + $(SHELL) ./config.status;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + $(SHELL) ./config.status --recheck + +$(top_srcdir)/configure: $(am__configure_deps) + $(am__cd) $(srcdir) && $(AUTOCONF) +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + $(am__cd) $(srcdir) && $(ACLOCAL) $(ACLOCAL_AMFLAGS) +$(am__aclocal_m4_deps): + +ac_config.h: stamp-h1 + @if test ! -f $@; then \ + rm -f stamp-h1; \ + $(MAKE) $(AM_MAKEFLAGS) stamp-h1; \ + else :; fi + +stamp-h1: $(srcdir)/ac_config.h.in $(top_builddir)/config.status + @rm -f stamp-h1 + cd $(top_builddir) && $(SHELL) ./config.status ac_config.h +$(srcdir)/ac_config.h.in: $(am__configure_deps) + ($(am__cd) $(top_srcdir) && $(AUTOHEADER)) + rm -f stamp-h1 + touch $@ + +distclean-hdr: + -rm -f ac_config.h stamp-h1 +libconfig.spec: $(top_builddir)/config.status $(srcdir)/libconfig.spec.in + cd $(top_builddir) && $(SHELL) ./config.status $@ + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +distclean-libtool: + -rm -f libtool config.lt + +# This directory's subdirectories are mostly independent; you can cd +# into them and run `make' without going through this Makefile. +# To change the values of `make' variables: instead of editing Makefiles, +# (1) if the variable is set in `config.status', edit `config.status' +# (which will cause the Makefiles to be regenerated when you run `make'); +# (2) otherwise, pass the desired values on the `make' command line. +$(RECURSIVE_TARGETS): + @fail= failcom='exit 1'; \ + for f in x $$MAKEFLAGS; do \ + case $$f in \ + *=* | --[!k]*);; \ + *k*) failcom='fail=yes';; \ + esac; \ + done; \ + dot_seen=no; \ + target=`echo $@ | sed s/-recursive//`; \ + list='$(SUBDIRS)'; for subdir in $$list; do \ + echo "Making $$target in $$subdir"; \ + if test "$$subdir" = "."; then \ + dot_seen=yes; \ + local_target="$$target-am"; \ + else \ + local_target="$$target"; \ + fi; \ + ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) $$local_target) \ + || eval $$failcom; \ + done; \ + if test "$$dot_seen" = "no"; then \ + $(MAKE) $(AM_MAKEFLAGS) "$$target-am" || exit 1; \ + fi; test -z "$$fail" + +$(RECURSIVE_CLEAN_TARGETS): + @fail= failcom='exit 1'; \ + for f in x $$MAKEFLAGS; do \ + case $$f in \ + *=* | --[!k]*);; \ + *k*) failcom='fail=yes';; \ + esac; \ + done; \ + dot_seen=no; \ + case "$@" in \ + distclean-* | maintainer-clean-*) list='$(DIST_SUBDIRS)' ;; \ + *) list='$(SUBDIRS)' ;; \ + esac; \ + rev=''; for subdir in $$list; do \ + if test "$$subdir" = "."; then :; else \ + rev="$$subdir $$rev"; \ + fi; \ + done; \ + rev="$$rev ."; \ + target=`echo $@ | sed s/-recursive//`; \ + for subdir in $$rev; do \ + echo "Making $$target in $$subdir"; \ + if test "$$subdir" = "."; then \ + local_target="$$target-am"; \ + else \ + local_target="$$target"; \ + fi; \ + ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) $$local_target) \ + || eval $$failcom; \ + done && test -z "$$fail" +tags-recursive: + list='$(SUBDIRS)'; for subdir in $$list; do \ + test "$$subdir" = . || ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) tags); \ + done +ctags-recursive: + list='$(SUBDIRS)'; for subdir in $$list; do \ + test "$$subdir" = . || ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) ctags); \ + done + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: tags-recursive $(HEADERS) $(SOURCES) ac_config.h.in $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + if ($(ETAGS) --etags-include --version) >/dev/null 2>&1; then \ + include_option=--etags-include; \ + empty_fix=.; \ + else \ + include_option=--include; \ + empty_fix=; \ + fi; \ + list='$(SUBDIRS)'; for subdir in $$list; do \ + if test "$$subdir" = .; then :; else \ + test ! -f $$subdir/TAGS || \ + set "$$@" "$$include_option=$$here/$$subdir/TAGS"; \ + fi; \ + done; \ + list='$(SOURCES) $(HEADERS) ac_config.h.in $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: ctags-recursive $(HEADERS) $(SOURCES) ac_config.h.in $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) ac_config.h.in $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + $(am__remove_distdir) + test -d "$(distdir)" || mkdir "$(distdir)" + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done + @list='$(DIST_SUBDIRS)'; for subdir in $$list; do \ + if test "$$subdir" = .; then :; else \ + test -d "$(distdir)/$$subdir" \ + || $(MKDIR_P) "$(distdir)/$$subdir" \ + || exit 1; \ + fi; \ + done + @list='$(DIST_SUBDIRS)'; for subdir in $$list; do \ + if test "$$subdir" = .; then :; else \ + dir1=$$subdir; dir2="$(distdir)/$$subdir"; \ + $(am__relativize); \ + new_distdir=$$reldir; \ + dir1=$$subdir; dir2="$(top_distdir)"; \ + $(am__relativize); \ + new_top_distdir=$$reldir; \ + echo " (cd $$subdir && $(MAKE) $(AM_MAKEFLAGS) top_distdir="$$new_top_distdir" distdir="$$new_distdir" \\"; \ + echo " am__remove_distdir=: am__skip_length_check=: am__skip_mode_fix=: distdir)"; \ + ($(am__cd) $$subdir && \ + $(MAKE) $(AM_MAKEFLAGS) \ + top_distdir="$$new_top_distdir" \ + distdir="$$new_distdir" \ + am__remove_distdir=: \ + am__skip_length_check=: \ + am__skip_mode_fix=: \ + distdir) \ + || exit 1; \ + fi; \ + done + $(MAKE) $(AM_MAKEFLAGS) \ + top_distdir="$(top_distdir)" distdir="$(distdir)" \ + dist-hook + -test -n "$(am__skip_mode_fix)" \ + || find "$(distdir)" -type d ! -perm -755 \ + -exec chmod u+rwx,go+rx {} \; -o \ + ! -type d ! -perm -444 -links 1 -exec chmod a+r {} \; -o \ + ! -type d ! -perm -400 -exec chmod a+r {} \; -o \ + ! -type d ! -perm -444 -exec $(install_sh) -c -m a+r {} {} \; \ + || chmod -R a+r "$(distdir)" +dist-gzip: distdir + tardir=$(distdir) && $(am__tar) | GZIP=$(GZIP_ENV) gzip -c >$(distdir).tar.gz + $(am__remove_distdir) + +dist-bzip2: distdir + tardir=$(distdir) && $(am__tar) | bzip2 -9 -c >$(distdir).tar.bz2 + $(am__remove_distdir) + +dist-lzma: distdir + tardir=$(distdir) && $(am__tar) | lzma -9 -c >$(distdir).tar.lzma + $(am__remove_distdir) + +dist-xz: distdir + tardir=$(distdir) && $(am__tar) | xz -c >$(distdir).tar.xz + $(am__remove_distdir) + +dist-tarZ: distdir + tardir=$(distdir) && $(am__tar) | compress -c >$(distdir).tar.Z + $(am__remove_distdir) + +dist-shar: distdir + shar $(distdir) | GZIP=$(GZIP_ENV) gzip -c >$(distdir).shar.gz + $(am__remove_distdir) + +dist-zip: distdir + -rm -f $(distdir).zip + zip -rq $(distdir).zip $(distdir) + $(am__remove_distdir) + +dist dist-all: distdir + tardir=$(distdir) && $(am__tar) | GZIP=$(GZIP_ENV) gzip -c >$(distdir).tar.gz + $(am__remove_distdir) + +# This target untars the dist file and tries a VPATH configuration. Then +# it guarantees that the distribution is self-contained by making another +# tarfile. +distcheck: dist + case '$(DIST_ARCHIVES)' in \ + *.tar.gz*) \ + GZIP=$(GZIP_ENV) gzip -dc $(distdir).tar.gz | $(am__untar) ;;\ + *.tar.bz2*) \ + bzip2 -dc $(distdir).tar.bz2 | $(am__untar) ;;\ + *.tar.lzma*) \ + lzma -dc $(distdir).tar.lzma | $(am__untar) ;;\ + *.tar.xz*) \ + xz -dc $(distdir).tar.xz | $(am__untar) ;;\ + *.tar.Z*) \ + uncompress -c $(distdir).tar.Z | $(am__untar) ;;\ + *.shar.gz*) \ + GZIP=$(GZIP_ENV) gzip -dc $(distdir).shar.gz | unshar ;;\ + *.zip*) \ + unzip $(distdir).zip ;;\ + esac + chmod -R a-w $(distdir); chmod a+w $(distdir) + mkdir $(distdir)/_build + mkdir $(distdir)/_inst + chmod a-w $(distdir) + test -d $(distdir)/_build || exit 0; \ + dc_install_base=`$(am__cd) $(distdir)/_inst && pwd | sed -e 's,^[^:\\/]:[\\/],/,'` \ + && dc_destdir="$${TMPDIR-/tmp}/am-dc-$$$$/" \ + && am__cwd=`pwd` \ + && $(am__cd) $(distdir)/_build \ + && ../configure --srcdir=.. --prefix="$$dc_install_base" \ + $(DISTCHECK_CONFIGURE_FLAGS) \ + && $(MAKE) $(AM_MAKEFLAGS) \ + && $(MAKE) $(AM_MAKEFLAGS) dvi \ + && $(MAKE) $(AM_MAKEFLAGS) check \ + && $(MAKE) $(AM_MAKEFLAGS) install \ + && $(MAKE) $(AM_MAKEFLAGS) installcheck \ + && $(MAKE) $(AM_MAKEFLAGS) uninstall \ + && $(MAKE) $(AM_MAKEFLAGS) distuninstallcheck_dir="$$dc_install_base" \ + distuninstallcheck \ + && chmod -R a-w "$$dc_install_base" \ + && ({ \ + (cd ../.. && umask 077 && mkdir "$$dc_destdir") \ + && $(MAKE) $(AM_MAKEFLAGS) DESTDIR="$$dc_destdir" install \ + && $(MAKE) $(AM_MAKEFLAGS) DESTDIR="$$dc_destdir" uninstall \ + && $(MAKE) $(AM_MAKEFLAGS) DESTDIR="$$dc_destdir" \ + distuninstallcheck_dir="$$dc_destdir" distuninstallcheck; \ + } || { rm -rf "$$dc_destdir"; exit 1; }) \ + && rm -rf "$$dc_destdir" \ + && $(MAKE) $(AM_MAKEFLAGS) dist \ + && rm -rf $(DIST_ARCHIVES) \ + && $(MAKE) $(AM_MAKEFLAGS) distcleancheck \ + && cd "$$am__cwd" \ + || exit 1 + $(am__remove_distdir) + @(echo "$(distdir) archives ready for distribution: "; \ + list='$(DIST_ARCHIVES)'; for i in $$list; do echo $$i; done) | \ + sed -e 1h -e 1s/./=/g -e 1p -e 1x -e '$$p' -e '$$x' +distuninstallcheck: + @$(am__cd) '$(distuninstallcheck_dir)' \ + && test `$(distuninstallcheck_listfiles) | wc -l` -le 1 \ + || { echo "ERROR: files left after uninstall:" ; \ + if test -n "$(DESTDIR)"; then \ + echo " (check DESTDIR support)"; \ + fi ; \ + $(distuninstallcheck_listfiles) ; \ + exit 1; } >&2 +distcleancheck: distclean + @if test '$(srcdir)' = . ; then \ + echo "ERROR: distcleancheck can only run from a VPATH build" ; \ + exit 1 ; \ + fi + @test `$(distcleancheck_listfiles) | wc -l` -eq 0 \ + || { echo "ERROR: files left in build directory after distclean:" ; \ + $(distcleancheck_listfiles) ; \ + exit 1; } >&2 +check-am: all-am +check: check-recursive +all-am: Makefile ac_config.h +installdirs: installdirs-recursive +installdirs-am: +install: install-recursive +install-exec: install-exec-recursive +install-data: install-data-recursive +uninstall: uninstall-recursive + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-recursive +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-recursive + +clean-am: clean-generic clean-libtool mostlyclean-am + +distclean: distclean-recursive + -rm -f $(am__CONFIG_DISTCLEAN_FILES) + -rm -f Makefile +distclean-am: clean-am distclean-generic distclean-hdr \ + distclean-libtool distclean-tags + +dvi: dvi-recursive + +dvi-am: + +html: html-recursive + +html-am: + +info: info-recursive + +info-am: + +install-data-am: + +install-dvi: install-dvi-recursive + +install-dvi-am: + +install-exec-am: + +install-html: install-html-recursive + +install-html-am: + +install-info: install-info-recursive + +install-info-am: + +install-man: + +install-pdf: install-pdf-recursive + +install-pdf-am: + +install-ps: install-ps-recursive + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-recursive + -rm -f $(am__CONFIG_DISTCLEAN_FILES) + -rm -rf $(top_srcdir)/autom4te.cache + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-recursive + +mostlyclean-am: mostlyclean-generic mostlyclean-libtool + +pdf: pdf-recursive + +pdf-am: + +ps: ps-recursive + +ps-am: + +uninstall-am: + +.MAKE: $(RECURSIVE_CLEAN_TARGETS) $(RECURSIVE_TARGETS) all \ + ctags-recursive install-am install-strip tags-recursive + +.PHONY: $(RECURSIVE_CLEAN_TARGETS) $(RECURSIVE_TARGETS) CTAGS GTAGS \ + all all-am am--refresh check check-am clean clean-generic \ + clean-libtool ctags ctags-recursive dist dist-all dist-bzip2 \ + dist-gzip dist-hook dist-lzma dist-shar dist-tarZ dist-xz \ + dist-zip distcheck distclean distclean-generic distclean-hdr \ + distclean-libtool distclean-tags distcleancheck distdir \ + distuninstallcheck dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-info install-info-am install-man \ + install-pdf install-pdf-am install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + installdirs-am maintainer-clean maintainer-clean-generic \ + mostlyclean mostlyclean-generic mostlyclean-libtool pdf pdf-am \ + ps ps-am tags tags-recursive uninstall uninstall-am + + +.PHONY: dist-rpm + +dist-rpm: distcheck + rpmbuild -ta $(distdir).tar.gz + +dist-hook: + rm -rf `find $(distdir)/contrib -name .svn` + +test: + cd tests && ./libconfig_tests + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/NEWS b/libconfig-1.4.9/NEWS new file mode 100644 index 0000000000000000000000000000000000000000..e69de29bb2d1d6434b8b29ae775ad8c2e48c5391 diff --git a/libconfig-1.4.9/README b/libconfig-1.4.9/README new file mode 100644 index 0000000000000000000000000000000000000000..e3def503f3a3798255d79a110c52cb0f353fd3c8 --- /dev/null +++ b/libconfig-1.4.9/README @@ -0,0 +1,58 @@ + +To produce a PDF manual, issue the command "make pdf" after running +`./configure'. + + -*- + +If you do not wish to build the C++ components, use: + +./configure --disable-cxx + + -*- + +The `examples' subdirectory contains some examples of using libconfig +from C and C++. + + -*- + +The config file syntax changed between versions 0.8 and 0.9. In order +to implement all of the feature/enhancement requests in an elegant and +self-consistent way, the configuration grammar had to be changed in a +non-backward-compatible way. In particular, groups are now values, so +the old syntax: + +group +{ + ... +} + +must now be written as: + +group = +{ + ... +}; + +Note that the trailing semicolon, which was previously optional, is +now required. Also note that a colon (':') can be used in place of the +equals sign. + + -*- + +Flex and Bison are not required in order to build this +package. However, if you modify the .l or .y files, you must have Flex +(2.5.31 or better) and Bison (2.1 or better), respectively. + + -*- + +To successfully compile using MinGW (with gcc 4.4.0 or later), it may +be necessary to modify the file "mingw32\4.4.0\libstdc++.la", changing line 11 +from: + +library_names='libstdc++.dll.a' + +to: + +library_names='libstdc++.a' + +(See http://trac.osgeo.org/geos/ticket/282 for more information). diff --git a/libconfig-1.4.9/TODO b/libconfig-1.4.9/TODO new file mode 100644 index 0000000000000000000000000000000000000000..2df9070601fcad0885079fff98c26f0b007db92e --- /dev/null +++ b/libconfig-1.4.9/TODO @@ -0,0 +1,44 @@ +TO-DOs: + +These are features that have been requested, and have been considered, +but are not yet implemented, because I'm undecided about how or whether they +should be implemented, and/or because they are difficult and/or time-consuming +to implement. + +Also, some of these features tend to push libconfig toward becoming a +general-purpose structured-data storage mechanism, which is really not the +intended purpose of this library. I think something like sqlite is better +suited for that sort of thing. + + +* Add an option for safe type conversions; that is, report an error + rather than silently truncating out-of-range values to 0 (namely int64 -> + int). + + +* Add support for copying settings from one configuration to another. Need a + recursive function to copy a setting and call itself on all child settings. + + +* Add a += operator, so that additional elements can be appended to a list or + array. The issue with this is defining a consistent syntax. For example: + + x = ( 1, 2, 3 ); + x += ( 4, 5 ); + + Should this result in ( 1, 2, 3, 4, 5 ), or ( 1, 2, 3, ( 4, 5 ))? I believe + it should be the latter. However, only the former makes sense for arrays. + + +* Add the ability to insert/delete elements at any position in a list or + array. A simple implementation would be expensive (shift all the elements + by one for every insert/delete), and a more efficient implementation would + add a lot of complexity to the library. + + +* Add limited support for preserving comments? + + +* Add support for unicode strings? A bit problematic, since flex doesn't + support unicode input, AFAICT. But maybe supply convenience functions to + convert between parsed UTF-8 strings and std::wstring. diff --git a/libconfig-1.4.9/ac_config.h b/libconfig-1.4.9/ac_config.h new file mode 100644 index 0000000000000000000000000000000000000000..bf60181259c3b3090c353b1f2ffed6fad607c362 --- /dev/null +++ b/libconfig-1.4.9/ac_config.h @@ -0,0 +1,120 @@ +/* ac_config.h. Generated from ac_config.h.in by configure. */ +/* ac_config.h.in. Generated from configure.ac by autoheader. */ + +/* Define to 1 if you have the header file. */ +#define HAVE_DLFCN_H 1 + +/* Define to 1 if you have the `freelocale' function. */ +#define HAVE_FREELOCALE 1 + +/* Define to 1 if you have the header file. */ +#define HAVE_INTTYPES_H 1 + +/* Define to 1 if you have the header file. */ +#define HAVE_MEMORY_H 1 + +/* Define to 1 if you have the `newlocale' function. */ +#define HAVE_NEWLOCALE 1 + +/* Define to 1 if you have the header file. */ +#define HAVE_STDINT_H 1 + +/* Define to 1 if you have the header file. */ +#define HAVE_STDLIB_H 1 + +/* Define to 1 if you have the header file. */ +#define HAVE_STRINGS_H 1 + +/* Define to 1 if you have the header file. */ +#define HAVE_STRING_H 1 + +/* Define to 1 if you have the header file. */ +#define HAVE_SYS_STAT_H 1 + +/* Define to 1 if you have the header file. */ +#define HAVE_SYS_TYPES_H 1 + +/* Define to 1 if you have the header file. */ +#define HAVE_UNISTD_H 1 + +/* Define to 1 if you have the `uselocale' function. */ +#define HAVE_USELOCALE 1 + +/* Define to 1 if you have the header file. */ +#define HAVE_XLOCALE_H 1 + +/* Define to the sub-directory in which libtool stores uninstalled libraries. + */ +#define LT_OBJDIR ".libs/" + +/* Define to 1 if your C compiler doesn't accept -c and -o together. */ +/* #undef NO_MINUS_C_MINUS_O */ + +/* Name of package */ +#define PACKAGE "libconfig" + +/* Define to the address where bug reports for this package should be sent. */ +#define PACKAGE_BUGREPORT "hyperrealm@gmail.com" + +/* Define to the full name of this package. */ +#define PACKAGE_NAME "libconfig" + +/* Define to the full name and version of this package. */ +#define PACKAGE_STRING "libconfig 1.4.9" + +/* Define to the one symbol short name of this package. */ +#define PACKAGE_TARNAME "libconfig" + +/* Define to the home page for this package. */ +#define PACKAGE_URL "http://www.hyperrealm.com/main.php?s=libconfig" + +/* Define to the version of this package. */ +#define PACKAGE_VERSION "1.4.9" + +/* Define to 1 if you have the ANSI C header files. */ +#define STDC_HEADERS 1 + +/* Configured target name. */ +#define TARGET "x86_64-unknown-linux-gnu" + +/* Enable extensions on AIX 3, Interix. */ +#ifndef _ALL_SOURCE +# define _ALL_SOURCE 1 +#endif +/* Enable GNU extensions on systems that have them. */ +#ifndef _GNU_SOURCE +# define _GNU_SOURCE 1 +#endif +/* Enable threading extensions on Solaris. */ +#ifndef _POSIX_PTHREAD_SEMANTICS +# define _POSIX_PTHREAD_SEMANTICS 1 +#endif +/* Enable extensions on HP NonStop. */ +#ifndef _TANDEM_SOURCE +# define _TANDEM_SOURCE 1 +#endif +/* Enable general extensions on Solaris. */ +#ifndef __EXTENSIONS__ +# define __EXTENSIONS__ 1 +#endif + + +/* Version number of package */ +#define VERSION "1.4.9" + +/* Define to 1 if `lex' declares `yytext' as a `char *' by default, not a + `char[]'. */ +/* #undef YYTEXT_POINTER */ + +/* Define to 1 if on MINIX. */ +/* #undef _MINIX */ + +/* Define to 2 if the system does not provide POSIX.1 features except with + this defined. */ +/* #undef _POSIX_1_SOURCE */ + +/* Define to 1 if you need to in order for `stat' and other things to work. */ +/* #undef _POSIX_SOURCE */ + +/* Define to empty if `const' does not conform to ANSI C. */ +/* #undef const */ diff --git a/libconfig-1.4.9/ac_config.h.in b/libconfig-1.4.9/ac_config.h.in new file mode 100644 index 0000000000000000000000000000000000000000..d69e45aed211239c3f77ab18a023b8dafe19763b --- /dev/null +++ b/libconfig-1.4.9/ac_config.h.in @@ -0,0 +1,119 @@ +/* ac_config.h.in. Generated from configure.ac by autoheader. */ + +/* Define to 1 if you have the header file. */ +#undef HAVE_DLFCN_H + +/* Define to 1 if you have the `freelocale' function. */ +#undef HAVE_FREELOCALE + +/* Define to 1 if you have the header file. */ +#undef HAVE_INTTYPES_H + +/* Define to 1 if you have the header file. */ +#undef HAVE_MEMORY_H + +/* Define to 1 if you have the `newlocale' function. */ +#undef HAVE_NEWLOCALE + +/* Define to 1 if you have the header file. */ +#undef HAVE_STDINT_H + +/* Define to 1 if you have the header file. */ +#undef HAVE_STDLIB_H + +/* Define to 1 if you have the header file. */ +#undef HAVE_STRINGS_H + +/* Define to 1 if you have the header file. */ +#undef HAVE_STRING_H + +/* Define to 1 if you have the header file. */ +#undef HAVE_SYS_STAT_H + +/* Define to 1 if you have the header file. */ +#undef HAVE_SYS_TYPES_H + +/* Define to 1 if you have the header file. */ +#undef HAVE_UNISTD_H + +/* Define to 1 if you have the `uselocale' function. */ +#undef HAVE_USELOCALE + +/* Define to 1 if you have the header file. */ +#undef HAVE_XLOCALE_H + +/* Define to the sub-directory in which libtool stores uninstalled libraries. + */ +#undef LT_OBJDIR + +/* Define to 1 if your C compiler doesn't accept -c and -o together. */ +#undef NO_MINUS_C_MINUS_O + +/* Name of package */ +#undef PACKAGE + +/* Define to the address where bug reports for this package should be sent. */ +#undef PACKAGE_BUGREPORT + +/* Define to the full name of this package. */ +#undef PACKAGE_NAME + +/* Define to the full name and version of this package. */ +#undef PACKAGE_STRING + +/* Define to the one symbol short name of this package. */ +#undef PACKAGE_TARNAME + +/* Define to the home page for this package. */ +#undef PACKAGE_URL + +/* Define to the version of this package. */ +#undef PACKAGE_VERSION + +/* Define to 1 if you have the ANSI C header files. */ +#undef STDC_HEADERS + +/* Configured target name. */ +#undef TARGET + +/* Enable extensions on AIX 3, Interix. */ +#ifndef _ALL_SOURCE +# undef _ALL_SOURCE +#endif +/* Enable GNU extensions on systems that have them. */ +#ifndef _GNU_SOURCE +# undef _GNU_SOURCE +#endif +/* Enable threading extensions on Solaris. */ +#ifndef _POSIX_PTHREAD_SEMANTICS +# undef _POSIX_PTHREAD_SEMANTICS +#endif +/* Enable extensions on HP NonStop. */ +#ifndef _TANDEM_SOURCE +# undef _TANDEM_SOURCE +#endif +/* Enable general extensions on Solaris. */ +#ifndef __EXTENSIONS__ +# undef __EXTENSIONS__ +#endif + + +/* Version number of package */ +#undef VERSION + +/* Define to 1 if `lex' declares `yytext' as a `char *' by default, not a + `char[]'. */ +#undef YYTEXT_POINTER + +/* Define to 1 if on MINIX. */ +#undef _MINIX + +/* Define to 2 if the system does not provide POSIX.1 features except with + this defined. */ +#undef _POSIX_1_SOURCE + +/* Define to 1 if you need to in order for `stat' and other things to work. */ +#undef _POSIX_SOURCE + +/* Define to empty if `const' does not conform to ANSI C. */ +#undef const diff --git a/libconfig-1.4.9/aclocal.m4 b/libconfig-1.4.9/aclocal.m4 new file mode 100644 index 0000000000000000000000000000000000000000..645675e5cabaa1d412b5dc9ce0d17c3f33f6f2fa --- /dev/null +++ b/libconfig-1.4.9/aclocal.m4 @@ -0,0 +1,9606 @@ +# generated automatically by aclocal 1.11.1 -*- Autoconf -*- + +# Copyright (C) 1996, 1997, 1998, 1999, 2000, 2001, 2002, 2003, 2004, +# 2005, 2006, 2007, 2008, 2009 Free Software Foundation, Inc. +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + +m4_ifndef([AC_AUTOCONF_VERSION], + [m4_copy([m4_PACKAGE_VERSION], [AC_AUTOCONF_VERSION])])dnl +m4_if(m4_defn([AC_AUTOCONF_VERSION]), [2.68],, +[m4_warning([this file was generated for autoconf 2.68. +You have another version of autoconf. It may work, but is not guaranteed to. +If you have problems, you may need to regenerate the build system entirely. +To do so, use the procedure documented by the package, typically `autoreconf'.])]) + +# libtool.m4 - Configure libtool for the host system. -*-Autoconf-*- +# +# Copyright (C) 1996, 1997, 1998, 1999, 2000, 2001, 2003, 2004, 2005, +# 2006, 2007, 2008, 2009, 2010, 2011 Free Software +# Foundation, Inc. +# Written by Gordon Matzigkeit, 1996 +# +# This file is free software; the Free Software Foundation gives +# unlimited permission to copy and/or distribute it, with or without +# modifications, as long as this notice is preserved. + +m4_define([_LT_COPYING], [dnl +# Copyright (C) 1996, 1997, 1998, 1999, 2000, 2001, 2003, 2004, 2005, +# 2006, 2007, 2008, 2009, 2010, 2011 Free Software +# Foundation, Inc. +# Written by Gordon Matzigkeit, 1996 +# +# This file is part of GNU Libtool. +# +# GNU Libtool is free software; you can redistribute it and/or +# modify it under the terms of the GNU General Public License as +# published by the Free Software Foundation; either version 2 of +# the License, or (at your option) any later version. +# +# As a special exception to the GNU General Public License, +# if you distribute this file as part of a program or library that +# is built using GNU Libtool, you may include this file under the +# same distribution terms that you use for the rest of that program. +# +# GNU Libtool is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY; without even the implied warranty of +# MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +# GNU General Public License for more details. +# +# You should have received a copy of the GNU General Public License +# along with GNU Libtool; see the file COPYING. If not, a copy +# can be downloaded from http://www.gnu.org/licenses/gpl.html, or +# obtained by writing to the Free Software Foundation, Inc., +# 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301, USA. +]) + +# serial 57 LT_INIT + + +# LT_PREREQ(VERSION) +# ------------------ +# Complain and exit if this libtool version is less that VERSION. +m4_defun([LT_PREREQ], +[m4_if(m4_version_compare(m4_defn([LT_PACKAGE_VERSION]), [$1]), -1, + [m4_default([$3], + [m4_fatal([Libtool version $1 or higher is required], + 63)])], + [$2])]) + + +# _LT_CHECK_BUILDDIR +# ------------------ +# Complain if the absolute build directory name contains unusual characters +m4_defun([_LT_CHECK_BUILDDIR], +[case `pwd` in + *\ * | *\ *) + AC_MSG_WARN([Libtool does not cope well with whitespace in `pwd`]) ;; +esac +]) + + +# LT_INIT([OPTIONS]) +# ------------------ +AC_DEFUN([LT_INIT], +[AC_PREREQ([2.58])dnl We use AC_INCLUDES_DEFAULT +AC_REQUIRE([AC_CONFIG_AUX_DIR_DEFAULT])dnl +AC_BEFORE([$0], [LT_LANG])dnl +AC_BEFORE([$0], [LT_OUTPUT])dnl +AC_BEFORE([$0], [LTDL_INIT])dnl +m4_require([_LT_CHECK_BUILDDIR])dnl + +dnl Autoconf doesn't catch unexpanded LT_ macros by default: +m4_pattern_forbid([^_?LT_[A-Z_]+$])dnl +m4_pattern_allow([^(_LT_EOF|LT_DLGLOBAL|LT_DLLAZY_OR_NOW|LT_MULTI_MODULE)$])dnl +dnl aclocal doesn't pull ltoptions.m4, ltsugar.m4, or ltversion.m4 +dnl unless we require an AC_DEFUNed macro: +AC_REQUIRE([LTOPTIONS_VERSION])dnl +AC_REQUIRE([LTSUGAR_VERSION])dnl +AC_REQUIRE([LTVERSION_VERSION])dnl +AC_REQUIRE([LTOBSOLETE_VERSION])dnl +m4_require([_LT_PROG_LTMAIN])dnl + +_LT_SHELL_INIT([SHELL=${CONFIG_SHELL-/bin/sh}]) + +dnl Parse OPTIONS +_LT_SET_OPTIONS([$0], [$1]) + +# This can be used to rebuild libtool when needed +LIBTOOL_DEPS="$ltmain" + +# Always use our own libtool. +LIBTOOL='$(SHELL) $(top_builddir)/libtool' +AC_SUBST(LIBTOOL)dnl + +_LT_SETUP + +# Only expand once: +m4_define([LT_INIT]) +])# LT_INIT + +# Old names: +AU_ALIAS([AC_PROG_LIBTOOL], [LT_INIT]) +AU_ALIAS([AM_PROG_LIBTOOL], [LT_INIT]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_PROG_LIBTOOL], []) +dnl AC_DEFUN([AM_PROG_LIBTOOL], []) + + +# _LT_CC_BASENAME(CC) +# ------------------- +# Calculate cc_basename. Skip known compiler wrappers and cross-prefix. +m4_defun([_LT_CC_BASENAME], +[for cc_temp in $1""; do + case $cc_temp in + compile | *[[\\/]]compile | ccache | *[[\\/]]ccache ) ;; + distcc | *[[\\/]]distcc | purify | *[[\\/]]purify ) ;; + \-*) ;; + *) break;; + esac +done +cc_basename=`$ECHO "$cc_temp" | $SED "s%.*/%%; s%^$host_alias-%%"` +]) + + +# _LT_FILEUTILS_DEFAULTS +# ---------------------- +# It is okay to use these file commands and assume they have been set +# sensibly after `m4_require([_LT_FILEUTILS_DEFAULTS])'. +m4_defun([_LT_FILEUTILS_DEFAULTS], +[: ${CP="cp -f"} +: ${MV="mv -f"} +: ${RM="rm -f"} +])# _LT_FILEUTILS_DEFAULTS + + +# _LT_SETUP +# --------- +m4_defun([_LT_SETUP], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +AC_REQUIRE([AC_CANONICAL_BUILD])dnl +AC_REQUIRE([_LT_PREPARE_SED_QUOTE_VARS])dnl +AC_REQUIRE([_LT_PROG_ECHO_BACKSLASH])dnl + +_LT_DECL([], [PATH_SEPARATOR], [1], [The PATH separator for the build system])dnl +dnl +_LT_DECL([], [host_alias], [0], [The host system])dnl +_LT_DECL([], [host], [0])dnl +_LT_DECL([], [host_os], [0])dnl +dnl +_LT_DECL([], [build_alias], [0], [The build system])dnl +_LT_DECL([], [build], [0])dnl +_LT_DECL([], [build_os], [0])dnl +dnl +AC_REQUIRE([AC_PROG_CC])dnl +AC_REQUIRE([LT_PATH_LD])dnl +AC_REQUIRE([LT_PATH_NM])dnl +dnl +AC_REQUIRE([AC_PROG_LN_S])dnl +test -z "$LN_S" && LN_S="ln -s" +_LT_DECL([], [LN_S], [1], [Whether we need soft or hard links])dnl +dnl +AC_REQUIRE([LT_CMD_MAX_LEN])dnl +_LT_DECL([objext], [ac_objext], [0], [Object file suffix (normally "o")])dnl +_LT_DECL([], [exeext], [0], [Executable file suffix (normally "")])dnl +dnl +m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_CHECK_SHELL_FEATURES])dnl +m4_require([_LT_PATH_CONVERSION_FUNCTIONS])dnl +m4_require([_LT_CMD_RELOAD])dnl +m4_require([_LT_CHECK_MAGIC_METHOD])dnl +m4_require([_LT_CHECK_SHAREDLIB_FROM_LINKLIB])dnl +m4_require([_LT_CMD_OLD_ARCHIVE])dnl +m4_require([_LT_CMD_GLOBAL_SYMBOLS])dnl +m4_require([_LT_WITH_SYSROOT])dnl + +_LT_CONFIG_LIBTOOL_INIT([ +# See if we are running on zsh, and set the options which allow our +# commands through without removal of \ escapes INIT. +if test -n "\${ZSH_VERSION+set}" ; then + setopt NO_GLOB_SUBST +fi +]) +if test -n "${ZSH_VERSION+set}" ; then + setopt NO_GLOB_SUBST +fi + +_LT_CHECK_OBJDIR + +m4_require([_LT_TAG_COMPILER])dnl + +case $host_os in +aix3*) + # AIX sometimes has problems with the GCC collect2 program. For some + # reason, if we set the COLLECT_NAMES environment variable, the problems + # vanish in a puff of smoke. + if test "X${COLLECT_NAMES+set}" != Xset; then + COLLECT_NAMES= + export COLLECT_NAMES + fi + ;; +esac + +# Global variables: +ofile=libtool +can_build_shared=yes + +# All known linkers require a `.a' archive for static linking (except MSVC, +# which needs '.lib'). +libext=a + +with_gnu_ld="$lt_cv_prog_gnu_ld" + +old_CC="$CC" +old_CFLAGS="$CFLAGS" + +# Set sane defaults for various variables +test -z "$CC" && CC=cc +test -z "$LTCC" && LTCC=$CC +test -z "$LTCFLAGS" && LTCFLAGS=$CFLAGS +test -z "$LD" && LD=ld +test -z "$ac_objext" && ac_objext=o + +_LT_CC_BASENAME([$compiler]) + +# Only perform the check for file, if the check method requires it +test -z "$MAGIC_CMD" && MAGIC_CMD=file +case $deplibs_check_method in +file_magic*) + if test "$file_magic_cmd" = '$MAGIC_CMD'; then + _LT_PATH_MAGIC + fi + ;; +esac + +# Use C for the default configuration in the libtool script +LT_SUPPORTED_TAG([CC]) +_LT_LANG_C_CONFIG +_LT_LANG_DEFAULT_CONFIG +_LT_CONFIG_COMMANDS +])# _LT_SETUP + + +# _LT_PREPARE_SED_QUOTE_VARS +# -------------------------- +# Define a few sed substitution that help us do robust quoting. +m4_defun([_LT_PREPARE_SED_QUOTE_VARS], +[# Backslashify metacharacters that are still active within +# double-quoted strings. +sed_quote_subst='s/\([["`$\\]]\)/\\\1/g' + +# Same as above, but do not quote variable references. +double_quote_subst='s/\([["`\\]]\)/\\\1/g' + +# Sed substitution to delay expansion of an escaped shell variable in a +# double_quote_subst'ed string. +delay_variable_subst='s/\\\\\\\\\\\$/\\\\\\$/g' + +# Sed substitution to delay expansion of an escaped single quote. +delay_single_quote_subst='s/'\''/'\'\\\\\\\'\''/g' + +# Sed substitution to avoid accidental globbing in evaled expressions +no_glob_subst='s/\*/\\\*/g' +]) + +# _LT_PROG_LTMAIN +# --------------- +# Note that this code is called both from `configure', and `config.status' +# now that we use AC_CONFIG_COMMANDS to generate libtool. Notably, +# `config.status' has no value for ac_aux_dir unless we are using Automake, +# so we pass a copy along to make sure it has a sensible value anyway. +m4_defun([_LT_PROG_LTMAIN], +[m4_ifdef([AC_REQUIRE_AUX_FILE], [AC_REQUIRE_AUX_FILE([ltmain.sh])])dnl +_LT_CONFIG_LIBTOOL_INIT([ac_aux_dir='$ac_aux_dir']) +ltmain="$ac_aux_dir/ltmain.sh" +])# _LT_PROG_LTMAIN + + + +# So that we can recreate a full libtool script including additional +# tags, we accumulate the chunks of code to send to AC_CONFIG_COMMANDS +# in macros and then make a single call at the end using the `libtool' +# label. + + +# _LT_CONFIG_LIBTOOL_INIT([INIT-COMMANDS]) +# ---------------------------------------- +# Register INIT-COMMANDS to be passed to AC_CONFIG_COMMANDS later. +m4_define([_LT_CONFIG_LIBTOOL_INIT], +[m4_ifval([$1], + [m4_append([_LT_OUTPUT_LIBTOOL_INIT], + [$1 +])])]) + +# Initialize. +m4_define([_LT_OUTPUT_LIBTOOL_INIT]) + + +# _LT_CONFIG_LIBTOOL([COMMANDS]) +# ------------------------------ +# Register COMMANDS to be passed to AC_CONFIG_COMMANDS later. +m4_define([_LT_CONFIG_LIBTOOL], +[m4_ifval([$1], + [m4_append([_LT_OUTPUT_LIBTOOL_COMMANDS], + [$1 +])])]) + +# Initialize. +m4_define([_LT_OUTPUT_LIBTOOL_COMMANDS]) + + +# _LT_CONFIG_SAVE_COMMANDS([COMMANDS], [INIT_COMMANDS]) +# ----------------------------------------------------- +m4_defun([_LT_CONFIG_SAVE_COMMANDS], +[_LT_CONFIG_LIBTOOL([$1]) +_LT_CONFIG_LIBTOOL_INIT([$2]) +]) + + +# _LT_FORMAT_COMMENT([COMMENT]) +# ----------------------------- +# Add leading comment marks to the start of each line, and a trailing +# full-stop to the whole comment if one is not present already. +m4_define([_LT_FORMAT_COMMENT], +[m4_ifval([$1], [ +m4_bpatsubst([m4_bpatsubst([$1], [^ *], [# ])], + [['`$\]], [\\\&])]m4_bmatch([$1], [[!?.]$], [], [.]) +)]) + + + + + +# _LT_DECL([CONFIGNAME], VARNAME, VALUE, [DESCRIPTION], [IS-TAGGED?]) +# ------------------------------------------------------------------- +# CONFIGNAME is the name given to the value in the libtool script. +# VARNAME is the (base) name used in the configure script. +# VALUE may be 0, 1 or 2 for a computed quote escaped value based on +# VARNAME. Any other value will be used directly. +m4_define([_LT_DECL], +[lt_if_append_uniq([lt_decl_varnames], [$2], [, ], + [lt_dict_add_subkey([lt_decl_dict], [$2], [libtool_name], + [m4_ifval([$1], [$1], [$2])]) + lt_dict_add_subkey([lt_decl_dict], [$2], [value], [$3]) + m4_ifval([$4], + [lt_dict_add_subkey([lt_decl_dict], [$2], [description], [$4])]) + lt_dict_add_subkey([lt_decl_dict], [$2], + [tagged?], [m4_ifval([$5], [yes], [no])])]) +]) + + +# _LT_TAGDECL([CONFIGNAME], VARNAME, VALUE, [DESCRIPTION]) +# -------------------------------------------------------- +m4_define([_LT_TAGDECL], [_LT_DECL([$1], [$2], [$3], [$4], [yes])]) + + +# lt_decl_tag_varnames([SEPARATOR], [VARNAME1...]) +# ------------------------------------------------ +m4_define([lt_decl_tag_varnames], +[_lt_decl_filter([tagged?], [yes], $@)]) + + +# _lt_decl_filter(SUBKEY, VALUE, [SEPARATOR], [VARNAME1..]) +# --------------------------------------------------------- +m4_define([_lt_decl_filter], +[m4_case([$#], + [0], [m4_fatal([$0: too few arguments: $#])], + [1], [m4_fatal([$0: too few arguments: $#: $1])], + [2], [lt_dict_filter([lt_decl_dict], [$1], [$2], [], lt_decl_varnames)], + [3], [lt_dict_filter([lt_decl_dict], [$1], [$2], [$3], lt_decl_varnames)], + [lt_dict_filter([lt_decl_dict], $@)])[]dnl +]) + + +# lt_decl_quote_varnames([SEPARATOR], [VARNAME1...]) +# -------------------------------------------------- +m4_define([lt_decl_quote_varnames], +[_lt_decl_filter([value], [1], $@)]) + + +# lt_decl_dquote_varnames([SEPARATOR], [VARNAME1...]) +# --------------------------------------------------- +m4_define([lt_decl_dquote_varnames], +[_lt_decl_filter([value], [2], $@)]) + + +# lt_decl_varnames_tagged([SEPARATOR], [VARNAME1...]) +# --------------------------------------------------- +m4_define([lt_decl_varnames_tagged], +[m4_assert([$# <= 2])dnl +_$0(m4_quote(m4_default([$1], [[, ]])), + m4_ifval([$2], [[$2]], [m4_dquote(lt_decl_tag_varnames)]), + m4_split(m4_normalize(m4_quote(_LT_TAGS)), [ ]))]) +m4_define([_lt_decl_varnames_tagged], +[m4_ifval([$3], [lt_combine([$1], [$2], [_], $3)])]) + + +# lt_decl_all_varnames([SEPARATOR], [VARNAME1...]) +# ------------------------------------------------ +m4_define([lt_decl_all_varnames], +[_$0(m4_quote(m4_default([$1], [[, ]])), + m4_if([$2], [], + m4_quote(lt_decl_varnames), + m4_quote(m4_shift($@))))[]dnl +]) +m4_define([_lt_decl_all_varnames], +[lt_join($@, lt_decl_varnames_tagged([$1], + lt_decl_tag_varnames([[, ]], m4_shift($@))))dnl +]) + + +# _LT_CONFIG_STATUS_DECLARE([VARNAME]) +# ------------------------------------ +# Quote a variable value, and forward it to `config.status' so that its +# declaration there will have the same value as in `configure'. VARNAME +# must have a single quote delimited value for this to work. +m4_define([_LT_CONFIG_STATUS_DECLARE], +[$1='`$ECHO "$][$1" | $SED "$delay_single_quote_subst"`']) + + +# _LT_CONFIG_STATUS_DECLARATIONS +# ------------------------------ +# We delimit libtool config variables with single quotes, so when +# we write them to config.status, we have to be sure to quote all +# embedded single quotes properly. In configure, this macro expands +# each variable declared with _LT_DECL (and _LT_TAGDECL) into: +# +# ='`$ECHO "$" | $SED "$delay_single_quote_subst"`' +m4_defun([_LT_CONFIG_STATUS_DECLARATIONS], +[m4_foreach([_lt_var], m4_quote(lt_decl_all_varnames), + [m4_n([_LT_CONFIG_STATUS_DECLARE(_lt_var)])])]) + + +# _LT_LIBTOOL_TAGS +# ---------------- +# Output comment and list of tags supported by the script +m4_defun([_LT_LIBTOOL_TAGS], +[_LT_FORMAT_COMMENT([The names of the tagged configurations supported by this script])dnl +available_tags="_LT_TAGS"dnl +]) + + +# _LT_LIBTOOL_DECLARE(VARNAME, [TAG]) +# ----------------------------------- +# Extract the dictionary values for VARNAME (optionally with TAG) and +# expand to a commented shell variable setting: +# +# # Some comment about what VAR is for. +# visible_name=$lt_internal_name +m4_define([_LT_LIBTOOL_DECLARE], +[_LT_FORMAT_COMMENT(m4_quote(lt_dict_fetch([lt_decl_dict], [$1], + [description])))[]dnl +m4_pushdef([_libtool_name], + m4_quote(lt_dict_fetch([lt_decl_dict], [$1], [libtool_name])))[]dnl +m4_case(m4_quote(lt_dict_fetch([lt_decl_dict], [$1], [value])), + [0], [_libtool_name=[$]$1], + [1], [_libtool_name=$lt_[]$1], + [2], [_libtool_name=$lt_[]$1], + [_libtool_name=lt_dict_fetch([lt_decl_dict], [$1], [value])])[]dnl +m4_ifval([$2], [_$2])[]m4_popdef([_libtool_name])[]dnl +]) + + +# _LT_LIBTOOL_CONFIG_VARS +# ----------------------- +# Produce commented declarations of non-tagged libtool config variables +# suitable for insertion in the LIBTOOL CONFIG section of the `libtool' +# script. Tagged libtool config variables (even for the LIBTOOL CONFIG +# section) are produced by _LT_LIBTOOL_TAG_VARS. +m4_defun([_LT_LIBTOOL_CONFIG_VARS], +[m4_foreach([_lt_var], + m4_quote(_lt_decl_filter([tagged?], [no], [], lt_decl_varnames)), + [m4_n([_LT_LIBTOOL_DECLARE(_lt_var)])])]) + + +# _LT_LIBTOOL_TAG_VARS(TAG) +# ------------------------- +m4_define([_LT_LIBTOOL_TAG_VARS], +[m4_foreach([_lt_var], m4_quote(lt_decl_tag_varnames), + [m4_n([_LT_LIBTOOL_DECLARE(_lt_var, [$1])])])]) + + +# _LT_TAGVAR(VARNAME, [TAGNAME]) +# ------------------------------ +m4_define([_LT_TAGVAR], [m4_ifval([$2], [$1_$2], [$1])]) + + +# _LT_CONFIG_COMMANDS +# ------------------- +# Send accumulated output to $CONFIG_STATUS. Thanks to the lists of +# variables for single and double quote escaping we saved from calls +# to _LT_DECL, we can put quote escaped variables declarations +# into `config.status', and then the shell code to quote escape them in +# for loops in `config.status'. Finally, any additional code accumulated +# from calls to _LT_CONFIG_LIBTOOL_INIT is expanded. +m4_defun([_LT_CONFIG_COMMANDS], +[AC_PROVIDE_IFELSE([LT_OUTPUT], + dnl If the libtool generation code has been placed in $CONFIG_LT, + dnl instead of duplicating it all over again into config.status, + dnl then we will have config.status run $CONFIG_LT later, so it + dnl needs to know what name is stored there: + [AC_CONFIG_COMMANDS([libtool], + [$SHELL $CONFIG_LT || AS_EXIT(1)], [CONFIG_LT='$CONFIG_LT'])], + dnl If the libtool generation code is destined for config.status, + dnl expand the accumulated commands and init code now: + [AC_CONFIG_COMMANDS([libtool], + [_LT_OUTPUT_LIBTOOL_COMMANDS], [_LT_OUTPUT_LIBTOOL_COMMANDS_INIT])]) +])#_LT_CONFIG_COMMANDS + + +# Initialize. +m4_define([_LT_OUTPUT_LIBTOOL_COMMANDS_INIT], +[ + +# The HP-UX ksh and POSIX shell print the target directory to stdout +# if CDPATH is set. +(unset CDPATH) >/dev/null 2>&1 && unset CDPATH + +sed_quote_subst='$sed_quote_subst' +double_quote_subst='$double_quote_subst' +delay_variable_subst='$delay_variable_subst' +_LT_CONFIG_STATUS_DECLARATIONS +LTCC='$LTCC' +LTCFLAGS='$LTCFLAGS' +compiler='$compiler_DEFAULT' + +# A function that is used when there is no print builtin or printf. +func_fallback_echo () +{ + eval 'cat <<_LTECHO_EOF +\$[]1 +_LTECHO_EOF' +} + +# Quote evaled strings. +for var in lt_decl_all_varnames([[ \ +]], lt_decl_quote_varnames); do + case \`eval \\\\\$ECHO \\\\""\\\\\$\$var"\\\\"\` in + *[[\\\\\\\`\\"\\\$]]*) + eval "lt_\$var=\\\\\\"\\\`\\\$ECHO \\"\\\$\$var\\" | \\\$SED \\"\\\$sed_quote_subst\\"\\\`\\\\\\"" + ;; + *) + eval "lt_\$var=\\\\\\"\\\$\$var\\\\\\"" + ;; + esac +done + +# Double-quote double-evaled strings. +for var in lt_decl_all_varnames([[ \ +]], lt_decl_dquote_varnames); do + case \`eval \\\\\$ECHO \\\\""\\\\\$\$var"\\\\"\` in + *[[\\\\\\\`\\"\\\$]]*) + eval "lt_\$var=\\\\\\"\\\`\\\$ECHO \\"\\\$\$var\\" | \\\$SED -e \\"\\\$double_quote_subst\\" -e \\"\\\$sed_quote_subst\\" -e \\"\\\$delay_variable_subst\\"\\\`\\\\\\"" + ;; + *) + eval "lt_\$var=\\\\\\"\\\$\$var\\\\\\"" + ;; + esac +done + +_LT_OUTPUT_LIBTOOL_INIT +]) + +# _LT_GENERATED_FILE_INIT(FILE, [COMMENT]) +# ------------------------------------ +# Generate a child script FILE with all initialization necessary to +# reuse the environment learned by the parent script, and make the +# file executable. If COMMENT is supplied, it is inserted after the +# `#!' sequence but before initialization text begins. After this +# macro, additional text can be appended to FILE to form the body of +# the child script. The macro ends with non-zero status if the +# file could not be fully written (such as if the disk is full). +m4_ifdef([AS_INIT_GENERATED], +[m4_defun([_LT_GENERATED_FILE_INIT],[AS_INIT_GENERATED($@)])], +[m4_defun([_LT_GENERATED_FILE_INIT], +[m4_require([AS_PREPARE])]dnl +[m4_pushdef([AS_MESSAGE_LOG_FD])]dnl +[lt_write_fail=0 +cat >$1 <<_ASEOF || lt_write_fail=1 +#! $SHELL +# Generated by $as_me. +$2 +SHELL=\${CONFIG_SHELL-$SHELL} +export SHELL +_ASEOF +cat >>$1 <<\_ASEOF || lt_write_fail=1 +AS_SHELL_SANITIZE +_AS_PREPARE +exec AS_MESSAGE_FD>&1 +_ASEOF +test $lt_write_fail = 0 && chmod +x $1[]dnl +m4_popdef([AS_MESSAGE_LOG_FD])])])# _LT_GENERATED_FILE_INIT + +# LT_OUTPUT +# --------- +# This macro allows early generation of the libtool script (before +# AC_OUTPUT is called), incase it is used in configure for compilation +# tests. +AC_DEFUN([LT_OUTPUT], +[: ${CONFIG_LT=./config.lt} +AC_MSG_NOTICE([creating $CONFIG_LT]) +_LT_GENERATED_FILE_INIT(["$CONFIG_LT"], +[# Run this file to recreate a libtool stub with the current configuration.]) + +cat >>"$CONFIG_LT" <<\_LTEOF +lt_cl_silent=false +exec AS_MESSAGE_LOG_FD>>config.log +{ + echo + AS_BOX([Running $as_me.]) +} >&AS_MESSAGE_LOG_FD + +lt_cl_help="\ +\`$as_me' creates a local libtool stub from the current configuration, +for use in further configure time tests before the real libtool is +generated. + +Usage: $[0] [[OPTIONS]] + + -h, --help print this help, then exit + -V, --version print version number, then exit + -q, --quiet do not print progress messages + -d, --debug don't remove temporary files + +Report bugs to ." + +lt_cl_version="\ +m4_ifset([AC_PACKAGE_NAME], [AC_PACKAGE_NAME ])config.lt[]dnl +m4_ifset([AC_PACKAGE_VERSION], [ AC_PACKAGE_VERSION]) +configured by $[0], generated by m4_PACKAGE_STRING. + +Copyright (C) 2011 Free Software Foundation, Inc. +This config.lt script is free software; the Free Software Foundation +gives unlimited permision to copy, distribute and modify it." + +while test $[#] != 0 +do + case $[1] in + --version | --v* | -V ) + echo "$lt_cl_version"; exit 0 ;; + --help | --h* | -h ) + echo "$lt_cl_help"; exit 0 ;; + --debug | --d* | -d ) + debug=: ;; + --quiet | --q* | --silent | --s* | -q ) + lt_cl_silent=: ;; + + -*) AC_MSG_ERROR([unrecognized option: $[1] +Try \`$[0] --help' for more information.]) ;; + + *) AC_MSG_ERROR([unrecognized argument: $[1] +Try \`$[0] --help' for more information.]) ;; + esac + shift +done + +if $lt_cl_silent; then + exec AS_MESSAGE_FD>/dev/null +fi +_LTEOF + +cat >>"$CONFIG_LT" <<_LTEOF +_LT_OUTPUT_LIBTOOL_COMMANDS_INIT +_LTEOF + +cat >>"$CONFIG_LT" <<\_LTEOF +AC_MSG_NOTICE([creating $ofile]) +_LT_OUTPUT_LIBTOOL_COMMANDS +AS_EXIT(0) +_LTEOF +chmod +x "$CONFIG_LT" + +# configure is writing to config.log, but config.lt does its own redirection, +# appending to config.log, which fails on DOS, as config.log is still kept +# open by configure. Here we exec the FD to /dev/null, effectively closing +# config.log, so it can be properly (re)opened and appended to by config.lt. +lt_cl_success=: +test "$silent" = yes && + lt_config_lt_args="$lt_config_lt_args --quiet" +exec AS_MESSAGE_LOG_FD>/dev/null +$SHELL "$CONFIG_LT" $lt_config_lt_args || lt_cl_success=false +exec AS_MESSAGE_LOG_FD>>config.log +$lt_cl_success || AS_EXIT(1) +])# LT_OUTPUT + + +# _LT_CONFIG(TAG) +# --------------- +# If TAG is the built-in tag, create an initial libtool script with a +# default configuration from the untagged config vars. Otherwise add code +# to config.status for appending the configuration named by TAG from the +# matching tagged config vars. +m4_defun([_LT_CONFIG], +[m4_require([_LT_FILEUTILS_DEFAULTS])dnl +_LT_CONFIG_SAVE_COMMANDS([ + m4_define([_LT_TAG], m4_if([$1], [], [C], [$1]))dnl + m4_if(_LT_TAG, [C], [ + # See if we are running on zsh, and set the options which allow our + # commands through without removal of \ escapes. + if test -n "${ZSH_VERSION+set}" ; then + setopt NO_GLOB_SUBST + fi + + cfgfile="${ofile}T" + trap "$RM \"$cfgfile\"; exit 1" 1 2 15 + $RM "$cfgfile" + + cat <<_LT_EOF >> "$cfgfile" +#! $SHELL + +# `$ECHO "$ofile" | sed 's%^.*/%%'` - Provide generalized library-building support services. +# Generated automatically by $as_me ($PACKAGE$TIMESTAMP) $VERSION +# Libtool was configured on host `(hostname || uname -n) 2>/dev/null | sed 1q`: +# NOTE: Changes made to this file will be lost: look at ltmain.sh. +# +_LT_COPYING +_LT_LIBTOOL_TAGS + +# ### BEGIN LIBTOOL CONFIG +_LT_LIBTOOL_CONFIG_VARS +_LT_LIBTOOL_TAG_VARS +# ### END LIBTOOL CONFIG + +_LT_EOF + + case $host_os in + aix3*) + cat <<\_LT_EOF >> "$cfgfile" +# AIX sometimes has problems with the GCC collect2 program. For some +# reason, if we set the COLLECT_NAMES environment variable, the problems +# vanish in a puff of smoke. +if test "X${COLLECT_NAMES+set}" != Xset; then + COLLECT_NAMES= + export COLLECT_NAMES +fi +_LT_EOF + ;; + esac + + _LT_PROG_LTMAIN + + # We use sed instead of cat because bash on DJGPP gets confused if + # if finds mixed CR/LF and LF-only lines. Since sed operates in + # text mode, it properly converts lines to CR/LF. This bash problem + # is reportedly fixed, but why not run on old versions too? + sed '$q' "$ltmain" >> "$cfgfile" \ + || (rm -f "$cfgfile"; exit 1) + + _LT_PROG_REPLACE_SHELLFNS + + mv -f "$cfgfile" "$ofile" || + (rm -f "$ofile" && cp "$cfgfile" "$ofile" && rm -f "$cfgfile") + chmod +x "$ofile" +], +[cat <<_LT_EOF >> "$ofile" + +dnl Unfortunately we have to use $1 here, since _LT_TAG is not expanded +dnl in a comment (ie after a #). +# ### BEGIN LIBTOOL TAG CONFIG: $1 +_LT_LIBTOOL_TAG_VARS(_LT_TAG) +# ### END LIBTOOL TAG CONFIG: $1 +_LT_EOF +])dnl /m4_if +], +[m4_if([$1], [], [ + PACKAGE='$PACKAGE' + VERSION='$VERSION' + TIMESTAMP='$TIMESTAMP' + RM='$RM' + ofile='$ofile'], []) +])dnl /_LT_CONFIG_SAVE_COMMANDS +])# _LT_CONFIG + + +# LT_SUPPORTED_TAG(TAG) +# --------------------- +# Trace this macro to discover what tags are supported by the libtool +# --tag option, using: +# autoconf --trace 'LT_SUPPORTED_TAG:$1' +AC_DEFUN([LT_SUPPORTED_TAG], []) + + +# C support is built-in for now +m4_define([_LT_LANG_C_enabled], []) +m4_define([_LT_TAGS], []) + + +# LT_LANG(LANG) +# ------------- +# Enable libtool support for the given language if not already enabled. +AC_DEFUN([LT_LANG], +[AC_BEFORE([$0], [LT_OUTPUT])dnl +m4_case([$1], + [C], [_LT_LANG(C)], + [C++], [_LT_LANG(CXX)], + [Go], [_LT_LANG(GO)], + [Java], [_LT_LANG(GCJ)], + [Fortran 77], [_LT_LANG(F77)], + [Fortran], [_LT_LANG(FC)], + [Windows Resource], [_LT_LANG(RC)], + [m4_ifdef([_LT_LANG_]$1[_CONFIG], + [_LT_LANG($1)], + [m4_fatal([$0: unsupported language: "$1"])])])dnl +])# LT_LANG + + +# _LT_LANG(LANGNAME) +# ------------------ +m4_defun([_LT_LANG], +[m4_ifdef([_LT_LANG_]$1[_enabled], [], + [LT_SUPPORTED_TAG([$1])dnl + m4_append([_LT_TAGS], [$1 ])dnl + m4_define([_LT_LANG_]$1[_enabled], [])dnl + _LT_LANG_$1_CONFIG($1)])dnl +])# _LT_LANG + + +m4_ifndef([AC_PROG_GO], [ +# NOTE: This macro has been submitted for inclusion into # +# GNU Autoconf as AC_PROG_GO. When it is available in # +# a released version of Autoconf we should remove this # +# macro and use it instead. # +m4_defun([AC_PROG_GO], +[AC_LANG_PUSH(Go)dnl +AC_ARG_VAR([GOC], [Go compiler command])dnl +AC_ARG_VAR([GOFLAGS], [Go compiler flags])dnl +_AC_ARG_VAR_LDFLAGS()dnl +AC_CHECK_TOOL(GOC, gccgo) +if test -z "$GOC"; then + if test -n "$ac_tool_prefix"; then + AC_CHECK_PROG(GOC, [${ac_tool_prefix}gccgo], [${ac_tool_prefix}gccgo]) + fi +fi +if test -z "$GOC"; then + AC_CHECK_PROG(GOC, gccgo, gccgo, false) +fi +])#m4_defun +])#m4_ifndef + + +# _LT_LANG_DEFAULT_CONFIG +# ----------------------- +m4_defun([_LT_LANG_DEFAULT_CONFIG], +[AC_PROVIDE_IFELSE([AC_PROG_CXX], + [LT_LANG(CXX)], + [m4_define([AC_PROG_CXX], defn([AC_PROG_CXX])[LT_LANG(CXX)])]) + +AC_PROVIDE_IFELSE([AC_PROG_F77], + [LT_LANG(F77)], + [m4_define([AC_PROG_F77], defn([AC_PROG_F77])[LT_LANG(F77)])]) + +AC_PROVIDE_IFELSE([AC_PROG_FC], + [LT_LANG(FC)], + [m4_define([AC_PROG_FC], defn([AC_PROG_FC])[LT_LANG(FC)])]) + +dnl The call to [A][M_PROG_GCJ] is quoted like that to stop aclocal +dnl pulling things in needlessly. +AC_PROVIDE_IFELSE([AC_PROG_GCJ], + [LT_LANG(GCJ)], + [AC_PROVIDE_IFELSE([A][M_PROG_GCJ], + [LT_LANG(GCJ)], + [AC_PROVIDE_IFELSE([LT_PROG_GCJ], + [LT_LANG(GCJ)], + [m4_ifdef([AC_PROG_GCJ], + [m4_define([AC_PROG_GCJ], defn([AC_PROG_GCJ])[LT_LANG(GCJ)])]) + m4_ifdef([A][M_PROG_GCJ], + [m4_define([A][M_PROG_GCJ], defn([A][M_PROG_GCJ])[LT_LANG(GCJ)])]) + m4_ifdef([LT_PROG_GCJ], + [m4_define([LT_PROG_GCJ], defn([LT_PROG_GCJ])[LT_LANG(GCJ)])])])])]) + +AC_PROVIDE_IFELSE([AC_PROG_GO], + [LT_LANG(GO)], + [m4_define([AC_PROG_GO], defn([AC_PROG_GO])[LT_LANG(GO)])]) + +AC_PROVIDE_IFELSE([LT_PROG_RC], + [LT_LANG(RC)], + [m4_define([LT_PROG_RC], defn([LT_PROG_RC])[LT_LANG(RC)])]) +])# _LT_LANG_DEFAULT_CONFIG + +# Obsolete macros: +AU_DEFUN([AC_LIBTOOL_CXX], [LT_LANG(C++)]) +AU_DEFUN([AC_LIBTOOL_F77], [LT_LANG(Fortran 77)]) +AU_DEFUN([AC_LIBTOOL_FC], [LT_LANG(Fortran)]) +AU_DEFUN([AC_LIBTOOL_GCJ], [LT_LANG(Java)]) +AU_DEFUN([AC_LIBTOOL_RC], [LT_LANG(Windows Resource)]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_CXX], []) +dnl AC_DEFUN([AC_LIBTOOL_F77], []) +dnl AC_DEFUN([AC_LIBTOOL_FC], []) +dnl AC_DEFUN([AC_LIBTOOL_GCJ], []) +dnl AC_DEFUN([AC_LIBTOOL_RC], []) + + +# _LT_TAG_COMPILER +# ---------------- +m4_defun([_LT_TAG_COMPILER], +[AC_REQUIRE([AC_PROG_CC])dnl + +_LT_DECL([LTCC], [CC], [1], [A C compiler])dnl +_LT_DECL([LTCFLAGS], [CFLAGS], [1], [LTCC compiler flags])dnl +_LT_TAGDECL([CC], [compiler], [1], [A language specific compiler])dnl +_LT_TAGDECL([with_gcc], [GCC], [0], [Is the compiler the GNU compiler?])dnl + +# If no C compiler was specified, use CC. +LTCC=${LTCC-"$CC"} + +# If no C compiler flags were specified, use CFLAGS. +LTCFLAGS=${LTCFLAGS-"$CFLAGS"} + +# Allow CC to be a program name with arguments. +compiler=$CC +])# _LT_TAG_COMPILER + + +# _LT_COMPILER_BOILERPLATE +# ------------------------ +# Check for compiler boilerplate output or warnings with +# the simple compiler test code. +m4_defun([_LT_COMPILER_BOILERPLATE], +[m4_require([_LT_DECL_SED])dnl +ac_outfile=conftest.$ac_objext +echo "$lt_simple_compile_test_code" >conftest.$ac_ext +eval "$ac_compile" 2>&1 >/dev/null | $SED '/^$/d; /^ *+/d' >conftest.err +_lt_compiler_boilerplate=`cat conftest.err` +$RM conftest* +])# _LT_COMPILER_BOILERPLATE + + +# _LT_LINKER_BOILERPLATE +# ---------------------- +# Check for linker boilerplate output or warnings with +# the simple link test code. +m4_defun([_LT_LINKER_BOILERPLATE], +[m4_require([_LT_DECL_SED])dnl +ac_outfile=conftest.$ac_objext +echo "$lt_simple_link_test_code" >conftest.$ac_ext +eval "$ac_link" 2>&1 >/dev/null | $SED '/^$/d; /^ *+/d' >conftest.err +_lt_linker_boilerplate=`cat conftest.err` +$RM -r conftest* +])# _LT_LINKER_BOILERPLATE + +# _LT_REQUIRED_DARWIN_CHECKS +# ------------------------- +m4_defun_once([_LT_REQUIRED_DARWIN_CHECKS],[ + case $host_os in + rhapsody* | darwin*) + AC_CHECK_TOOL([DSYMUTIL], [dsymutil], [:]) + AC_CHECK_TOOL([NMEDIT], [nmedit], [:]) + AC_CHECK_TOOL([LIPO], [lipo], [:]) + AC_CHECK_TOOL([OTOOL], [otool], [:]) + AC_CHECK_TOOL([OTOOL64], [otool64], [:]) + _LT_DECL([], [DSYMUTIL], [1], + [Tool to manipulate archived DWARF debug symbol files on Mac OS X]) + _LT_DECL([], [NMEDIT], [1], + [Tool to change global to local symbols on Mac OS X]) + _LT_DECL([], [LIPO], [1], + [Tool to manipulate fat objects and archives on Mac OS X]) + _LT_DECL([], [OTOOL], [1], + [ldd/readelf like tool for Mach-O binaries on Mac OS X]) + _LT_DECL([], [OTOOL64], [1], + [ldd/readelf like tool for 64 bit Mach-O binaries on Mac OS X 10.4]) + + AC_CACHE_CHECK([for -single_module linker flag],[lt_cv_apple_cc_single_mod], + [lt_cv_apple_cc_single_mod=no + if test -z "${LT_MULTI_MODULE}"; then + # By default we will add the -single_module flag. You can override + # by either setting the environment variable LT_MULTI_MODULE + # non-empty at configure time, or by adding -multi_module to the + # link flags. + rm -rf libconftest.dylib* + echo "int foo(void){return 1;}" > conftest.c + echo "$LTCC $LTCFLAGS $LDFLAGS -o libconftest.dylib \ +-dynamiclib -Wl,-single_module conftest.c" >&AS_MESSAGE_LOG_FD + $LTCC $LTCFLAGS $LDFLAGS -o libconftest.dylib \ + -dynamiclib -Wl,-single_module conftest.c 2>conftest.err + _lt_result=$? + # If there is a non-empty error log, and "single_module" + # appears in it, assume the flag caused a linker warning + if test -s conftest.err && $GREP single_module conftest.err; then + cat conftest.err >&AS_MESSAGE_LOG_FD + # Otherwise, if the output was created with a 0 exit code from + # the compiler, it worked. + elif test -f libconftest.dylib && test $_lt_result -eq 0; then + lt_cv_apple_cc_single_mod=yes + else + cat conftest.err >&AS_MESSAGE_LOG_FD + fi + rm -rf libconftest.dylib* + rm -f conftest.* + fi]) + + AC_CACHE_CHECK([for -exported_symbols_list linker flag], + [lt_cv_ld_exported_symbols_list], + [lt_cv_ld_exported_symbols_list=no + save_LDFLAGS=$LDFLAGS + echo "_main" > conftest.sym + LDFLAGS="$LDFLAGS -Wl,-exported_symbols_list,conftest.sym" + AC_LINK_IFELSE([AC_LANG_PROGRAM([],[])], + [lt_cv_ld_exported_symbols_list=yes], + [lt_cv_ld_exported_symbols_list=no]) + LDFLAGS="$save_LDFLAGS" + ]) + + AC_CACHE_CHECK([for -force_load linker flag],[lt_cv_ld_force_load], + [lt_cv_ld_force_load=no + cat > conftest.c << _LT_EOF +int forced_loaded() { return 2;} +_LT_EOF + echo "$LTCC $LTCFLAGS -c -o conftest.o conftest.c" >&AS_MESSAGE_LOG_FD + $LTCC $LTCFLAGS -c -o conftest.o conftest.c 2>&AS_MESSAGE_LOG_FD + echo "$AR cru libconftest.a conftest.o" >&AS_MESSAGE_LOG_FD + $AR cru libconftest.a conftest.o 2>&AS_MESSAGE_LOG_FD + echo "$RANLIB libconftest.a" >&AS_MESSAGE_LOG_FD + $RANLIB libconftest.a 2>&AS_MESSAGE_LOG_FD + cat > conftest.c << _LT_EOF +int main() { return 0;} +_LT_EOF + echo "$LTCC $LTCFLAGS $LDFLAGS -o conftest conftest.c -Wl,-force_load,./libconftest.a" >&AS_MESSAGE_LOG_FD + $LTCC $LTCFLAGS $LDFLAGS -o conftest conftest.c -Wl,-force_load,./libconftest.a 2>conftest.err + _lt_result=$? + if test -s conftest.err && $GREP force_load conftest.err; then + cat conftest.err >&AS_MESSAGE_LOG_FD + elif test -f conftest && test $_lt_result -eq 0 && $GREP forced_load conftest >/dev/null 2>&1 ; then + lt_cv_ld_force_load=yes + else + cat conftest.err >&AS_MESSAGE_LOG_FD + fi + rm -f conftest.err libconftest.a conftest conftest.c + rm -rf conftest.dSYM + ]) + case $host_os in + rhapsody* | darwin1.[[012]]) + _lt_dar_allow_undefined='${wl}-undefined ${wl}suppress' ;; + darwin1.*) + _lt_dar_allow_undefined='${wl}-flat_namespace ${wl}-undefined ${wl}suppress' ;; + darwin*) # darwin 5.x on + # if running on 10.5 or later, the deployment target defaults + # to the OS version, if on x86, and 10.4, the deployment + # target defaults to 10.4. Don't you love it? + case ${MACOSX_DEPLOYMENT_TARGET-10.0},$host in + 10.0,*86*-darwin8*|10.0,*-darwin[[91]]*) + _lt_dar_allow_undefined='${wl}-undefined ${wl}dynamic_lookup' ;; + 10.[[012]]*) + _lt_dar_allow_undefined='${wl}-flat_namespace ${wl}-undefined ${wl}suppress' ;; + 10.*) + _lt_dar_allow_undefined='${wl}-undefined ${wl}dynamic_lookup' ;; + esac + ;; + esac + if test "$lt_cv_apple_cc_single_mod" = "yes"; then + _lt_dar_single_mod='$single_module' + fi + if test "$lt_cv_ld_exported_symbols_list" = "yes"; then + _lt_dar_export_syms=' ${wl}-exported_symbols_list,$output_objdir/${libname}-symbols.expsym' + else + _lt_dar_export_syms='~$NMEDIT -s $output_objdir/${libname}-symbols.expsym ${lib}' + fi + if test "$DSYMUTIL" != ":" && test "$lt_cv_ld_force_load" = "no"; then + _lt_dsymutil='~$DSYMUTIL $lib || :' + else + _lt_dsymutil= + fi + ;; + esac +]) + + +# _LT_DARWIN_LINKER_FEATURES([TAG]) +# --------------------------------- +# Checks for linker and compiler features on darwin +m4_defun([_LT_DARWIN_LINKER_FEATURES], +[ + m4_require([_LT_REQUIRED_DARWIN_CHECKS]) + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + _LT_TAGVAR(hardcode_direct, $1)=no + _LT_TAGVAR(hardcode_automatic, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=unsupported + if test "$lt_cv_ld_force_load" = "yes"; then + _LT_TAGVAR(whole_archive_flag_spec, $1)='`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience ${wl}-force_load,$conv\"; done; func_echo_all \"$new_convenience\"`' + m4_case([$1], [F77], [_LT_TAGVAR(compiler_needs_object, $1)=yes], + [FC], [_LT_TAGVAR(compiler_needs_object, $1)=yes]) + else + _LT_TAGVAR(whole_archive_flag_spec, $1)='' + fi + _LT_TAGVAR(link_all_deplibs, $1)=yes + _LT_TAGVAR(allow_undefined_flag, $1)="$_lt_dar_allow_undefined" + case $cc_basename in + ifort*) _lt_dar_can_shared=yes ;; + *) _lt_dar_can_shared=$GCC ;; + esac + if test "$_lt_dar_can_shared" = "yes"; then + output_verbose_link_cmd=func_echo_all + _LT_TAGVAR(archive_cmds, $1)="\$CC -dynamiclib \$allow_undefined_flag -o \$lib \$libobjs \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring $_lt_dar_single_mod${_lt_dsymutil}" + _LT_TAGVAR(module_cmds, $1)="\$CC \$allow_undefined_flag -o \$lib -bundle \$libobjs \$deplibs \$compiler_flags${_lt_dsymutil}" + _LT_TAGVAR(archive_expsym_cmds, $1)="sed 's,^,_,' < \$export_symbols > \$output_objdir/\${libname}-symbols.expsym~\$CC -dynamiclib \$allow_undefined_flag -o \$lib \$libobjs \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring ${_lt_dar_single_mod}${_lt_dar_export_syms}${_lt_dsymutil}" + _LT_TAGVAR(module_expsym_cmds, $1)="sed -e 's,^,_,' < \$export_symbols > \$output_objdir/\${libname}-symbols.expsym~\$CC \$allow_undefined_flag -o \$lib -bundle \$libobjs \$deplibs \$compiler_flags${_lt_dar_export_syms}${_lt_dsymutil}" + m4_if([$1], [CXX], +[ if test "$lt_cv_apple_cc_single_mod" != "yes"; then + _LT_TAGVAR(archive_cmds, $1)="\$CC -r -keep_private_externs -nostdlib -o \${lib}-master.o \$libobjs~\$CC -dynamiclib \$allow_undefined_flag -o \$lib \${lib}-master.o \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring${_lt_dsymutil}" + _LT_TAGVAR(archive_expsym_cmds, $1)="sed 's,^,_,' < \$export_symbols > \$output_objdir/\${libname}-symbols.expsym~\$CC -r -keep_private_externs -nostdlib -o \${lib}-master.o \$libobjs~\$CC -dynamiclib \$allow_undefined_flag -o \$lib \${lib}-master.o \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring${_lt_dar_export_syms}${_lt_dsymutil}" + fi +],[]) + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi +]) + +# _LT_SYS_MODULE_PATH_AIX([TAGNAME]) +# ---------------------------------- +# Links a minimal program and checks the executable +# for the system default hardcoded library path. In most cases, +# this is /usr/lib:/lib, but when the MPI compilers are used +# the location of the communication and MPI libs are included too. +# If we don't find anything, use the default library path according +# to the aix ld manual. +# Store the results from the different compilers for each TAGNAME. +# Allow to override them for all tags through lt_cv_aix_libpath. +m4_defun([_LT_SYS_MODULE_PATH_AIX], +[m4_require([_LT_DECL_SED])dnl +if test "${lt_cv_aix_libpath+set}" = set; then + aix_libpath=$lt_cv_aix_libpath +else + AC_CACHE_VAL([_LT_TAGVAR([lt_cv_aix_libpath_], [$1])], + [AC_LINK_IFELSE([AC_LANG_PROGRAM],[ + lt_aix_libpath_sed='[ + /Import File Strings/,/^$/ { + /^0/ { + s/^0 *\([^ ]*\) *$/\1/ + p + } + }]' + _LT_TAGVAR([lt_cv_aix_libpath_], [$1])=`dump -H conftest$ac_exeext 2>/dev/null | $SED -n -e "$lt_aix_libpath_sed"` + # Check for a 64-bit object if we didn't find anything. + if test -z "$_LT_TAGVAR([lt_cv_aix_libpath_], [$1])"; then + _LT_TAGVAR([lt_cv_aix_libpath_], [$1])=`dump -HX64 conftest$ac_exeext 2>/dev/null | $SED -n -e "$lt_aix_libpath_sed"` + fi],[]) + if test -z "$_LT_TAGVAR([lt_cv_aix_libpath_], [$1])"; then + _LT_TAGVAR([lt_cv_aix_libpath_], [$1])="/usr/lib:/lib" + fi + ]) + aix_libpath=$_LT_TAGVAR([lt_cv_aix_libpath_], [$1]) +fi +])# _LT_SYS_MODULE_PATH_AIX + + +# _LT_SHELL_INIT(ARG) +# ------------------- +m4_define([_LT_SHELL_INIT], +[m4_divert_text([M4SH-INIT], [$1 +])])# _LT_SHELL_INIT + + + +# _LT_PROG_ECHO_BACKSLASH +# ----------------------- +# Find how we can fake an echo command that does not interpret backslash. +# In particular, with Autoconf 2.60 or later we add some code to the start +# of the generated configure script which will find a shell with a builtin +# printf (which we can use as an echo command). +m4_defun([_LT_PROG_ECHO_BACKSLASH], +[ECHO='\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\' +ECHO=$ECHO$ECHO$ECHO$ECHO$ECHO +ECHO=$ECHO$ECHO$ECHO$ECHO$ECHO$ECHO + +AC_MSG_CHECKING([how to print strings]) +# Test print first, because it will be a builtin if present. +if test "X`( print -r -- -n ) 2>/dev/null`" = X-n && \ + test "X`print -r -- $ECHO 2>/dev/null`" = "X$ECHO"; then + ECHO='print -r --' +elif test "X`printf %s $ECHO 2>/dev/null`" = "X$ECHO"; then + ECHO='printf %s\n' +else + # Use this function as a fallback that always works. + func_fallback_echo () + { + eval 'cat <<_LTECHO_EOF +$[]1 +_LTECHO_EOF' + } + ECHO='func_fallback_echo' +fi + +# func_echo_all arg... +# Invoke $ECHO with all args, space-separated. +func_echo_all () +{ + $ECHO "$*" +} + +case "$ECHO" in + printf*) AC_MSG_RESULT([printf]) ;; + print*) AC_MSG_RESULT([print -r]) ;; + *) AC_MSG_RESULT([cat]) ;; +esac + +m4_ifdef([_AS_DETECT_SUGGESTED], +[_AS_DETECT_SUGGESTED([ + test -n "${ZSH_VERSION+set}${BASH_VERSION+set}" || ( + ECHO='\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\' + ECHO=$ECHO$ECHO$ECHO$ECHO$ECHO + ECHO=$ECHO$ECHO$ECHO$ECHO$ECHO$ECHO + PATH=/empty FPATH=/empty; export PATH FPATH + test "X`printf %s $ECHO`" = "X$ECHO" \ + || test "X`print -r -- $ECHO`" = "X$ECHO" )])]) + +_LT_DECL([], [SHELL], [1], [Shell to use when invoking shell scripts]) +_LT_DECL([], [ECHO], [1], [An echo program that protects backslashes]) +])# _LT_PROG_ECHO_BACKSLASH + + +# _LT_WITH_SYSROOT +# ---------------- +AC_DEFUN([_LT_WITH_SYSROOT], +[AC_MSG_CHECKING([for sysroot]) +AC_ARG_WITH([sysroot], +[ --with-sysroot[=DIR] Search for dependent libraries within DIR + (or the compiler's sysroot if not specified).], +[], [with_sysroot=no]) + +dnl lt_sysroot will always be passed unquoted. We quote it here +dnl in case the user passed a directory name. +lt_sysroot= +case ${with_sysroot} in #( + yes) + if test "$GCC" = yes; then + lt_sysroot=`$CC --print-sysroot 2>/dev/null` + fi + ;; #( + /*) + lt_sysroot=`echo "$with_sysroot" | sed -e "$sed_quote_subst"` + ;; #( + no|'') + ;; #( + *) + AC_MSG_RESULT([${with_sysroot}]) + AC_MSG_ERROR([The sysroot must be an absolute path.]) + ;; +esac + + AC_MSG_RESULT([${lt_sysroot:-no}]) +_LT_DECL([], [lt_sysroot], [0], [The root where to search for ]dnl +[dependent libraries, and in which our libraries should be installed.])]) + +# _LT_ENABLE_LOCK +# --------------- +m4_defun([_LT_ENABLE_LOCK], +[AC_ARG_ENABLE([libtool-lock], + [AS_HELP_STRING([--disable-libtool-lock], + [avoid locking (might break parallel builds)])]) +test "x$enable_libtool_lock" != xno && enable_libtool_lock=yes + +# Some flags need to be propagated to the compiler or linker for good +# libtool support. +case $host in +ia64-*-hpux*) + # Find out which ABI we are using. + echo 'int i;' > conftest.$ac_ext + if AC_TRY_EVAL(ac_compile); then + case `/usr/bin/file conftest.$ac_objext` in + *ELF-32*) + HPUX_IA64_MODE="32" + ;; + *ELF-64*) + HPUX_IA64_MODE="64" + ;; + esac + fi + rm -rf conftest* + ;; +*-*-irix6*) + # Find out which ABI we are using. + echo '[#]line '$LINENO' "configure"' > conftest.$ac_ext + if AC_TRY_EVAL(ac_compile); then + if test "$lt_cv_prog_gnu_ld" = yes; then + case `/usr/bin/file conftest.$ac_objext` in + *32-bit*) + LD="${LD-ld} -melf32bsmip" + ;; + *N32*) + LD="${LD-ld} -melf32bmipn32" + ;; + *64-bit*) + LD="${LD-ld} -melf64bmip" + ;; + esac + else + case `/usr/bin/file conftest.$ac_objext` in + *32-bit*) + LD="${LD-ld} -32" + ;; + *N32*) + LD="${LD-ld} -n32" + ;; + *64-bit*) + LD="${LD-ld} -64" + ;; + esac + fi + fi + rm -rf conftest* + ;; + +x86_64-*kfreebsd*-gnu|x86_64-*linux*|ppc*-*linux*|powerpc*-*linux*| \ +s390*-*linux*|s390*-*tpf*|sparc*-*linux*) + # Find out which ABI we are using. + echo 'int i;' > conftest.$ac_ext + if AC_TRY_EVAL(ac_compile); then + case `/usr/bin/file conftest.o` in + *32-bit*) + case $host in + x86_64-*kfreebsd*-gnu) + LD="${LD-ld} -m elf_i386_fbsd" + ;; + x86_64-*linux*) + LD="${LD-ld} -m elf_i386" + ;; + ppc64-*linux*|powerpc64-*linux*) + LD="${LD-ld} -m elf32ppclinux" + ;; + s390x-*linux*) + LD="${LD-ld} -m elf_s390" + ;; + sparc64-*linux*) + LD="${LD-ld} -m elf32_sparc" + ;; + esac + ;; + *64-bit*) + case $host in + x86_64-*kfreebsd*-gnu) + LD="${LD-ld} -m elf_x86_64_fbsd" + ;; + x86_64-*linux*) + LD="${LD-ld} -m elf_x86_64" + ;; + ppc*-*linux*|powerpc*-*linux*) + LD="${LD-ld} -m elf64ppc" + ;; + s390*-*linux*|s390*-*tpf*) + LD="${LD-ld} -m elf64_s390" + ;; + sparc*-*linux*) + LD="${LD-ld} -m elf64_sparc" + ;; + esac + ;; + esac + fi + rm -rf conftest* + ;; + +*-*-sco3.2v5*) + # On SCO OpenServer 5, we need -belf to get full-featured binaries. + SAVE_CFLAGS="$CFLAGS" + CFLAGS="$CFLAGS -belf" + AC_CACHE_CHECK([whether the C compiler needs -belf], lt_cv_cc_needs_belf, + [AC_LANG_PUSH(C) + AC_LINK_IFELSE([AC_LANG_PROGRAM([[]],[[]])],[lt_cv_cc_needs_belf=yes],[lt_cv_cc_needs_belf=no]) + AC_LANG_POP]) + if test x"$lt_cv_cc_needs_belf" != x"yes"; then + # this is probably gcc 2.8.0, egcs 1.0 or newer; no need for -belf + CFLAGS="$SAVE_CFLAGS" + fi + ;; +*-*solaris*) + # Find out which ABI we are using. + echo 'int i;' > conftest.$ac_ext + if AC_TRY_EVAL(ac_compile); then + case `/usr/bin/file conftest.o` in + *64-bit*) + case $lt_cv_prog_gnu_ld in + yes*) + case $host in + i?86-*-solaris*) + LD="${LD-ld} -m elf_x86_64" + ;; + sparc*-*-solaris*) + LD="${LD-ld} -m elf64_sparc" + ;; + esac + # GNU ld 2.21 introduced _sol2 emulations. Use them if available. + if ${LD-ld} -V | grep _sol2 >/dev/null 2>&1; then + LD="${LD-ld}_sol2" + fi + ;; + *) + if ${LD-ld} -64 -r -o conftest2.o conftest.o >/dev/null 2>&1; then + LD="${LD-ld} -64" + fi + ;; + esac + ;; + esac + fi + rm -rf conftest* + ;; +esac + +need_locks="$enable_libtool_lock" +])# _LT_ENABLE_LOCK + + +# _LT_PROG_AR +# ----------- +m4_defun([_LT_PROG_AR], +[AC_CHECK_TOOLS(AR, [ar], false) +: ${AR=ar} +: ${AR_FLAGS=cru} +_LT_DECL([], [AR], [1], [The archiver]) +_LT_DECL([], [AR_FLAGS], [1], [Flags to create an archive]) + +AC_CACHE_CHECK([for archiver @FILE support], [lt_cv_ar_at_file], + [lt_cv_ar_at_file=no + AC_COMPILE_IFELSE([AC_LANG_PROGRAM], + [echo conftest.$ac_objext > conftest.lst + lt_ar_try='$AR $AR_FLAGS libconftest.a @conftest.lst >&AS_MESSAGE_LOG_FD' + AC_TRY_EVAL([lt_ar_try]) + if test "$ac_status" -eq 0; then + # Ensure the archiver fails upon bogus file names. + rm -f conftest.$ac_objext libconftest.a + AC_TRY_EVAL([lt_ar_try]) + if test "$ac_status" -ne 0; then + lt_cv_ar_at_file=@ + fi + fi + rm -f conftest.* libconftest.a + ]) + ]) + +if test "x$lt_cv_ar_at_file" = xno; then + archiver_list_spec= +else + archiver_list_spec=$lt_cv_ar_at_file +fi +_LT_DECL([], [archiver_list_spec], [1], + [How to feed a file listing to the archiver]) +])# _LT_PROG_AR + + +# _LT_CMD_OLD_ARCHIVE +# ------------------- +m4_defun([_LT_CMD_OLD_ARCHIVE], +[_LT_PROG_AR + +AC_CHECK_TOOL(STRIP, strip, :) +test -z "$STRIP" && STRIP=: +_LT_DECL([], [STRIP], [1], [A symbol stripping program]) + +AC_CHECK_TOOL(RANLIB, ranlib, :) +test -z "$RANLIB" && RANLIB=: +_LT_DECL([], [RANLIB], [1], + [Commands used to install an old-style archive]) + +# Determine commands to create old-style static archives. +old_archive_cmds='$AR $AR_FLAGS $oldlib$oldobjs' +old_postinstall_cmds='chmod 644 $oldlib' +old_postuninstall_cmds= + +if test -n "$RANLIB"; then + case $host_os in + openbsd*) + old_postinstall_cmds="$old_postinstall_cmds~\$RANLIB -t \$tool_oldlib" + ;; + *) + old_postinstall_cmds="$old_postinstall_cmds~\$RANLIB \$tool_oldlib" + ;; + esac + old_archive_cmds="$old_archive_cmds~\$RANLIB \$tool_oldlib" +fi + +case $host_os in + darwin*) + lock_old_archive_extraction=yes ;; + *) + lock_old_archive_extraction=no ;; +esac +_LT_DECL([], [old_postinstall_cmds], [2]) +_LT_DECL([], [old_postuninstall_cmds], [2]) +_LT_TAGDECL([], [old_archive_cmds], [2], + [Commands used to build an old-style archive]) +_LT_DECL([], [lock_old_archive_extraction], [0], + [Whether to use a lock for old archive extraction]) +])# _LT_CMD_OLD_ARCHIVE + + +# _LT_COMPILER_OPTION(MESSAGE, VARIABLE-NAME, FLAGS, +# [OUTPUT-FILE], [ACTION-SUCCESS], [ACTION-FAILURE]) +# ---------------------------------------------------------------- +# Check whether the given compiler option works +AC_DEFUN([_LT_COMPILER_OPTION], +[m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_DECL_SED])dnl +AC_CACHE_CHECK([$1], [$2], + [$2=no + m4_if([$4], , [ac_outfile=conftest.$ac_objext], [ac_outfile=$4]) + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + lt_compiler_flag="$3" + # Insert the option either (1) after the last *FLAGS variable, or + # (2) before a word containing "conftest.", or (3) at the end. + # Note that $ac_compile itself does not contain backslashes and begins + # with a dollar sign (not a hyphen), so the echo should work correctly. + # The option is referenced via a variable to avoid confusing sed. + lt_compile=`echo "$ac_compile" | $SED \ + -e 's:.*FLAGS}\{0,1\} :&$lt_compiler_flag :; t' \ + -e 's: [[^ ]]*conftest\.: $lt_compiler_flag&:; t' \ + -e 's:$: $lt_compiler_flag:'` + (eval echo "\"\$as_me:$LINENO: $lt_compile\"" >&AS_MESSAGE_LOG_FD) + (eval "$lt_compile" 2>conftest.err) + ac_status=$? + cat conftest.err >&AS_MESSAGE_LOG_FD + echo "$as_me:$LINENO: \$? = $ac_status" >&AS_MESSAGE_LOG_FD + if (exit $ac_status) && test -s "$ac_outfile"; then + # The compiler can only warn and ignore the option if not recognized + # So say no if there are warnings other than the usual output. + $ECHO "$_lt_compiler_boilerplate" | $SED '/^$/d' >conftest.exp + $SED '/^$/d; /^ *+/d' conftest.err >conftest.er2 + if test ! -s conftest.er2 || diff conftest.exp conftest.er2 >/dev/null; then + $2=yes + fi + fi + $RM conftest* +]) + +if test x"[$]$2" = xyes; then + m4_if([$5], , :, [$5]) +else + m4_if([$6], , :, [$6]) +fi +])# _LT_COMPILER_OPTION + +# Old name: +AU_ALIAS([AC_LIBTOOL_COMPILER_OPTION], [_LT_COMPILER_OPTION]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_COMPILER_OPTION], []) + + +# _LT_LINKER_OPTION(MESSAGE, VARIABLE-NAME, FLAGS, +# [ACTION-SUCCESS], [ACTION-FAILURE]) +# ---------------------------------------------------- +# Check whether the given linker option works +AC_DEFUN([_LT_LINKER_OPTION], +[m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_DECL_SED])dnl +AC_CACHE_CHECK([$1], [$2], + [$2=no + save_LDFLAGS="$LDFLAGS" + LDFLAGS="$LDFLAGS $3" + echo "$lt_simple_link_test_code" > conftest.$ac_ext + if (eval $ac_link 2>conftest.err) && test -s conftest$ac_exeext; then + # The linker can only warn and ignore the option if not recognized + # So say no if there are warnings + if test -s conftest.err; then + # Append any errors to the config.log. + cat conftest.err 1>&AS_MESSAGE_LOG_FD + $ECHO "$_lt_linker_boilerplate" | $SED '/^$/d' > conftest.exp + $SED '/^$/d; /^ *+/d' conftest.err >conftest.er2 + if diff conftest.exp conftest.er2 >/dev/null; then + $2=yes + fi + else + $2=yes + fi + fi + $RM -r conftest* + LDFLAGS="$save_LDFLAGS" +]) + +if test x"[$]$2" = xyes; then + m4_if([$4], , :, [$4]) +else + m4_if([$5], , :, [$5]) +fi +])# _LT_LINKER_OPTION + +# Old name: +AU_ALIAS([AC_LIBTOOL_LINKER_OPTION], [_LT_LINKER_OPTION]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_LINKER_OPTION], []) + + +# LT_CMD_MAX_LEN +#--------------- +AC_DEFUN([LT_CMD_MAX_LEN], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +# find the maximum length of command line arguments +AC_MSG_CHECKING([the maximum length of command line arguments]) +AC_CACHE_VAL([lt_cv_sys_max_cmd_len], [dnl + i=0 + teststring="ABCD" + + case $build_os in + msdosdjgpp*) + # On DJGPP, this test can blow up pretty badly due to problems in libc + # (any single argument exceeding 2000 bytes causes a buffer overrun + # during glob expansion). Even if it were fixed, the result of this + # check would be larger than it should be. + lt_cv_sys_max_cmd_len=12288; # 12K is about right + ;; + + gnu*) + # Under GNU Hurd, this test is not required because there is + # no limit to the length of command line arguments. + # Libtool will interpret -1 as no limit whatsoever + lt_cv_sys_max_cmd_len=-1; + ;; + + cygwin* | mingw* | cegcc*) + # On Win9x/ME, this test blows up -- it succeeds, but takes + # about 5 minutes as the teststring grows exponentially. + # Worse, since 9x/ME are not pre-emptively multitasking, + # you end up with a "frozen" computer, even though with patience + # the test eventually succeeds (with a max line length of 256k). + # Instead, let's just punt: use the minimum linelength reported by + # all of the supported platforms: 8192 (on NT/2K/XP). + lt_cv_sys_max_cmd_len=8192; + ;; + + mint*) + # On MiNT this can take a long time and run out of memory. + lt_cv_sys_max_cmd_len=8192; + ;; + + amigaos*) + # On AmigaOS with pdksh, this test takes hours, literally. + # So we just punt and use a minimum line length of 8192. + lt_cv_sys_max_cmd_len=8192; + ;; + + netbsd* | freebsd* | openbsd* | darwin* | dragonfly*) + # This has been around since 386BSD, at least. Likely further. + if test -x /sbin/sysctl; then + lt_cv_sys_max_cmd_len=`/sbin/sysctl -n kern.argmax` + elif test -x /usr/sbin/sysctl; then + lt_cv_sys_max_cmd_len=`/usr/sbin/sysctl -n kern.argmax` + else + lt_cv_sys_max_cmd_len=65536 # usable default for all BSDs + fi + # And add a safety zone + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \/ 4` + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \* 3` + ;; + + interix*) + # We know the value 262144 and hardcode it with a safety zone (like BSD) + lt_cv_sys_max_cmd_len=196608 + ;; + + os2*) + # The test takes a long time on OS/2. + lt_cv_sys_max_cmd_len=8192 + ;; + + osf*) + # Dr. Hans Ekkehard Plesser reports seeing a kernel panic running configure + # due to this test when exec_disable_arg_limit is 1 on Tru64. It is not + # nice to cause kernel panics so lets avoid the loop below. + # First set a reasonable default. + lt_cv_sys_max_cmd_len=16384 + # + if test -x /sbin/sysconfig; then + case `/sbin/sysconfig -q proc exec_disable_arg_limit` in + *1*) lt_cv_sys_max_cmd_len=-1 ;; + esac + fi + ;; + sco3.2v5*) + lt_cv_sys_max_cmd_len=102400 + ;; + sysv5* | sco5v6* | sysv4.2uw2*) + kargmax=`grep ARG_MAX /etc/conf/cf.d/stune 2>/dev/null` + if test -n "$kargmax"; then + lt_cv_sys_max_cmd_len=`echo $kargmax | sed 's/.*[[ ]]//'` + else + lt_cv_sys_max_cmd_len=32768 + fi + ;; + *) + lt_cv_sys_max_cmd_len=`(getconf ARG_MAX) 2> /dev/null` + if test -n "$lt_cv_sys_max_cmd_len"; then + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \/ 4` + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \* 3` + else + # Make teststring a little bigger before we do anything with it. + # a 1K string should be a reasonable start. + for i in 1 2 3 4 5 6 7 8 ; do + teststring=$teststring$teststring + done + SHELL=${SHELL-${CONFIG_SHELL-/bin/sh}} + # If test is not a shell built-in, we'll probably end up computing a + # maximum length that is only half of the actual maximum length, but + # we can't tell. + while { test "X"`env echo "$teststring$teststring" 2>/dev/null` \ + = "X$teststring$teststring"; } >/dev/null 2>&1 && + test $i != 17 # 1/2 MB should be enough + do + i=`expr $i + 1` + teststring=$teststring$teststring + done + # Only check the string length outside the loop. + lt_cv_sys_max_cmd_len=`expr "X$teststring" : ".*" 2>&1` + teststring= + # Add a significant safety factor because C++ compilers can tack on + # massive amounts of additional arguments before passing them to the + # linker. It appears as though 1/2 is a usable value. + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \/ 2` + fi + ;; + esac +]) +if test -n $lt_cv_sys_max_cmd_len ; then + AC_MSG_RESULT($lt_cv_sys_max_cmd_len) +else + AC_MSG_RESULT(none) +fi +max_cmd_len=$lt_cv_sys_max_cmd_len +_LT_DECL([], [max_cmd_len], [0], + [What is the maximum length of a command?]) +])# LT_CMD_MAX_LEN + +# Old name: +AU_ALIAS([AC_LIBTOOL_SYS_MAX_CMD_LEN], [LT_CMD_MAX_LEN]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_SYS_MAX_CMD_LEN], []) + + +# _LT_HEADER_DLFCN +# ---------------- +m4_defun([_LT_HEADER_DLFCN], +[AC_CHECK_HEADERS([dlfcn.h], [], [], [AC_INCLUDES_DEFAULT])dnl +])# _LT_HEADER_DLFCN + + +# _LT_TRY_DLOPEN_SELF (ACTION-IF-TRUE, ACTION-IF-TRUE-W-USCORE, +# ACTION-IF-FALSE, ACTION-IF-CROSS-COMPILING) +# ---------------------------------------------------------------- +m4_defun([_LT_TRY_DLOPEN_SELF], +[m4_require([_LT_HEADER_DLFCN])dnl +if test "$cross_compiling" = yes; then : + [$4] +else + lt_dlunknown=0; lt_dlno_uscore=1; lt_dlneed_uscore=2 + lt_status=$lt_dlunknown + cat > conftest.$ac_ext <<_LT_EOF +[#line $LINENO "configure" +#include "confdefs.h" + +#if HAVE_DLFCN_H +#include +#endif + +#include + +#ifdef RTLD_GLOBAL +# define LT_DLGLOBAL RTLD_GLOBAL +#else +# ifdef DL_GLOBAL +# define LT_DLGLOBAL DL_GLOBAL +# else +# define LT_DLGLOBAL 0 +# endif +#endif + +/* We may have to define LT_DLLAZY_OR_NOW in the command line if we + find out it does not work in some platform. */ +#ifndef LT_DLLAZY_OR_NOW +# ifdef RTLD_LAZY +# define LT_DLLAZY_OR_NOW RTLD_LAZY +# else +# ifdef DL_LAZY +# define LT_DLLAZY_OR_NOW DL_LAZY +# else +# ifdef RTLD_NOW +# define LT_DLLAZY_OR_NOW RTLD_NOW +# else +# ifdef DL_NOW +# define LT_DLLAZY_OR_NOW DL_NOW +# else +# define LT_DLLAZY_OR_NOW 0 +# endif +# endif +# endif +# endif +#endif + +/* When -fvisbility=hidden is used, assume the code has been annotated + correspondingly for the symbols needed. */ +#if defined(__GNUC__) && (((__GNUC__ == 3) && (__GNUC_MINOR__ >= 3)) || (__GNUC__ > 3)) +int fnord () __attribute__((visibility("default"))); +#endif + +int fnord () { return 42; } +int main () +{ + void *self = dlopen (0, LT_DLGLOBAL|LT_DLLAZY_OR_NOW); + int status = $lt_dlunknown; + + if (self) + { + if (dlsym (self,"fnord")) status = $lt_dlno_uscore; + else + { + if (dlsym( self,"_fnord")) status = $lt_dlneed_uscore; + else puts (dlerror ()); + } + /* dlclose (self); */ + } + else + puts (dlerror ()); + + return status; +}] +_LT_EOF + if AC_TRY_EVAL(ac_link) && test -s conftest${ac_exeext} 2>/dev/null; then + (./conftest; exit; ) >&AS_MESSAGE_LOG_FD 2>/dev/null + lt_status=$? + case x$lt_status in + x$lt_dlno_uscore) $1 ;; + x$lt_dlneed_uscore) $2 ;; + x$lt_dlunknown|x*) $3 ;; + esac + else : + # compilation failed + $3 + fi +fi +rm -fr conftest* +])# _LT_TRY_DLOPEN_SELF + + +# LT_SYS_DLOPEN_SELF +# ------------------ +AC_DEFUN([LT_SYS_DLOPEN_SELF], +[m4_require([_LT_HEADER_DLFCN])dnl +if test "x$enable_dlopen" != xyes; then + enable_dlopen=unknown + enable_dlopen_self=unknown + enable_dlopen_self_static=unknown +else + lt_cv_dlopen=no + lt_cv_dlopen_libs= + + case $host_os in + beos*) + lt_cv_dlopen="load_add_on" + lt_cv_dlopen_libs= + lt_cv_dlopen_self=yes + ;; + + mingw* | pw32* | cegcc*) + lt_cv_dlopen="LoadLibrary" + lt_cv_dlopen_libs= + ;; + + cygwin*) + lt_cv_dlopen="dlopen" + lt_cv_dlopen_libs= + ;; + + darwin*) + # if libdl is installed we need to link against it + AC_CHECK_LIB([dl], [dlopen], + [lt_cv_dlopen="dlopen" lt_cv_dlopen_libs="-ldl"],[ + lt_cv_dlopen="dyld" + lt_cv_dlopen_libs= + lt_cv_dlopen_self=yes + ]) + ;; + + *) + AC_CHECK_FUNC([shl_load], + [lt_cv_dlopen="shl_load"], + [AC_CHECK_LIB([dld], [shl_load], + [lt_cv_dlopen="shl_load" lt_cv_dlopen_libs="-ldld"], + [AC_CHECK_FUNC([dlopen], + [lt_cv_dlopen="dlopen"], + [AC_CHECK_LIB([dl], [dlopen], + [lt_cv_dlopen="dlopen" lt_cv_dlopen_libs="-ldl"], + [AC_CHECK_LIB([svld], [dlopen], + [lt_cv_dlopen="dlopen" lt_cv_dlopen_libs="-lsvld"], + [AC_CHECK_LIB([dld], [dld_link], + [lt_cv_dlopen="dld_link" lt_cv_dlopen_libs="-ldld"]) + ]) + ]) + ]) + ]) + ]) + ;; + esac + + if test "x$lt_cv_dlopen" != xno; then + enable_dlopen=yes + else + enable_dlopen=no + fi + + case $lt_cv_dlopen in + dlopen) + save_CPPFLAGS="$CPPFLAGS" + test "x$ac_cv_header_dlfcn_h" = xyes && CPPFLAGS="$CPPFLAGS -DHAVE_DLFCN_H" + + save_LDFLAGS="$LDFLAGS" + wl=$lt_prog_compiler_wl eval LDFLAGS=\"\$LDFLAGS $export_dynamic_flag_spec\" + + save_LIBS="$LIBS" + LIBS="$lt_cv_dlopen_libs $LIBS" + + AC_CACHE_CHECK([whether a program can dlopen itself], + lt_cv_dlopen_self, [dnl + _LT_TRY_DLOPEN_SELF( + lt_cv_dlopen_self=yes, lt_cv_dlopen_self=yes, + lt_cv_dlopen_self=no, lt_cv_dlopen_self=cross) + ]) + + if test "x$lt_cv_dlopen_self" = xyes; then + wl=$lt_prog_compiler_wl eval LDFLAGS=\"\$LDFLAGS $lt_prog_compiler_static\" + AC_CACHE_CHECK([whether a statically linked program can dlopen itself], + lt_cv_dlopen_self_static, [dnl + _LT_TRY_DLOPEN_SELF( + lt_cv_dlopen_self_static=yes, lt_cv_dlopen_self_static=yes, + lt_cv_dlopen_self_static=no, lt_cv_dlopen_self_static=cross) + ]) + fi + + CPPFLAGS="$save_CPPFLAGS" + LDFLAGS="$save_LDFLAGS" + LIBS="$save_LIBS" + ;; + esac + + case $lt_cv_dlopen_self in + yes|no) enable_dlopen_self=$lt_cv_dlopen_self ;; + *) enable_dlopen_self=unknown ;; + esac + + case $lt_cv_dlopen_self_static in + yes|no) enable_dlopen_self_static=$lt_cv_dlopen_self_static ;; + *) enable_dlopen_self_static=unknown ;; + esac +fi +_LT_DECL([dlopen_support], [enable_dlopen], [0], + [Whether dlopen is supported]) +_LT_DECL([dlopen_self], [enable_dlopen_self], [0], + [Whether dlopen of programs is supported]) +_LT_DECL([dlopen_self_static], [enable_dlopen_self_static], [0], + [Whether dlopen of statically linked programs is supported]) +])# LT_SYS_DLOPEN_SELF + +# Old name: +AU_ALIAS([AC_LIBTOOL_DLOPEN_SELF], [LT_SYS_DLOPEN_SELF]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_DLOPEN_SELF], []) + + +# _LT_COMPILER_C_O([TAGNAME]) +# --------------------------- +# Check to see if options -c and -o are simultaneously supported by compiler. +# This macro does not hard code the compiler like AC_PROG_CC_C_O. +m4_defun([_LT_COMPILER_C_O], +[m4_require([_LT_DECL_SED])dnl +m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_TAG_COMPILER])dnl +AC_CACHE_CHECK([if $compiler supports -c -o file.$ac_objext], + [_LT_TAGVAR(lt_cv_prog_compiler_c_o, $1)], + [_LT_TAGVAR(lt_cv_prog_compiler_c_o, $1)=no + $RM -r conftest 2>/dev/null + mkdir conftest + cd conftest + mkdir out + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + + lt_compiler_flag="-o out/conftest2.$ac_objext" + # Insert the option either (1) after the last *FLAGS variable, or + # (2) before a word containing "conftest.", or (3) at the end. + # Note that $ac_compile itself does not contain backslashes and begins + # with a dollar sign (not a hyphen), so the echo should work correctly. + lt_compile=`echo "$ac_compile" | $SED \ + -e 's:.*FLAGS}\{0,1\} :&$lt_compiler_flag :; t' \ + -e 's: [[^ ]]*conftest\.: $lt_compiler_flag&:; t' \ + -e 's:$: $lt_compiler_flag:'` + (eval echo "\"\$as_me:$LINENO: $lt_compile\"" >&AS_MESSAGE_LOG_FD) + (eval "$lt_compile" 2>out/conftest.err) + ac_status=$? + cat out/conftest.err >&AS_MESSAGE_LOG_FD + echo "$as_me:$LINENO: \$? = $ac_status" >&AS_MESSAGE_LOG_FD + if (exit $ac_status) && test -s out/conftest2.$ac_objext + then + # The compiler can only warn and ignore the option if not recognized + # So say no if there are warnings + $ECHO "$_lt_compiler_boilerplate" | $SED '/^$/d' > out/conftest.exp + $SED '/^$/d; /^ *+/d' out/conftest.err >out/conftest.er2 + if test ! -s out/conftest.er2 || diff out/conftest.exp out/conftest.er2 >/dev/null; then + _LT_TAGVAR(lt_cv_prog_compiler_c_o, $1)=yes + fi + fi + chmod u+w . 2>&AS_MESSAGE_LOG_FD + $RM conftest* + # SGI C++ compiler will create directory out/ii_files/ for + # template instantiation + test -d out/ii_files && $RM out/ii_files/* && rmdir out/ii_files + $RM out/* && rmdir out + cd .. + $RM -r conftest + $RM conftest* +]) +_LT_TAGDECL([compiler_c_o], [lt_cv_prog_compiler_c_o], [1], + [Does compiler simultaneously support -c and -o options?]) +])# _LT_COMPILER_C_O + + +# _LT_COMPILER_FILE_LOCKS([TAGNAME]) +# ---------------------------------- +# Check to see if we can do hard links to lock some files if needed +m4_defun([_LT_COMPILER_FILE_LOCKS], +[m4_require([_LT_ENABLE_LOCK])dnl +m4_require([_LT_FILEUTILS_DEFAULTS])dnl +_LT_COMPILER_C_O([$1]) + +hard_links="nottested" +if test "$_LT_TAGVAR(lt_cv_prog_compiler_c_o, $1)" = no && test "$need_locks" != no; then + # do not overwrite the value of need_locks provided by the user + AC_MSG_CHECKING([if we can lock with hard links]) + hard_links=yes + $RM conftest* + ln conftest.a conftest.b 2>/dev/null && hard_links=no + touch conftest.a + ln conftest.a conftest.b 2>&5 || hard_links=no + ln conftest.a conftest.b 2>/dev/null && hard_links=no + AC_MSG_RESULT([$hard_links]) + if test "$hard_links" = no; then + AC_MSG_WARN([`$CC' does not support `-c -o', so `make -j' may be unsafe]) + need_locks=warn + fi +else + need_locks=no +fi +_LT_DECL([], [need_locks], [1], [Must we lock files when doing compilation?]) +])# _LT_COMPILER_FILE_LOCKS + + +# _LT_CHECK_OBJDIR +# ---------------- +m4_defun([_LT_CHECK_OBJDIR], +[AC_CACHE_CHECK([for objdir], [lt_cv_objdir], +[rm -f .libs 2>/dev/null +mkdir .libs 2>/dev/null +if test -d .libs; then + lt_cv_objdir=.libs +else + # MS-DOS does not allow filenames that begin with a dot. + lt_cv_objdir=_libs +fi +rmdir .libs 2>/dev/null]) +objdir=$lt_cv_objdir +_LT_DECL([], [objdir], [0], + [The name of the directory that contains temporary libtool files])dnl +m4_pattern_allow([LT_OBJDIR])dnl +AC_DEFINE_UNQUOTED(LT_OBJDIR, "$lt_cv_objdir/", + [Define to the sub-directory in which libtool stores uninstalled libraries.]) +])# _LT_CHECK_OBJDIR + + +# _LT_LINKER_HARDCODE_LIBPATH([TAGNAME]) +# -------------------------------------- +# Check hardcoding attributes. +m4_defun([_LT_LINKER_HARDCODE_LIBPATH], +[AC_MSG_CHECKING([how to hardcode library paths into programs]) +_LT_TAGVAR(hardcode_action, $1)= +if test -n "$_LT_TAGVAR(hardcode_libdir_flag_spec, $1)" || + test -n "$_LT_TAGVAR(runpath_var, $1)" || + test "X$_LT_TAGVAR(hardcode_automatic, $1)" = "Xyes" ; then + + # We can hardcode non-existent directories. + if test "$_LT_TAGVAR(hardcode_direct, $1)" != no && + # If the only mechanism to avoid hardcoding is shlibpath_var, we + # have to relink, otherwise we might link with an installed library + # when we should be linking with a yet-to-be-installed one + ## test "$_LT_TAGVAR(hardcode_shlibpath_var, $1)" != no && + test "$_LT_TAGVAR(hardcode_minus_L, $1)" != no; then + # Linking always hardcodes the temporary library directory. + _LT_TAGVAR(hardcode_action, $1)=relink + else + # We can link without hardcoding, and we can hardcode nonexisting dirs. + _LT_TAGVAR(hardcode_action, $1)=immediate + fi +else + # We cannot hardcode anything, or else we can only hardcode existing + # directories. + _LT_TAGVAR(hardcode_action, $1)=unsupported +fi +AC_MSG_RESULT([$_LT_TAGVAR(hardcode_action, $1)]) + +if test "$_LT_TAGVAR(hardcode_action, $1)" = relink || + test "$_LT_TAGVAR(inherit_rpath, $1)" = yes; then + # Fast installation is not supported + enable_fast_install=no +elif test "$shlibpath_overrides_runpath" = yes || + test "$enable_shared" = no; then + # Fast installation is not necessary + enable_fast_install=needless +fi +_LT_TAGDECL([], [hardcode_action], [0], + [How to hardcode a shared library path into an executable]) +])# _LT_LINKER_HARDCODE_LIBPATH + + +# _LT_CMD_STRIPLIB +# ---------------- +m4_defun([_LT_CMD_STRIPLIB], +[m4_require([_LT_DECL_EGREP]) +striplib= +old_striplib= +AC_MSG_CHECKING([whether stripping libraries is possible]) +if test -n "$STRIP" && $STRIP -V 2>&1 | $GREP "GNU strip" >/dev/null; then + test -z "$old_striplib" && old_striplib="$STRIP --strip-debug" + test -z "$striplib" && striplib="$STRIP --strip-unneeded" + AC_MSG_RESULT([yes]) +else +# FIXME - insert some real tests, host_os isn't really good enough + case $host_os in + darwin*) + if test -n "$STRIP" ; then + striplib="$STRIP -x" + old_striplib="$STRIP -S" + AC_MSG_RESULT([yes]) + else + AC_MSG_RESULT([no]) + fi + ;; + *) + AC_MSG_RESULT([no]) + ;; + esac +fi +_LT_DECL([], [old_striplib], [1], [Commands to strip libraries]) +_LT_DECL([], [striplib], [1]) +])# _LT_CMD_STRIPLIB + + +# _LT_SYS_DYNAMIC_LINKER([TAG]) +# ----------------------------- +# PORTME Fill in your ld.so characteristics +m4_defun([_LT_SYS_DYNAMIC_LINKER], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +m4_require([_LT_DECL_EGREP])dnl +m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_DECL_OBJDUMP])dnl +m4_require([_LT_DECL_SED])dnl +m4_require([_LT_CHECK_SHELL_FEATURES])dnl +AC_MSG_CHECKING([dynamic linker characteristics]) +m4_if([$1], + [], [ +if test "$GCC" = yes; then + case $host_os in + darwin*) lt_awk_arg="/^libraries:/,/LR/" ;; + *) lt_awk_arg="/^libraries:/" ;; + esac + case $host_os in + mingw* | cegcc*) lt_sed_strip_eq="s,=\([[A-Za-z]]:\),\1,g" ;; + *) lt_sed_strip_eq="s,=/,/,g" ;; + esac + lt_search_path_spec=`$CC -print-search-dirs | awk $lt_awk_arg | $SED -e "s/^libraries://" -e $lt_sed_strip_eq` + case $lt_search_path_spec in + *\;*) + # if the path contains ";" then we assume it to be the separator + # otherwise default to the standard path separator (i.e. ":") - it is + # assumed that no part of a normal pathname contains ";" but that should + # okay in the real world where ";" in dirpaths is itself problematic. + lt_search_path_spec=`$ECHO "$lt_search_path_spec" | $SED 's/;/ /g'` + ;; + *) + lt_search_path_spec=`$ECHO "$lt_search_path_spec" | $SED "s/$PATH_SEPARATOR/ /g"` + ;; + esac + # Ok, now we have the path, separated by spaces, we can step through it + # and add multilib dir if necessary. + lt_tmp_lt_search_path_spec= + lt_multi_os_dir=`$CC $CPPFLAGS $CFLAGS $LDFLAGS -print-multi-os-directory 2>/dev/null` + for lt_sys_path in $lt_search_path_spec; do + if test -d "$lt_sys_path/$lt_multi_os_dir"; then + lt_tmp_lt_search_path_spec="$lt_tmp_lt_search_path_spec $lt_sys_path/$lt_multi_os_dir" + else + test -d "$lt_sys_path" && \ + lt_tmp_lt_search_path_spec="$lt_tmp_lt_search_path_spec $lt_sys_path" + fi + done + lt_search_path_spec=`$ECHO "$lt_tmp_lt_search_path_spec" | awk ' +BEGIN {RS=" "; FS="/|\n";} { + lt_foo=""; + lt_count=0; + for (lt_i = NF; lt_i > 0; lt_i--) { + if ($lt_i != "" && $lt_i != ".") { + if ($lt_i == "..") { + lt_count++; + } else { + if (lt_count == 0) { + lt_foo="/" $lt_i lt_foo; + } else { + lt_count--; + } + } + } + } + if (lt_foo != "") { lt_freq[[lt_foo]]++; } + if (lt_freq[[lt_foo]] == 1) { print lt_foo; } +}'` + # AWK program above erroneously prepends '/' to C:/dos/paths + # for these hosts. + case $host_os in + mingw* | cegcc*) lt_search_path_spec=`$ECHO "$lt_search_path_spec" |\ + $SED 's,/\([[A-Za-z]]:\),\1,g'` ;; + esac + sys_lib_search_path_spec=`$ECHO "$lt_search_path_spec" | $lt_NL2SP` +else + sys_lib_search_path_spec="/lib /usr/lib /usr/local/lib" +fi]) +library_names_spec= +libname_spec='lib$name' +soname_spec= +shrext_cmds=".so" +postinstall_cmds= +postuninstall_cmds= +finish_cmds= +finish_eval= +shlibpath_var= +shlibpath_overrides_runpath=unknown +version_type=none +dynamic_linker="$host_os ld.so" +sys_lib_dlsearch_path_spec="/lib /usr/lib" +need_lib_prefix=unknown +hardcode_into_libs=no + +# when you set need_version to no, make sure it does not cause -set_version +# flags to be left without arguments +need_version=unknown + +case $host_os in +aix3*) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix $libname.a' + shlibpath_var=LIBPATH + + # AIX 3 has no versioning support, so we append a major version to the name. + soname_spec='${libname}${release}${shared_ext}$major' + ;; + +aix[[4-9]]*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + hardcode_into_libs=yes + if test "$host_cpu" = ia64; then + # AIX 5 supports IA64 + library_names_spec='${libname}${release}${shared_ext}$major ${libname}${release}${shared_ext}$versuffix $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + else + # With GCC up to 2.95.x, collect2 would create an import file + # for dependence libraries. The import file would start with + # the line `#! .'. This would cause the generated library to + # depend on `.', always an invalid library. This was fixed in + # development snapshots of GCC prior to 3.0. + case $host_os in + aix4 | aix4.[[01]] | aix4.[[01]].*) + if { echo '#if __GNUC__ > 2 || (__GNUC__ == 2 && __GNUC_MINOR__ >= 97)' + echo ' yes ' + echo '#endif'; } | ${CC} -E - | $GREP yes > /dev/null; then + : + else + can_build_shared=no + fi + ;; + esac + # AIX (on Power*) has no versioning support, so currently we can not hardcode correct + # soname into executable. Probably we can add versioning support to + # collect2, so additional links can be useful in future. + if test "$aix_use_runtimelinking" = yes; then + # If using run time linking (on AIX 4.2 or later) use lib.so + # instead of lib.a to let people know that these are not + # typical AIX shared libraries. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + else + # We preserve .a as extension for shared libraries through AIX4.2 + # and later when we are not doing run time linking. + library_names_spec='${libname}${release}.a $libname.a' + soname_spec='${libname}${release}${shared_ext}$major' + fi + shlibpath_var=LIBPATH + fi + ;; + +amigaos*) + case $host_cpu in + powerpc) + # Since July 2007 AmigaOS4 officially supports .so libraries. + # When compiling the executable, add -use-dynld -Lsobjs: to the compileline. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + ;; + m68k) + library_names_spec='$libname.ixlibrary $libname.a' + # Create ${libname}_ixlibrary.a entries in /sys/libs. + finish_eval='for lib in `ls $libdir/*.ixlibrary 2>/dev/null`; do libname=`func_echo_all "$lib" | $SED '\''s%^.*/\([[^/]]*\)\.ixlibrary$%\1%'\''`; test $RM /sys/libs/${libname}_ixlibrary.a; $show "cd /sys/libs && $LN_S $lib ${libname}_ixlibrary.a"; cd /sys/libs && $LN_S $lib ${libname}_ixlibrary.a || exit 1; done' + ;; + esac + ;; + +beos*) + library_names_spec='${libname}${shared_ext}' + dynamic_linker="$host_os ld.so" + shlibpath_var=LIBRARY_PATH + ;; + +bsdi[[45]]*) + version_type=linux # correct to gnu/linux during the next big refactor + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + finish_cmds='PATH="\$PATH:/sbin" ldconfig $libdir' + shlibpath_var=LD_LIBRARY_PATH + sys_lib_search_path_spec="/shlib /usr/lib /usr/X11/lib /usr/contrib/lib /lib /usr/local/lib" + sys_lib_dlsearch_path_spec="/shlib /usr/lib /usr/local/lib" + # the default ld.so.conf also contains /usr/contrib/lib and + # /usr/X11R6/lib (/usr/X11 is a link to /usr/X11R6), but let us allow + # libtool to hard-code these into programs + ;; + +cygwin* | mingw* | pw32* | cegcc*) + version_type=windows + shrext_cmds=".dll" + need_version=no + need_lib_prefix=no + + case $GCC,$cc_basename in + yes,*) + # gcc + library_names_spec='$libname.dll.a' + # DLL is installed to $(libdir)/../bin by postinstall_cmds + postinstall_cmds='base_file=`basename \${file}`~ + dlpath=`$SHELL 2>&1 -c '\''. $dir/'\''\${base_file}'\''i; echo \$dlname'\''`~ + dldir=$destdir/`dirname \$dlpath`~ + test -d \$dldir || mkdir -p \$dldir~ + $install_prog $dir/$dlname \$dldir/$dlname~ + chmod a+x \$dldir/$dlname~ + if test -n '\''$stripme'\'' && test -n '\''$striplib'\''; then + eval '\''$striplib \$dldir/$dlname'\'' || exit \$?; + fi' + postuninstall_cmds='dldll=`$SHELL 2>&1 -c '\''. $file; echo \$dlname'\''`~ + dlpath=$dir/\$dldll~ + $RM \$dlpath' + shlibpath_overrides_runpath=yes + + case $host_os in + cygwin*) + # Cygwin DLLs use 'cyg' prefix rather than 'lib' + soname_spec='`echo ${libname} | sed -e 's/^lib/cyg/'``echo ${release} | $SED -e 's/[[.]]/-/g'`${versuffix}${shared_ext}' +m4_if([$1], [],[ + sys_lib_search_path_spec="$sys_lib_search_path_spec /usr/lib/w32api"]) + ;; + mingw* | cegcc*) + # MinGW DLLs use traditional 'lib' prefix + soname_spec='${libname}`echo ${release} | $SED -e 's/[[.]]/-/g'`${versuffix}${shared_ext}' + ;; + pw32*) + # pw32 DLLs use 'pw' prefix rather than 'lib' + library_names_spec='`echo ${libname} | sed -e 's/^lib/pw/'``echo ${release} | $SED -e 's/[[.]]/-/g'`${versuffix}${shared_ext}' + ;; + esac + dynamic_linker='Win32 ld.exe' + ;; + + *,cl*) + # Native MSVC + libname_spec='$name' + soname_spec='${libname}`echo ${release} | $SED -e 's/[[.]]/-/g'`${versuffix}${shared_ext}' + library_names_spec='${libname}.dll.lib' + + case $build_os in + mingw*) + sys_lib_search_path_spec= + lt_save_ifs=$IFS + IFS=';' + for lt_path in $LIB + do + IFS=$lt_save_ifs + # Let DOS variable expansion print the short 8.3 style file name. + lt_path=`cd "$lt_path" 2>/dev/null && cmd //C "for %i in (".") do @echo %~si"` + sys_lib_search_path_spec="$sys_lib_search_path_spec $lt_path" + done + IFS=$lt_save_ifs + # Convert to MSYS style. + sys_lib_search_path_spec=`$ECHO "$sys_lib_search_path_spec" | sed -e 's|\\\\|/|g' -e 's| \\([[a-zA-Z]]\\):| /\\1|g' -e 's|^ ||'` + ;; + cygwin*) + # Convert to unix form, then to dos form, then back to unix form + # but this time dos style (no spaces!) so that the unix form looks + # like /cygdrive/c/PROGRA~1:/cygdr... + sys_lib_search_path_spec=`cygpath --path --unix "$LIB"` + sys_lib_search_path_spec=`cygpath --path --dos "$sys_lib_search_path_spec" 2>/dev/null` + sys_lib_search_path_spec=`cygpath --path --unix "$sys_lib_search_path_spec" | $SED -e "s/$PATH_SEPARATOR/ /g"` + ;; + *) + sys_lib_search_path_spec="$LIB" + if $ECHO "$sys_lib_search_path_spec" | [$GREP ';[c-zC-Z]:/' >/dev/null]; then + # It is most probably a Windows format PATH. + sys_lib_search_path_spec=`$ECHO "$sys_lib_search_path_spec" | $SED -e 's/;/ /g'` + else + sys_lib_search_path_spec=`$ECHO "$sys_lib_search_path_spec" | $SED -e "s/$PATH_SEPARATOR/ /g"` + fi + # FIXME: find the short name or the path components, as spaces are + # common. (e.g. "Program Files" -> "PROGRA~1") + ;; + esac + + # DLL is installed to $(libdir)/../bin by postinstall_cmds + postinstall_cmds='base_file=`basename \${file}`~ + dlpath=`$SHELL 2>&1 -c '\''. $dir/'\''\${base_file}'\''i; echo \$dlname'\''`~ + dldir=$destdir/`dirname \$dlpath`~ + test -d \$dldir || mkdir -p \$dldir~ + $install_prog $dir/$dlname \$dldir/$dlname' + postuninstall_cmds='dldll=`$SHELL 2>&1 -c '\''. $file; echo \$dlname'\''`~ + dlpath=$dir/\$dldll~ + $RM \$dlpath' + shlibpath_overrides_runpath=yes + dynamic_linker='Win32 link.exe' + ;; + + *) + # Assume MSVC wrapper + library_names_spec='${libname}`echo ${release} | $SED -e 's/[[.]]/-/g'`${versuffix}${shared_ext} $libname.lib' + dynamic_linker='Win32 ld.exe' + ;; + esac + # FIXME: first we should search . and the directory the executable is in + shlibpath_var=PATH + ;; + +darwin* | rhapsody*) + dynamic_linker="$host_os dyld" + version_type=darwin + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${major}$shared_ext ${libname}$shared_ext' + soname_spec='${libname}${release}${major}$shared_ext' + shlibpath_overrides_runpath=yes + shlibpath_var=DYLD_LIBRARY_PATH + shrext_cmds='`test .$module = .yes && echo .so || echo .dylib`' +m4_if([$1], [],[ + sys_lib_search_path_spec="$sys_lib_search_path_spec /usr/local/lib"]) + sys_lib_dlsearch_path_spec='/usr/local/lib /lib /usr/lib' + ;; + +dgux*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname$shared_ext' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + ;; + +freebsd* | dragonfly*) + # DragonFly does not have aout. When/if they implement a new + # versioning mechanism, adjust this. + if test -x /usr/bin/objformat; then + objformat=`/usr/bin/objformat` + else + case $host_os in + freebsd[[23]].*) objformat=aout ;; + *) objformat=elf ;; + esac + fi + version_type=freebsd-$objformat + case $version_type in + freebsd-elf*) + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext} $libname${shared_ext}' + need_version=no + need_lib_prefix=no + ;; + freebsd-*) + library_names_spec='${libname}${release}${shared_ext}$versuffix $libname${shared_ext}$versuffix' + need_version=yes + ;; + esac + shlibpath_var=LD_LIBRARY_PATH + case $host_os in + freebsd2.*) + shlibpath_overrides_runpath=yes + ;; + freebsd3.[[01]]* | freebsdelf3.[[01]]*) + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + ;; + freebsd3.[[2-9]]* | freebsdelf3.[[2-9]]* | \ + freebsd4.[[0-5]] | freebsdelf4.[[0-5]] | freebsd4.1.1 | freebsdelf4.1.1) + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + *) # from 4.6 on, and DragonFly + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + ;; + esac + ;; + +gnu*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}${major} ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + +haiku*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + dynamic_linker="$host_os runtime_loader" + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}${major} ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LIBRARY_PATH + shlibpath_overrides_runpath=yes + sys_lib_dlsearch_path_spec='/boot/home/config/lib /boot/common/lib /boot/system/lib' + hardcode_into_libs=yes + ;; + +hpux9* | hpux10* | hpux11*) + # Give a soname corresponding to the major version so that dld.sl refuses to + # link against other versions. + version_type=sunos + need_lib_prefix=no + need_version=no + case $host_cpu in + ia64*) + shrext_cmds='.so' + hardcode_into_libs=yes + dynamic_linker="$host_os dld.so" + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes # Unless +noenvvar is specified. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + if test "X$HPUX_IA64_MODE" = X32; then + sys_lib_search_path_spec="/usr/lib/hpux32 /usr/local/lib/hpux32 /usr/local/lib" + else + sys_lib_search_path_spec="/usr/lib/hpux64 /usr/local/lib/hpux64" + fi + sys_lib_dlsearch_path_spec=$sys_lib_search_path_spec + ;; + hppa*64*) + shrext_cmds='.sl' + hardcode_into_libs=yes + dynamic_linker="$host_os dld.sl" + shlibpath_var=LD_LIBRARY_PATH # How should we handle SHLIB_PATH + shlibpath_overrides_runpath=yes # Unless +noenvvar is specified. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + sys_lib_search_path_spec="/usr/lib/pa20_64 /usr/ccs/lib/pa20_64" + sys_lib_dlsearch_path_spec=$sys_lib_search_path_spec + ;; + *) + shrext_cmds='.sl' + dynamic_linker="$host_os dld.sl" + shlibpath_var=SHLIB_PATH + shlibpath_overrides_runpath=no # +s is required to enable SHLIB_PATH + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + ;; + esac + # HP-UX runs *really* slowly unless shared libraries are mode 555, ... + postinstall_cmds='chmod 555 $lib' + # or fails outright, so override atomically: + install_override_mode=555 + ;; + +interix[[3-9]]*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + dynamic_linker='Interix 3.x ld.so.1 (PE, like ELF)' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + +irix5* | irix6* | nonstopux*) + case $host_os in + nonstopux*) version_type=nonstopux ;; + *) + if test "$lt_cv_prog_gnu_ld" = yes; then + version_type=linux # correct to gnu/linux during the next big refactor + else + version_type=irix + fi ;; + esac + need_lib_prefix=no + need_version=no + soname_spec='${libname}${release}${shared_ext}$major' + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major ${libname}${release}${shared_ext} $libname${shared_ext}' + case $host_os in + irix5* | nonstopux*) + libsuff= shlibsuff= + ;; + *) + case $LD in # libtool.m4 will add one of these switches to LD + *-32|*"-32 "|*-melf32bsmip|*"-melf32bsmip ") + libsuff= shlibsuff= libmagic=32-bit;; + *-n32|*"-n32 "|*-melf32bmipn32|*"-melf32bmipn32 ") + libsuff=32 shlibsuff=N32 libmagic=N32;; + *-64|*"-64 "|*-melf64bmip|*"-melf64bmip ") + libsuff=64 shlibsuff=64 libmagic=64-bit;; + *) libsuff= shlibsuff= libmagic=never-match;; + esac + ;; + esac + shlibpath_var=LD_LIBRARY${shlibsuff}_PATH + shlibpath_overrides_runpath=no + sys_lib_search_path_spec="/usr/lib${libsuff} /lib${libsuff} /usr/local/lib${libsuff}" + sys_lib_dlsearch_path_spec="/usr/lib${libsuff} /lib${libsuff}" + hardcode_into_libs=yes + ;; + +# No shared lib support for Linux oldld, aout, or coff. +linux*oldld* | linux*aout* | linux*coff*) + dynamic_linker=no + ;; + +# This must be glibc/ELF. +linux* | k*bsd*-gnu | kopensolaris*-gnu) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + finish_cmds='PATH="\$PATH:/sbin" ldconfig -n $libdir' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + + # Some binutils ld are patched to set DT_RUNPATH + AC_CACHE_VAL([lt_cv_shlibpath_overrides_runpath], + [lt_cv_shlibpath_overrides_runpath=no + save_LDFLAGS=$LDFLAGS + save_libdir=$libdir + eval "libdir=/foo; wl=\"$_LT_TAGVAR(lt_prog_compiler_wl, $1)\"; \ + LDFLAGS=\"\$LDFLAGS $_LT_TAGVAR(hardcode_libdir_flag_spec, $1)\"" + AC_LINK_IFELSE([AC_LANG_PROGRAM([],[])], + [AS_IF([ ($OBJDUMP -p conftest$ac_exeext) 2>/dev/null | grep "RUNPATH.*$libdir" >/dev/null], + [lt_cv_shlibpath_overrides_runpath=yes])]) + LDFLAGS=$save_LDFLAGS + libdir=$save_libdir + ]) + shlibpath_overrides_runpath=$lt_cv_shlibpath_overrides_runpath + + # This implies no fast_install, which is unacceptable. + # Some rework will be needed to allow for fast_install + # before this can be enabled. + hardcode_into_libs=yes + + # Append ld.so.conf contents to the search path + if test -f /etc/ld.so.conf; then + lt_ld_extra=`awk '/^include / { system(sprintf("cd /etc; cat %s 2>/dev/null", \[$]2)); skip = 1; } { if (!skip) print \[$]0; skip = 0; }' < /etc/ld.so.conf | $SED -e 's/#.*//;/^[ ]*hwcap[ ]/d;s/[:, ]/ /g;s/=[^=]*$//;s/=[^= ]* / /g;s/"//g;/^$/d' | tr '\n' ' '` + sys_lib_dlsearch_path_spec="/lib /usr/lib $lt_ld_extra" + fi + + # We used to test for /lib/ld.so.1 and disable shared libraries on + # powerpc, because MkLinux only supported shared libraries with the + # GNU dynamic linker. Since this was broken with cross compilers, + # most powerpc-linux boxes support dynamic linking these days and + # people can always --disable-shared, the test was removed, and we + # assume the GNU/Linux dynamic linker is in use. + dynamic_linker='GNU/Linux ld.so' + ;; + +netbsd*) + version_type=sunos + need_lib_prefix=no + need_version=no + if echo __ELF__ | $CC -E - | $GREP __ELF__ >/dev/null; then + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${shared_ext}$versuffix' + finish_cmds='PATH="\$PATH:/sbin" ldconfig -m $libdir' + dynamic_linker='NetBSD (a.out) ld.so' + else + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + dynamic_linker='NetBSD ld.elf_so' + fi + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + ;; + +newsos6) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + ;; + +*nto* | *qnx*) + version_type=qnx + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + dynamic_linker='ldqnx.so' + ;; + +openbsd*) + version_type=sunos + sys_lib_dlsearch_path_spec="/usr/lib" + need_lib_prefix=no + # Some older versions of OpenBSD (3.3 at least) *do* need versioned libs. + case $host_os in + openbsd3.3 | openbsd3.3.*) need_version=yes ;; + *) need_version=no ;; + esac + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${shared_ext}$versuffix' + finish_cmds='PATH="\$PATH:/sbin" ldconfig -m $libdir' + shlibpath_var=LD_LIBRARY_PATH + if test -z "`echo __ELF__ | $CC -E - | $GREP __ELF__`" || test "$host_os-$host_cpu" = "openbsd2.8-powerpc"; then + case $host_os in + openbsd2.[[89]] | openbsd2.[[89]].*) + shlibpath_overrides_runpath=no + ;; + *) + shlibpath_overrides_runpath=yes + ;; + esac + else + shlibpath_overrides_runpath=yes + fi + ;; + +os2*) + libname_spec='$name' + shrext_cmds=".dll" + need_lib_prefix=no + library_names_spec='$libname${shared_ext} $libname.a' + dynamic_linker='OS/2 ld.exe' + shlibpath_var=LIBPATH + ;; + +osf3* | osf4* | osf5*) + version_type=osf + need_lib_prefix=no + need_version=no + soname_spec='${libname}${release}${shared_ext}$major' + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + sys_lib_search_path_spec="/usr/shlib /usr/ccs/lib /usr/lib/cmplrs/cc /usr/lib /usr/local/lib /var/shlib" + sys_lib_dlsearch_path_spec="$sys_lib_search_path_spec" + ;; + +rdos*) + dynamic_linker=no + ;; + +solaris*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + # ldd complains unless libraries are executable + postinstall_cmds='chmod +x $lib' + ;; + +sunos4*) + version_type=sunos + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${shared_ext}$versuffix' + finish_cmds='PATH="\$PATH:/usr/etc" ldconfig $libdir' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + if test "$with_gnu_ld" = yes; then + need_lib_prefix=no + fi + need_version=yes + ;; + +sysv4 | sysv4.3*) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + case $host_vendor in + sni) + shlibpath_overrides_runpath=no + need_lib_prefix=no + runpath_var=LD_RUN_PATH + ;; + siemens) + need_lib_prefix=no + ;; + motorola) + need_lib_prefix=no + need_version=no + shlibpath_overrides_runpath=no + sys_lib_search_path_spec='/lib /usr/lib /usr/ccs/lib' + ;; + esac + ;; + +sysv4*MP*) + if test -d /usr/nec ;then + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='$libname${shared_ext}.$versuffix $libname${shared_ext}.$major $libname${shared_ext}' + soname_spec='$libname${shared_ext}.$major' + shlibpath_var=LD_LIBRARY_PATH + fi + ;; + +sysv5* | sco3.2v5* | sco5v6* | unixware* | OpenUNIX* | sysv4*uw2*) + version_type=freebsd-elf + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext} $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + if test "$with_gnu_ld" = yes; then + sys_lib_search_path_spec='/usr/local/lib /usr/gnu/lib /usr/ccs/lib /usr/lib /lib' + else + sys_lib_search_path_spec='/usr/ccs/lib /usr/lib' + case $host_os in + sco3.2v5*) + sys_lib_search_path_spec="$sys_lib_search_path_spec /lib" + ;; + esac + fi + sys_lib_dlsearch_path_spec='/usr/lib' + ;; + +tpf*) + # TPF is a cross-target only. Preferred cross-host = GNU/Linux. + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + +uts4*) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + ;; + +*) + dynamic_linker=no + ;; +esac +AC_MSG_RESULT([$dynamic_linker]) +test "$dynamic_linker" = no && can_build_shared=no + +variables_saved_for_relink="PATH $shlibpath_var $runpath_var" +if test "$GCC" = yes; then + variables_saved_for_relink="$variables_saved_for_relink GCC_EXEC_PREFIX COMPILER_PATH LIBRARY_PATH" +fi + +if test "${lt_cv_sys_lib_search_path_spec+set}" = set; then + sys_lib_search_path_spec="$lt_cv_sys_lib_search_path_spec" +fi +if test "${lt_cv_sys_lib_dlsearch_path_spec+set}" = set; then + sys_lib_dlsearch_path_spec="$lt_cv_sys_lib_dlsearch_path_spec" +fi + +_LT_DECL([], [variables_saved_for_relink], [1], + [Variables whose values should be saved in libtool wrapper scripts and + restored at link time]) +_LT_DECL([], [need_lib_prefix], [0], + [Do we need the "lib" prefix for modules?]) +_LT_DECL([], [need_version], [0], [Do we need a version for libraries?]) +_LT_DECL([], [version_type], [0], [Library versioning type]) +_LT_DECL([], [runpath_var], [0], [Shared library runtime path variable]) +_LT_DECL([], [shlibpath_var], [0],[Shared library path variable]) +_LT_DECL([], [shlibpath_overrides_runpath], [0], + [Is shlibpath searched before the hard-coded library search path?]) +_LT_DECL([], [libname_spec], [1], [Format of library name prefix]) +_LT_DECL([], [library_names_spec], [1], + [[List of archive names. First name is the real one, the rest are links. + The last name is the one that the linker finds with -lNAME]]) +_LT_DECL([], [soname_spec], [1], + [[The coded name of the library, if different from the real name]]) +_LT_DECL([], [install_override_mode], [1], + [Permission mode override for installation of shared libraries]) +_LT_DECL([], [postinstall_cmds], [2], + [Command to use after installation of a shared archive]) +_LT_DECL([], [postuninstall_cmds], [2], + [Command to use after uninstallation of a shared archive]) +_LT_DECL([], [finish_cmds], [2], + [Commands used to finish a libtool library installation in a directory]) +_LT_DECL([], [finish_eval], [1], + [[As "finish_cmds", except a single script fragment to be evaled but + not shown]]) +_LT_DECL([], [hardcode_into_libs], [0], + [Whether we should hardcode library paths into libraries]) +_LT_DECL([], [sys_lib_search_path_spec], [2], + [Compile-time system search path for libraries]) +_LT_DECL([], [sys_lib_dlsearch_path_spec], [2], + [Run-time system search path for libraries]) +])# _LT_SYS_DYNAMIC_LINKER + + +# _LT_PATH_TOOL_PREFIX(TOOL) +# -------------------------- +# find a file program which can recognize shared library +AC_DEFUN([_LT_PATH_TOOL_PREFIX], +[m4_require([_LT_DECL_EGREP])dnl +AC_MSG_CHECKING([for $1]) +AC_CACHE_VAL(lt_cv_path_MAGIC_CMD, +[case $MAGIC_CMD in +[[\\/*] | ?:[\\/]*]) + lt_cv_path_MAGIC_CMD="$MAGIC_CMD" # Let the user override the test with a path. + ;; +*) + lt_save_MAGIC_CMD="$MAGIC_CMD" + lt_save_ifs="$IFS"; IFS=$PATH_SEPARATOR +dnl $ac_dummy forces splitting on constant user-supplied paths. +dnl POSIX.2 word splitting is done only on the output of word expansions, +dnl not every word. This closes a longstanding sh security hole. + ac_dummy="m4_if([$2], , $PATH, [$2])" + for ac_dir in $ac_dummy; do + IFS="$lt_save_ifs" + test -z "$ac_dir" && ac_dir=. + if test -f $ac_dir/$1; then + lt_cv_path_MAGIC_CMD="$ac_dir/$1" + if test -n "$file_magic_test_file"; then + case $deplibs_check_method in + "file_magic "*) + file_magic_regex=`expr "$deplibs_check_method" : "file_magic \(.*\)"` + MAGIC_CMD="$lt_cv_path_MAGIC_CMD" + if eval $file_magic_cmd \$file_magic_test_file 2> /dev/null | + $EGREP "$file_magic_regex" > /dev/null; then + : + else + cat <<_LT_EOF 1>&2 + +*** Warning: the command libtool uses to detect shared libraries, +*** $file_magic_cmd, produces output that libtool cannot recognize. +*** The result is that libtool may fail to recognize shared libraries +*** as such. This will affect the creation of libtool libraries that +*** depend on shared libraries, but programs linked with such libtool +*** libraries will work regardless of this problem. Nevertheless, you +*** may want to report the problem to your system manager and/or to +*** bug-libtool@gnu.org + +_LT_EOF + fi ;; + esac + fi + break + fi + done + IFS="$lt_save_ifs" + MAGIC_CMD="$lt_save_MAGIC_CMD" + ;; +esac]) +MAGIC_CMD="$lt_cv_path_MAGIC_CMD" +if test -n "$MAGIC_CMD"; then + AC_MSG_RESULT($MAGIC_CMD) +else + AC_MSG_RESULT(no) +fi +_LT_DECL([], [MAGIC_CMD], [0], + [Used to examine libraries when file_magic_cmd begins with "file"])dnl +])# _LT_PATH_TOOL_PREFIX + +# Old name: +AU_ALIAS([AC_PATH_TOOL_PREFIX], [_LT_PATH_TOOL_PREFIX]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_PATH_TOOL_PREFIX], []) + + +# _LT_PATH_MAGIC +# -------------- +# find a file program which can recognize a shared library +m4_defun([_LT_PATH_MAGIC], +[_LT_PATH_TOOL_PREFIX(${ac_tool_prefix}file, /usr/bin$PATH_SEPARATOR$PATH) +if test -z "$lt_cv_path_MAGIC_CMD"; then + if test -n "$ac_tool_prefix"; then + _LT_PATH_TOOL_PREFIX(file, /usr/bin$PATH_SEPARATOR$PATH) + else + MAGIC_CMD=: + fi +fi +])# _LT_PATH_MAGIC + + +# LT_PATH_LD +# ---------- +# find the pathname to the GNU or non-GNU linker +AC_DEFUN([LT_PATH_LD], +[AC_REQUIRE([AC_PROG_CC])dnl +AC_REQUIRE([AC_CANONICAL_HOST])dnl +AC_REQUIRE([AC_CANONICAL_BUILD])dnl +m4_require([_LT_DECL_SED])dnl +m4_require([_LT_DECL_EGREP])dnl +m4_require([_LT_PROG_ECHO_BACKSLASH])dnl + +AC_ARG_WITH([gnu-ld], + [AS_HELP_STRING([--with-gnu-ld], + [assume the C compiler uses GNU ld @<:@default=no@:>@])], + [test "$withval" = no || with_gnu_ld=yes], + [with_gnu_ld=no])dnl + +ac_prog=ld +if test "$GCC" = yes; then + # Check if gcc -print-prog-name=ld gives a path. + AC_MSG_CHECKING([for ld used by $CC]) + case $host in + *-*-mingw*) + # gcc leaves a trailing carriage return which upsets mingw + ac_prog=`($CC -print-prog-name=ld) 2>&5 | tr -d '\015'` ;; + *) + ac_prog=`($CC -print-prog-name=ld) 2>&5` ;; + esac + case $ac_prog in + # Accept absolute paths. + [[\\/]]* | ?:[[\\/]]*) + re_direlt='/[[^/]][[^/]]*/\.\./' + # Canonicalize the pathname of ld + ac_prog=`$ECHO "$ac_prog"| $SED 's%\\\\%/%g'` + while $ECHO "$ac_prog" | $GREP "$re_direlt" > /dev/null 2>&1; do + ac_prog=`$ECHO $ac_prog| $SED "s%$re_direlt%/%"` + done + test -z "$LD" && LD="$ac_prog" + ;; + "") + # If it fails, then pretend we aren't using GCC. + ac_prog=ld + ;; + *) + # If it is relative, then search for the first ld in PATH. + with_gnu_ld=unknown + ;; + esac +elif test "$with_gnu_ld" = yes; then + AC_MSG_CHECKING([for GNU ld]) +else + AC_MSG_CHECKING([for non-GNU ld]) +fi +AC_CACHE_VAL(lt_cv_path_LD, +[if test -z "$LD"; then + lt_save_ifs="$IFS"; IFS=$PATH_SEPARATOR + for ac_dir in $PATH; do + IFS="$lt_save_ifs" + test -z "$ac_dir" && ac_dir=. + if test -f "$ac_dir/$ac_prog" || test -f "$ac_dir/$ac_prog$ac_exeext"; then + lt_cv_path_LD="$ac_dir/$ac_prog" + # Check to see if the program is GNU ld. I'd rather use --version, + # but apparently some variants of GNU ld only accept -v. + # Break only if it was the GNU/non-GNU ld that we prefer. + case `"$lt_cv_path_LD" -v 2>&1 &1 /dev/null 2>&1; then + lt_cv_deplibs_check_method='file_magic ^x86 archive import|^x86 DLL' + lt_cv_file_magic_cmd='func_win32_libid' + else + # Keep this pattern in sync with the one in func_win32_libid. + lt_cv_deplibs_check_method='file_magic file format (pei*-i386(.*architecture: i386)?|pe-arm-wince|pe-x86-64)' + lt_cv_file_magic_cmd='$OBJDUMP -f' + fi + ;; + +cegcc*) + # use the weaker test based on 'objdump'. See mingw*. + lt_cv_deplibs_check_method='file_magic file format pe-arm-.*little(.*architecture: arm)?' + lt_cv_file_magic_cmd='$OBJDUMP -f' + ;; + +darwin* | rhapsody*) + lt_cv_deplibs_check_method=pass_all + ;; + +freebsd* | dragonfly*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ > /dev/null; then + case $host_cpu in + i*86 ) + # Not sure whether the presence of OpenBSD here was a mistake. + # Let's accept both of them until this is cleared up. + lt_cv_deplibs_check_method='file_magic (FreeBSD|OpenBSD|DragonFly)/i[[3-9]]86 (compact )?demand paged shared library' + lt_cv_file_magic_cmd=/usr/bin/file + lt_cv_file_magic_test_file=`echo /usr/lib/libc.so.*` + ;; + esac + else + lt_cv_deplibs_check_method=pass_all + fi + ;; + +gnu*) + lt_cv_deplibs_check_method=pass_all + ;; + +haiku*) + lt_cv_deplibs_check_method=pass_all + ;; + +hpux10.20* | hpux11*) + lt_cv_file_magic_cmd=/usr/bin/file + case $host_cpu in + ia64*) + lt_cv_deplibs_check_method='file_magic (s[[0-9]][[0-9]][[0-9]]|ELF-[[0-9]][[0-9]]) shared object file - IA64' + lt_cv_file_magic_test_file=/usr/lib/hpux32/libc.so + ;; + hppa*64*) + [lt_cv_deplibs_check_method='file_magic (s[0-9][0-9][0-9]|ELF[ -][0-9][0-9])(-bit)?( [LM]SB)? shared object( file)?[, -]* PA-RISC [0-9]\.[0-9]'] + lt_cv_file_magic_test_file=/usr/lib/pa20_64/libc.sl + ;; + *) + lt_cv_deplibs_check_method='file_magic (s[[0-9]][[0-9]][[0-9]]|PA-RISC[[0-9]]\.[[0-9]]) shared library' + lt_cv_file_magic_test_file=/usr/lib/libc.sl + ;; + esac + ;; + +interix[[3-9]]*) + # PIC code is broken on Interix 3.x, that's why |\.a not |_pic\.a here + lt_cv_deplibs_check_method='match_pattern /lib[[^/]]+(\.so|\.a)$' + ;; + +irix5* | irix6* | nonstopux*) + case $LD in + *-32|*"-32 ") libmagic=32-bit;; + *-n32|*"-n32 ") libmagic=N32;; + *-64|*"-64 ") libmagic=64-bit;; + *) libmagic=never-match;; + esac + lt_cv_deplibs_check_method=pass_all + ;; + +# This must be glibc/ELF. +linux* | k*bsd*-gnu | kopensolaris*-gnu) + lt_cv_deplibs_check_method=pass_all + ;; + +netbsd*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ > /dev/null; then + lt_cv_deplibs_check_method='match_pattern /lib[[^/]]+(\.so\.[[0-9]]+\.[[0-9]]+|_pic\.a)$' + else + lt_cv_deplibs_check_method='match_pattern /lib[[^/]]+(\.so|_pic\.a)$' + fi + ;; + +newos6*) + lt_cv_deplibs_check_method='file_magic ELF [[0-9]][[0-9]]*-bit [[ML]]SB (executable|dynamic lib)' + lt_cv_file_magic_cmd=/usr/bin/file + lt_cv_file_magic_test_file=/usr/lib/libnls.so + ;; + +*nto* | *qnx*) + lt_cv_deplibs_check_method=pass_all + ;; + +openbsd*) + if test -z "`echo __ELF__ | $CC -E - | $GREP __ELF__`" || test "$host_os-$host_cpu" = "openbsd2.8-powerpc"; then + lt_cv_deplibs_check_method='match_pattern /lib[[^/]]+(\.so\.[[0-9]]+\.[[0-9]]+|\.so|_pic\.a)$' + else + lt_cv_deplibs_check_method='match_pattern /lib[[^/]]+(\.so\.[[0-9]]+\.[[0-9]]+|_pic\.a)$' + fi + ;; + +osf3* | osf4* | osf5*) + lt_cv_deplibs_check_method=pass_all + ;; + +rdos*) + lt_cv_deplibs_check_method=pass_all + ;; + +solaris*) + lt_cv_deplibs_check_method=pass_all + ;; + +sysv5* | sco3.2v5* | sco5v6* | unixware* | OpenUNIX* | sysv4*uw2*) + lt_cv_deplibs_check_method=pass_all + ;; + +sysv4 | sysv4.3*) + case $host_vendor in + motorola) + lt_cv_deplibs_check_method='file_magic ELF [[0-9]][[0-9]]*-bit [[ML]]SB (shared object|dynamic lib) M[[0-9]][[0-9]]* Version [[0-9]]' + lt_cv_file_magic_test_file=`echo /usr/lib/libc.so*` + ;; + ncr) + lt_cv_deplibs_check_method=pass_all + ;; + sequent) + lt_cv_file_magic_cmd='/bin/file' + lt_cv_deplibs_check_method='file_magic ELF [[0-9]][[0-9]]*-bit [[LM]]SB (shared object|dynamic lib )' + ;; + sni) + lt_cv_file_magic_cmd='/bin/file' + lt_cv_deplibs_check_method="file_magic ELF [[0-9]][[0-9]]*-bit [[LM]]SB dynamic lib" + lt_cv_file_magic_test_file=/lib/libc.so + ;; + siemens) + lt_cv_deplibs_check_method=pass_all + ;; + pc) + lt_cv_deplibs_check_method=pass_all + ;; + esac + ;; + +tpf*) + lt_cv_deplibs_check_method=pass_all + ;; +esac +]) + +file_magic_glob= +want_nocaseglob=no +if test "$build" = "$host"; then + case $host_os in + mingw* | pw32*) + if ( shopt | grep nocaseglob ) >/dev/null 2>&1; then + want_nocaseglob=yes + else + file_magic_glob=`echo aAbBcCdDeEfFgGhHiIjJkKlLmMnNoOpPqQrRsStTuUvVwWxXyYzZ | $SED -e "s/\(..\)/s\/[[\1]]\/[[\1]]\/g;/g"` + fi + ;; + esac +fi + +file_magic_cmd=$lt_cv_file_magic_cmd +deplibs_check_method=$lt_cv_deplibs_check_method +test -z "$deplibs_check_method" && deplibs_check_method=unknown + +_LT_DECL([], [deplibs_check_method], [1], + [Method to check whether dependent libraries are shared objects]) +_LT_DECL([], [file_magic_cmd], [1], + [Command to use when deplibs_check_method = "file_magic"]) +_LT_DECL([], [file_magic_glob], [1], + [How to find potential files when deplibs_check_method = "file_magic"]) +_LT_DECL([], [want_nocaseglob], [1], + [Find potential files using nocaseglob when deplibs_check_method = "file_magic"]) +])# _LT_CHECK_MAGIC_METHOD + + +# LT_PATH_NM +# ---------- +# find the pathname to a BSD- or MS-compatible name lister +AC_DEFUN([LT_PATH_NM], +[AC_REQUIRE([AC_PROG_CC])dnl +AC_CACHE_CHECK([for BSD- or MS-compatible name lister (nm)], lt_cv_path_NM, +[if test -n "$NM"; then + # Let the user override the test. + lt_cv_path_NM="$NM" +else + lt_nm_to_check="${ac_tool_prefix}nm" + if test -n "$ac_tool_prefix" && test "$build" = "$host"; then + lt_nm_to_check="$lt_nm_to_check nm" + fi + for lt_tmp_nm in $lt_nm_to_check; do + lt_save_ifs="$IFS"; IFS=$PATH_SEPARATOR + for ac_dir in $PATH /usr/ccs/bin/elf /usr/ccs/bin /usr/ucb /bin; do + IFS="$lt_save_ifs" + test -z "$ac_dir" && ac_dir=. + tmp_nm="$ac_dir/$lt_tmp_nm" + if test -f "$tmp_nm" || test -f "$tmp_nm$ac_exeext" ; then + # Check to see if the nm accepts a BSD-compat flag. + # Adding the `sed 1q' prevents false positives on HP-UX, which says: + # nm: unknown option "B" ignored + # Tru64's nm complains that /dev/null is an invalid object file + case `"$tmp_nm" -B /dev/null 2>&1 | sed '1q'` in + */dev/null* | *'Invalid file or object type'*) + lt_cv_path_NM="$tmp_nm -B" + break + ;; + *) + case `"$tmp_nm" -p /dev/null 2>&1 | sed '1q'` in + */dev/null*) + lt_cv_path_NM="$tmp_nm -p" + break + ;; + *) + lt_cv_path_NM=${lt_cv_path_NM="$tmp_nm"} # keep the first match, but + continue # so that we can try to find one that supports BSD flags + ;; + esac + ;; + esac + fi + done + IFS="$lt_save_ifs" + done + : ${lt_cv_path_NM=no} +fi]) +if test "$lt_cv_path_NM" != "no"; then + NM="$lt_cv_path_NM" +else + # Didn't find any BSD compatible name lister, look for dumpbin. + if test -n "$DUMPBIN"; then : + # Let the user override the test. + else + AC_CHECK_TOOLS(DUMPBIN, [dumpbin "link -dump"], :) + case `$DUMPBIN -symbols /dev/null 2>&1 | sed '1q'` in + *COFF*) + DUMPBIN="$DUMPBIN -symbols" + ;; + *) + DUMPBIN=: + ;; + esac + fi + AC_SUBST([DUMPBIN]) + if test "$DUMPBIN" != ":"; then + NM="$DUMPBIN" + fi +fi +test -z "$NM" && NM=nm +AC_SUBST([NM]) +_LT_DECL([], [NM], [1], [A BSD- or MS-compatible name lister])dnl + +AC_CACHE_CHECK([the name lister ($NM) interface], [lt_cv_nm_interface], + [lt_cv_nm_interface="BSD nm" + echo "int some_variable = 0;" > conftest.$ac_ext + (eval echo "\"\$as_me:$LINENO: $ac_compile\"" >&AS_MESSAGE_LOG_FD) + (eval "$ac_compile" 2>conftest.err) + cat conftest.err >&AS_MESSAGE_LOG_FD + (eval echo "\"\$as_me:$LINENO: $NM \\\"conftest.$ac_objext\\\"\"" >&AS_MESSAGE_LOG_FD) + (eval "$NM \"conftest.$ac_objext\"" 2>conftest.err > conftest.out) + cat conftest.err >&AS_MESSAGE_LOG_FD + (eval echo "\"\$as_me:$LINENO: output\"" >&AS_MESSAGE_LOG_FD) + cat conftest.out >&AS_MESSAGE_LOG_FD + if $GREP 'External.*some_variable' conftest.out > /dev/null; then + lt_cv_nm_interface="MS dumpbin" + fi + rm -f conftest*]) +])# LT_PATH_NM + +# Old names: +AU_ALIAS([AM_PROG_NM], [LT_PATH_NM]) +AU_ALIAS([AC_PROG_NM], [LT_PATH_NM]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AM_PROG_NM], []) +dnl AC_DEFUN([AC_PROG_NM], []) + +# _LT_CHECK_SHAREDLIB_FROM_LINKLIB +# -------------------------------- +# how to determine the name of the shared library +# associated with a specific link library. +# -- PORTME fill in with the dynamic library characteristics +m4_defun([_LT_CHECK_SHAREDLIB_FROM_LINKLIB], +[m4_require([_LT_DECL_EGREP]) +m4_require([_LT_DECL_OBJDUMP]) +m4_require([_LT_DECL_DLLTOOL]) +AC_CACHE_CHECK([how to associate runtime and link libraries], +lt_cv_sharedlib_from_linklib_cmd, +[lt_cv_sharedlib_from_linklib_cmd='unknown' + +case $host_os in +cygwin* | mingw* | pw32* | cegcc*) + # two different shell functions defined in ltmain.sh + # decide which to use based on capabilities of $DLLTOOL + case `$DLLTOOL --help 2>&1` in + *--identify-strict*) + lt_cv_sharedlib_from_linklib_cmd=func_cygming_dll_for_implib + ;; + *) + lt_cv_sharedlib_from_linklib_cmd=func_cygming_dll_for_implib_fallback + ;; + esac + ;; +*) + # fallback: assume linklib IS sharedlib + lt_cv_sharedlib_from_linklib_cmd="$ECHO" + ;; +esac +]) +sharedlib_from_linklib_cmd=$lt_cv_sharedlib_from_linklib_cmd +test -z "$sharedlib_from_linklib_cmd" && sharedlib_from_linklib_cmd=$ECHO + +_LT_DECL([], [sharedlib_from_linklib_cmd], [1], + [Command to associate shared and link libraries]) +])# _LT_CHECK_SHAREDLIB_FROM_LINKLIB + + +# _LT_PATH_MANIFEST_TOOL +# ---------------------- +# locate the manifest tool +m4_defun([_LT_PATH_MANIFEST_TOOL], +[AC_CHECK_TOOL(MANIFEST_TOOL, mt, :) +test -z "$MANIFEST_TOOL" && MANIFEST_TOOL=mt +AC_CACHE_CHECK([if $MANIFEST_TOOL is a manifest tool], [lt_cv_path_mainfest_tool], + [lt_cv_path_mainfest_tool=no + echo "$as_me:$LINENO: $MANIFEST_TOOL '-?'" >&AS_MESSAGE_LOG_FD + $MANIFEST_TOOL '-?' 2>conftest.err > conftest.out + cat conftest.err >&AS_MESSAGE_LOG_FD + if $GREP 'Manifest Tool' conftest.out > /dev/null; then + lt_cv_path_mainfest_tool=yes + fi + rm -f conftest*]) +if test "x$lt_cv_path_mainfest_tool" != xyes; then + MANIFEST_TOOL=: +fi +_LT_DECL([], [MANIFEST_TOOL], [1], [Manifest tool])dnl +])# _LT_PATH_MANIFEST_TOOL + + +# LT_LIB_M +# -------- +# check for math library +AC_DEFUN([LT_LIB_M], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +LIBM= +case $host in +*-*-beos* | *-*-cegcc* | *-*-cygwin* | *-*-haiku* | *-*-pw32* | *-*-darwin*) + # These system don't have libm, or don't need it + ;; +*-ncr-sysv4.3*) + AC_CHECK_LIB(mw, _mwvalidcheckl, LIBM="-lmw") + AC_CHECK_LIB(m, cos, LIBM="$LIBM -lm") + ;; +*) + AC_CHECK_LIB(m, cos, LIBM="-lm") + ;; +esac +AC_SUBST([LIBM]) +])# LT_LIB_M + +# Old name: +AU_ALIAS([AC_CHECK_LIBM], [LT_LIB_M]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_CHECK_LIBM], []) + + +# _LT_COMPILER_NO_RTTI([TAGNAME]) +# ------------------------------- +m4_defun([_LT_COMPILER_NO_RTTI], +[m4_require([_LT_TAG_COMPILER])dnl + +_LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)= + +if test "$GCC" = yes; then + case $cc_basename in + nvcc*) + _LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)=' -Xcompiler -fno-builtin' ;; + *) + _LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)=' -fno-builtin' ;; + esac + + _LT_COMPILER_OPTION([if $compiler supports -fno-rtti -fno-exceptions], + lt_cv_prog_compiler_rtti_exceptions, + [-fno-rtti -fno-exceptions], [], + [_LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)="$_LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1) -fno-rtti -fno-exceptions"]) +fi +_LT_TAGDECL([no_builtin_flag], [lt_prog_compiler_no_builtin_flag], [1], + [Compiler flag to turn off builtin functions]) +])# _LT_COMPILER_NO_RTTI + + +# _LT_CMD_GLOBAL_SYMBOLS +# ---------------------- +m4_defun([_LT_CMD_GLOBAL_SYMBOLS], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +AC_REQUIRE([AC_PROG_CC])dnl +AC_REQUIRE([AC_PROG_AWK])dnl +AC_REQUIRE([LT_PATH_NM])dnl +AC_REQUIRE([LT_PATH_LD])dnl +m4_require([_LT_DECL_SED])dnl +m4_require([_LT_DECL_EGREP])dnl +m4_require([_LT_TAG_COMPILER])dnl + +# Check for command to grab the raw symbol name followed by C symbol from nm. +AC_MSG_CHECKING([command to parse $NM output from $compiler object]) +AC_CACHE_VAL([lt_cv_sys_global_symbol_pipe], +[ +# These are sane defaults that work on at least a few old systems. +# [They come from Ultrix. What could be older than Ultrix?!! ;)] + +# Character class describing NM global symbol codes. +symcode='[[BCDEGRST]]' + +# Regexp to match symbols that can be accessed directly from C. +sympat='\([[_A-Za-z]][[_A-Za-z0-9]]*\)' + +# Define system-specific variables. +case $host_os in +aix*) + symcode='[[BCDT]]' + ;; +cygwin* | mingw* | pw32* | cegcc*) + symcode='[[ABCDGISTW]]' + ;; +hpux*) + if test "$host_cpu" = ia64; then + symcode='[[ABCDEGRST]]' + fi + ;; +irix* | nonstopux*) + symcode='[[BCDEGRST]]' + ;; +osf*) + symcode='[[BCDEGQRST]]' + ;; +solaris*) + symcode='[[BDRT]]' + ;; +sco3.2v5*) + symcode='[[DT]]' + ;; +sysv4.2uw2*) + symcode='[[DT]]' + ;; +sysv5* | sco5v6* | unixware* | OpenUNIX*) + symcode='[[ABDT]]' + ;; +sysv4) + symcode='[[DFNSTU]]' + ;; +esac + +# If we're using GNU nm, then use its standard symbol codes. +case `$NM -V 2>&1` in +*GNU* | *'with BFD'*) + symcode='[[ABCDGIRSTW]]' ;; +esac + +# Transform an extracted symbol line into a proper C declaration. +# Some systems (esp. on ia64) link data and code symbols differently, +# so use this general approach. +lt_cv_sys_global_symbol_to_cdecl="sed -n -e 's/^T .* \(.*\)$/extern int \1();/p' -e 's/^$symcode* .* \(.*\)$/extern char \1;/p'" + +# Transform an extracted symbol line into symbol name and symbol address +lt_cv_sys_global_symbol_to_c_name_address="sed -n -e 's/^: \([[^ ]]*\)[[ ]]*$/ {\\\"\1\\\", (void *) 0},/p' -e 's/^$symcode* \([[^ ]]*\) \([[^ ]]*\)$/ {\"\2\", (void *) \&\2},/p'" +lt_cv_sys_global_symbol_to_c_name_address_lib_prefix="sed -n -e 's/^: \([[^ ]]*\)[[ ]]*$/ {\\\"\1\\\", (void *) 0},/p' -e 's/^$symcode* \([[^ ]]*\) \(lib[[^ ]]*\)$/ {\"\2\", (void *) \&\2},/p' -e 's/^$symcode* \([[^ ]]*\) \([[^ ]]*\)$/ {\"lib\2\", (void *) \&\2},/p'" + +# Handle CRLF in mingw tool chain +opt_cr= +case $build_os in +mingw*) + opt_cr=`$ECHO 'x\{0,1\}' | tr x '\015'` # option cr in regexp + ;; +esac + +# Try without a prefix underscore, then with it. +for ac_symprfx in "" "_"; do + + # Transform symcode, sympat, and symprfx into a raw symbol and a C symbol. + symxfrm="\\1 $ac_symprfx\\2 \\2" + + # Write the raw and C identifiers. + if test "$lt_cv_nm_interface" = "MS dumpbin"; then + # Fake it for dumpbin and say T for any non-static function + # and D for any global variable. + # Also find C++ and __fastcall symbols from MSVC++, + # which start with @ or ?. + lt_cv_sys_global_symbol_pipe="$AWK ['"\ +" {last_section=section; section=\$ 3};"\ +" /^COFF SYMBOL TABLE/{for(i in hide) delete hide[i]};"\ +" /Section length .*#relocs.*(pick any)/{hide[last_section]=1};"\ +" \$ 0!~/External *\|/{next};"\ +" / 0+ UNDEF /{next}; / UNDEF \([^|]\)*()/{next};"\ +" {if(hide[section]) next};"\ +" {f=0}; \$ 0~/\(\).*\|/{f=1}; {printf f ? \"T \" : \"D \"};"\ +" {split(\$ 0, a, /\||\r/); split(a[2], s)};"\ +" s[1]~/^[@?]/{print s[1], s[1]; next};"\ +" s[1]~prfx {split(s[1],t,\"@\"); print t[1], substr(t[1],length(prfx))}"\ +" ' prfx=^$ac_symprfx]" + else + lt_cv_sys_global_symbol_pipe="sed -n -e 's/^.*[[ ]]\($symcode$symcode*\)[[ ]][[ ]]*$ac_symprfx$sympat$opt_cr$/$symxfrm/p'" + fi + lt_cv_sys_global_symbol_pipe="$lt_cv_sys_global_symbol_pipe | sed '/ __gnu_lto/d'" + + # Check to see that the pipe works correctly. + pipe_works=no + + rm -f conftest* + cat > conftest.$ac_ext <<_LT_EOF +#ifdef __cplusplus +extern "C" { +#endif +char nm_test_var; +void nm_test_func(void); +void nm_test_func(void){} +#ifdef __cplusplus +} +#endif +int main(){nm_test_var='a';nm_test_func();return(0);} +_LT_EOF + + if AC_TRY_EVAL(ac_compile); then + # Now try to grab the symbols. + nlist=conftest.nm + if AC_TRY_EVAL(NM conftest.$ac_objext \| "$lt_cv_sys_global_symbol_pipe" \> $nlist) && test -s "$nlist"; then + # Try sorting and uniquifying the output. + if sort "$nlist" | uniq > "$nlist"T; then + mv -f "$nlist"T "$nlist" + else + rm -f "$nlist"T + fi + + # Make sure that we snagged all the symbols we need. + if $GREP ' nm_test_var$' "$nlist" >/dev/null; then + if $GREP ' nm_test_func$' "$nlist" >/dev/null; then + cat <<_LT_EOF > conftest.$ac_ext +/* Keep this code in sync between libtool.m4, ltmain, lt_system.h, and tests. */ +#if defined(_WIN32) || defined(__CYGWIN__) || defined(_WIN32_WCE) +/* DATA imports from DLLs on WIN32 con't be const, because runtime + relocations are performed -- see ld's documentation on pseudo-relocs. */ +# define LT@&t@_DLSYM_CONST +#elif defined(__osf__) +/* This system does not cope well with relocations in const data. */ +# define LT@&t@_DLSYM_CONST +#else +# define LT@&t@_DLSYM_CONST const +#endif + +#ifdef __cplusplus +extern "C" { +#endif + +_LT_EOF + # Now generate the symbol file. + eval "$lt_cv_sys_global_symbol_to_cdecl"' < "$nlist" | $GREP -v main >> conftest.$ac_ext' + + cat <<_LT_EOF >> conftest.$ac_ext + +/* The mapping between symbol names and symbols. */ +LT@&t@_DLSYM_CONST struct { + const char *name; + void *address; +} +lt__PROGRAM__LTX_preloaded_symbols[[]] = +{ + { "@PROGRAM@", (void *) 0 }, +_LT_EOF + $SED "s/^$symcode$symcode* \(.*\) \(.*\)$/ {\"\2\", (void *) \&\2},/" < "$nlist" | $GREP -v main >> conftest.$ac_ext + cat <<\_LT_EOF >> conftest.$ac_ext + {0, (void *) 0} +}; + +/* This works around a problem in FreeBSD linker */ +#ifdef FREEBSD_WORKAROUND +static const void *lt_preloaded_setup() { + return lt__PROGRAM__LTX_preloaded_symbols; +} +#endif + +#ifdef __cplusplus +} +#endif +_LT_EOF + # Now try linking the two files. + mv conftest.$ac_objext conftstm.$ac_objext + lt_globsym_save_LIBS=$LIBS + lt_globsym_save_CFLAGS=$CFLAGS + LIBS="conftstm.$ac_objext" + CFLAGS="$CFLAGS$_LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)" + if AC_TRY_EVAL(ac_link) && test -s conftest${ac_exeext}; then + pipe_works=yes + fi + LIBS=$lt_globsym_save_LIBS + CFLAGS=$lt_globsym_save_CFLAGS + else + echo "cannot find nm_test_func in $nlist" >&AS_MESSAGE_LOG_FD + fi + else + echo "cannot find nm_test_var in $nlist" >&AS_MESSAGE_LOG_FD + fi + else + echo "cannot run $lt_cv_sys_global_symbol_pipe" >&AS_MESSAGE_LOG_FD + fi + else + echo "$progname: failed program was:" >&AS_MESSAGE_LOG_FD + cat conftest.$ac_ext >&5 + fi + rm -rf conftest* conftst* + + # Do not use the global_symbol_pipe unless it works. + if test "$pipe_works" = yes; then + break + else + lt_cv_sys_global_symbol_pipe= + fi +done +]) +if test -z "$lt_cv_sys_global_symbol_pipe"; then + lt_cv_sys_global_symbol_to_cdecl= +fi +if test -z "$lt_cv_sys_global_symbol_pipe$lt_cv_sys_global_symbol_to_cdecl"; then + AC_MSG_RESULT(failed) +else + AC_MSG_RESULT(ok) +fi + +# Response file support. +if test "$lt_cv_nm_interface" = "MS dumpbin"; then + nm_file_list_spec='@' +elif $NM --help 2>/dev/null | grep '[[@]]FILE' >/dev/null; then + nm_file_list_spec='@' +fi + +_LT_DECL([global_symbol_pipe], [lt_cv_sys_global_symbol_pipe], [1], + [Take the output of nm and produce a listing of raw symbols and C names]) +_LT_DECL([global_symbol_to_cdecl], [lt_cv_sys_global_symbol_to_cdecl], [1], + [Transform the output of nm in a proper C declaration]) +_LT_DECL([global_symbol_to_c_name_address], + [lt_cv_sys_global_symbol_to_c_name_address], [1], + [Transform the output of nm in a C name address pair]) +_LT_DECL([global_symbol_to_c_name_address_lib_prefix], + [lt_cv_sys_global_symbol_to_c_name_address_lib_prefix], [1], + [Transform the output of nm in a C name address pair when lib prefix is needed]) +_LT_DECL([], [nm_file_list_spec], [1], + [Specify filename containing input files for $NM]) +]) # _LT_CMD_GLOBAL_SYMBOLS + + +# _LT_COMPILER_PIC([TAGNAME]) +# --------------------------- +m4_defun([_LT_COMPILER_PIC], +[m4_require([_LT_TAG_COMPILER])dnl +_LT_TAGVAR(lt_prog_compiler_wl, $1)= +_LT_TAGVAR(lt_prog_compiler_pic, $1)= +_LT_TAGVAR(lt_prog_compiler_static, $1)= + +m4_if([$1], [CXX], [ + # C++ specific cases for pic, static, wl, etc. + if test "$GXX" = yes; then + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + + case $host_os in + aix*) + # All AIX code is PIC. + if test "$host_cpu" = ia64; then + # AIX 5 now supports IA64 processor + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + fi + ;; + + amigaos*) + case $host_cpu in + powerpc) + # see comment about AmigaOS4 .so support + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + m68k) + # FIXME: we need at least 68020 code to build shared libraries, but + # adding the `-m68020' flag to GCC prevents building anything better, + # like `-m68040'. + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-m68020 -resident32 -malways-restore-a4' + ;; + esac + ;; + + beos* | irix5* | irix6* | nonstopux* | osf3* | osf4* | osf5*) + # PIC is the default for these OSes. + ;; + mingw* | cygwin* | os2* | pw32* | cegcc*) + # This hack is so that the source file can tell whether it is being + # built for inclusion in a dll (and should export symbols for example). + # Although the cygwin gcc ignores -fPIC, still need this for old-style + # (--disable-auto-import) libraries + m4_if([$1], [GCJ], [], + [_LT_TAGVAR(lt_prog_compiler_pic, $1)='-DDLL_EXPORT']) + ;; + darwin* | rhapsody*) + # PIC is the default on this platform + # Common symbols not allowed in MH_DYLIB files + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fno-common' + ;; + *djgpp*) + # DJGPP does not support shared libraries at all + _LT_TAGVAR(lt_prog_compiler_pic, $1)= + ;; + haiku*) + # PIC is the default for Haiku. + # The "-static" flag exists, but is broken. + _LT_TAGVAR(lt_prog_compiler_static, $1)= + ;; + interix[[3-9]]*) + # Interix 3.x gcc -fpic/-fPIC options generate broken code. + # Instead, we relocate shared libraries at runtime. + ;; + sysv4*MP*) + if test -d /usr/nec; then + _LT_TAGVAR(lt_prog_compiler_pic, $1)=-Kconform_pic + fi + ;; + hpux*) + # PIC is the default for 64-bit PA HP-UX, but not for 32-bit + # PA HP-UX. On IA64 HP-UX, PIC is the default but the pic flag + # sets the default TLS model and affects inlining. + case $host_cpu in + hppa*64*) + ;; + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + esac + ;; + *qnx* | *nto*) + # QNX uses GNU C++, but need to define -shared option too, otherwise + # it will coredump. + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC -shared' + ;; + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + esac + else + case $host_os in + aix[[4-9]]*) + # All AIX code is PIC. + if test "$host_cpu" = ia64; then + # AIX 5 now supports IA64 processor + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + else + _LT_TAGVAR(lt_prog_compiler_static, $1)='-bnso -bI:/lib/syscalls.exp' + fi + ;; + chorus*) + case $cc_basename in + cxch68*) + # Green Hills C++ Compiler + # _LT_TAGVAR(lt_prog_compiler_static, $1)="--no_auto_instantiation -u __main -u __premain -u _abort -r $COOL_DIR/lib/libOrb.a $MVME_DIR/lib/CC/libC.a $MVME_DIR/lib/classix/libcx.s.a" + ;; + esac + ;; + mingw* | cygwin* | os2* | pw32* | cegcc*) + # This hack is so that the source file can tell whether it is being + # built for inclusion in a dll (and should export symbols for example). + m4_if([$1], [GCJ], [], + [_LT_TAGVAR(lt_prog_compiler_pic, $1)='-DDLL_EXPORT']) + ;; + dgux*) + case $cc_basename in + ec++*) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + ;; + ghcx*) + # Green Hills C++ Compiler + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-pic' + ;; + *) + ;; + esac + ;; + freebsd* | dragonfly*) + # FreeBSD uses GNU C++ + ;; + hpux9* | hpux10* | hpux11*) + case $cc_basename in + CC*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_static, $1)='${wl}-a ${wl}archive' + if test "$host_cpu" != ia64; then + _LT_TAGVAR(lt_prog_compiler_pic, $1)='+Z' + fi + ;; + aCC*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_static, $1)='${wl}-a ${wl}archive' + case $host_cpu in + hppa*64*|ia64*) + # +Z the default + ;; + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='+Z' + ;; + esac + ;; + *) + ;; + esac + ;; + interix*) + # This is c89, which is MS Visual C++ (no shared libs) + # Anyone wants to do a port? + ;; + irix5* | irix6* | nonstopux*) + case $cc_basename in + CC*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + # CC pic flag -KPIC is the default. + ;; + *) + ;; + esac + ;; + linux* | k*bsd*-gnu | kopensolaris*-gnu) + case $cc_basename in + KCC*) + # KAI C++ Compiler + _LT_TAGVAR(lt_prog_compiler_wl, $1)='--backend -Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + ecpc* ) + # old Intel C++ for x86_64 which still supported -KPIC. + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + ;; + icpc* ) + # Intel C++, used to be incompatible with GCC. + # ICC 10 doesn't accept -KPIC any more. + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + ;; + pgCC* | pgcpp*) + # Portland Group C++ compiler + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fpic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + cxx*) + # Compaq C++ + # Make sure the PIC flag is empty. It appears that all Alpha + # Linux and Compaq Tru64 Unix objects are PIC. + _LT_TAGVAR(lt_prog_compiler_pic, $1)= + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + ;; + xlc* | xlC* | bgxl[[cC]]* | mpixl[[cC]]*) + # IBM XL 8.0, 9.0 on PPC and BlueGene + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-qpic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-qstaticlink' + ;; + *) + case `$CC -V 2>&1 | sed 5q` in + *Sun\ C*) + # Sun C++ 5.9 + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Qoption ld ' + ;; + esac + ;; + esac + ;; + lynxos*) + ;; + m88k*) + ;; + mvs*) + case $cc_basename in + cxx*) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-W c,exportall' + ;; + *) + ;; + esac + ;; + netbsd*) + ;; + *qnx* | *nto*) + # QNX uses GNU C++, but need to define -shared option too, otherwise + # it will coredump. + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC -shared' + ;; + osf3* | osf4* | osf5*) + case $cc_basename in + KCC*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='--backend -Wl,' + ;; + RCC*) + # Rational C++ 2.4.1 + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-pic' + ;; + cxx*) + # Digital/Compaq C++ + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + # Make sure the PIC flag is empty. It appears that all Alpha + # Linux and Compaq Tru64 Unix objects are PIC. + _LT_TAGVAR(lt_prog_compiler_pic, $1)= + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + ;; + *) + ;; + esac + ;; + psos*) + ;; + solaris*) + case $cc_basename in + CC* | sunCC*) + # Sun C++ 4.2, 5.x and Centerline C++ + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Qoption ld ' + ;; + gcx*) + # Green Hills C++ Compiler + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-PIC' + ;; + *) + ;; + esac + ;; + sunos4*) + case $cc_basename in + CC*) + # Sun C++ 4.x + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-pic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + lcc*) + # Lucid + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-pic' + ;; + *) + ;; + esac + ;; + sysv5* | unixware* | sco3.2v5* | sco5v6* | OpenUNIX*) + case $cc_basename in + CC*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + esac + ;; + tandem*) + case $cc_basename in + NCC*) + # NonStop-UX NCC 3.20 + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + ;; + *) + ;; + esac + ;; + vxworks*) + ;; + *) + _LT_TAGVAR(lt_prog_compiler_can_build_shared, $1)=no + ;; + esac + fi +], +[ + if test "$GCC" = yes; then + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + + case $host_os in + aix*) + # All AIX code is PIC. + if test "$host_cpu" = ia64; then + # AIX 5 now supports IA64 processor + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + fi + ;; + + amigaos*) + case $host_cpu in + powerpc) + # see comment about AmigaOS4 .so support + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + m68k) + # FIXME: we need at least 68020 code to build shared libraries, but + # adding the `-m68020' flag to GCC prevents building anything better, + # like `-m68040'. + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-m68020 -resident32 -malways-restore-a4' + ;; + esac + ;; + + beos* | irix5* | irix6* | nonstopux* | osf3* | osf4* | osf5*) + # PIC is the default for these OSes. + ;; + + mingw* | cygwin* | pw32* | os2* | cegcc*) + # This hack is so that the source file can tell whether it is being + # built for inclusion in a dll (and should export symbols for example). + # Although the cygwin gcc ignores -fPIC, still need this for old-style + # (--disable-auto-import) libraries + m4_if([$1], [GCJ], [], + [_LT_TAGVAR(lt_prog_compiler_pic, $1)='-DDLL_EXPORT']) + ;; + + darwin* | rhapsody*) + # PIC is the default on this platform + # Common symbols not allowed in MH_DYLIB files + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fno-common' + ;; + + haiku*) + # PIC is the default for Haiku. + # The "-static" flag exists, but is broken. + _LT_TAGVAR(lt_prog_compiler_static, $1)= + ;; + + hpux*) + # PIC is the default for 64-bit PA HP-UX, but not for 32-bit + # PA HP-UX. On IA64 HP-UX, PIC is the default but the pic flag + # sets the default TLS model and affects inlining. + case $host_cpu in + hppa*64*) + # +Z the default + ;; + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + esac + ;; + + interix[[3-9]]*) + # Interix 3.x gcc -fpic/-fPIC options generate broken code. + # Instead, we relocate shared libraries at runtime. + ;; + + msdosdjgpp*) + # Just because we use GCC doesn't mean we suddenly get shared libraries + # on systems that don't support them. + _LT_TAGVAR(lt_prog_compiler_can_build_shared, $1)=no + enable_shared=no + ;; + + *nto* | *qnx*) + # QNX uses GNU C++, but need to define -shared option too, otherwise + # it will coredump. + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC -shared' + ;; + + sysv4*MP*) + if test -d /usr/nec; then + _LT_TAGVAR(lt_prog_compiler_pic, $1)=-Kconform_pic + fi + ;; + + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + esac + + case $cc_basename in + nvcc*) # Cuda Compiler Driver 2.2 + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Xlinker ' + if test -n "$_LT_TAGVAR(lt_prog_compiler_pic, $1)"; then + _LT_TAGVAR(lt_prog_compiler_pic, $1)="-Xcompiler $_LT_TAGVAR(lt_prog_compiler_pic, $1)" + fi + ;; + esac + else + # PORTME Check for flag to pass linker flags through the system compiler. + case $host_os in + aix*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + if test "$host_cpu" = ia64; then + # AIX 5 now supports IA64 processor + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + else + _LT_TAGVAR(lt_prog_compiler_static, $1)='-bnso -bI:/lib/syscalls.exp' + fi + ;; + + mingw* | cygwin* | pw32* | os2* | cegcc*) + # This hack is so that the source file can tell whether it is being + # built for inclusion in a dll (and should export symbols for example). + m4_if([$1], [GCJ], [], + [_LT_TAGVAR(lt_prog_compiler_pic, $1)='-DDLL_EXPORT']) + ;; + + hpux9* | hpux10* | hpux11*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + # PIC is the default for IA64 HP-UX and 64-bit HP-UX, but + # not for PA HP-UX. + case $host_cpu in + hppa*64*|ia64*) + # +Z the default + ;; + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='+Z' + ;; + esac + # Is there a better lt_prog_compiler_static that works with the bundled CC? + _LT_TAGVAR(lt_prog_compiler_static, $1)='${wl}-a ${wl}archive' + ;; + + irix5* | irix6* | nonstopux*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + # PIC (with -KPIC) is the default. + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + ;; + + linux* | k*bsd*-gnu | kopensolaris*-gnu) + case $cc_basename in + # old Intel for x86_64 which still supported -KPIC. + ecc*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + ;; + # icc used to be incompatible with GCC. + # ICC 10 doesn't accept -KPIC any more. + icc* | ifort*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + ;; + # Lahey Fortran 8.1. + lf95*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='--shared' + _LT_TAGVAR(lt_prog_compiler_static, $1)='--static' + ;; + nagfor*) + # NAG Fortran compiler + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,-Wl,,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-PIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + pgcc* | pgf77* | pgf90* | pgf95* | pgfortran*) + # Portland Group compilers (*not* the Pentium gcc compiler, + # which looks to be a dead project) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fpic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + ccc*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + # All Alpha code is PIC. + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + ;; + xl* | bgxl* | bgf* | mpixl*) + # IBM XL C 8.0/Fortran 10.1, 11.1 on PPC and BlueGene + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-qpic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-qstaticlink' + ;; + *) + case `$CC -V 2>&1 | sed 5q` in + *Sun\ Ceres\ Fortran* | *Sun*Fortran*\ [[1-7]].* | *Sun*Fortran*\ 8.[[0-3]]*) + # Sun Fortran 8.3 passes all unrecognized flags to the linker + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + _LT_TAGVAR(lt_prog_compiler_wl, $1)='' + ;; + *Sun\ F* | *Sun*Fortran*) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Qoption ld ' + ;; + *Sun\ C*) + # Sun C 5.9 + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + ;; + *Intel*\ [[CF]]*Compiler*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + ;; + *Portland\ Group*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fpic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + esac + ;; + esac + ;; + + newsos6) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + + *nto* | *qnx*) + # QNX uses GNU C++, but need to define -shared option too, otherwise + # it will coredump. + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC -shared' + ;; + + osf3* | osf4* | osf5*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + # All OSF/1 code is PIC. + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + ;; + + rdos*) + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + ;; + + solaris*) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + case $cc_basename in + f77* | f90* | f95* | sunf77* | sunf90* | sunf95*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Qoption ld ';; + *) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,';; + esac + ;; + + sunos4*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Qoption ld ' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-PIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + + sysv4 | sysv4.2uw2* | sysv4.3*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + + sysv4*MP*) + if test -d /usr/nec ;then + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-Kconform_pic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + fi + ;; + + sysv5* | unixware* | sco3.2v5* | sco5v6* | OpenUNIX*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + + unicos*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_can_build_shared, $1)=no + ;; + + uts4*) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-pic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + + *) + _LT_TAGVAR(lt_prog_compiler_can_build_shared, $1)=no + ;; + esac + fi +]) +case $host_os in + # For platforms which do not support PIC, -DPIC is meaningless: + *djgpp*) + _LT_TAGVAR(lt_prog_compiler_pic, $1)= + ;; + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)="$_LT_TAGVAR(lt_prog_compiler_pic, $1)@&t@m4_if([$1],[],[ -DPIC],[m4_if([$1],[CXX],[ -DPIC],[])])" + ;; +esac + +AC_CACHE_CHECK([for $compiler option to produce PIC], + [_LT_TAGVAR(lt_cv_prog_compiler_pic, $1)], + [_LT_TAGVAR(lt_cv_prog_compiler_pic, $1)=$_LT_TAGVAR(lt_prog_compiler_pic, $1)]) +_LT_TAGVAR(lt_prog_compiler_pic, $1)=$_LT_TAGVAR(lt_cv_prog_compiler_pic, $1) + +# +# Check to make sure the PIC flag actually works. +# +if test -n "$_LT_TAGVAR(lt_prog_compiler_pic, $1)"; then + _LT_COMPILER_OPTION([if $compiler PIC flag $_LT_TAGVAR(lt_prog_compiler_pic, $1) works], + [_LT_TAGVAR(lt_cv_prog_compiler_pic_works, $1)], + [$_LT_TAGVAR(lt_prog_compiler_pic, $1)@&t@m4_if([$1],[],[ -DPIC],[m4_if([$1],[CXX],[ -DPIC],[])])], [], + [case $_LT_TAGVAR(lt_prog_compiler_pic, $1) in + "" | " "*) ;; + *) _LT_TAGVAR(lt_prog_compiler_pic, $1)=" $_LT_TAGVAR(lt_prog_compiler_pic, $1)" ;; + esac], + [_LT_TAGVAR(lt_prog_compiler_pic, $1)= + _LT_TAGVAR(lt_prog_compiler_can_build_shared, $1)=no]) +fi +_LT_TAGDECL([pic_flag], [lt_prog_compiler_pic], [1], + [Additional compiler flags for building library objects]) + +_LT_TAGDECL([wl], [lt_prog_compiler_wl], [1], + [How to pass a linker flag through the compiler]) +# +# Check to make sure the static flag actually works. +# +wl=$_LT_TAGVAR(lt_prog_compiler_wl, $1) eval lt_tmp_static_flag=\"$_LT_TAGVAR(lt_prog_compiler_static, $1)\" +_LT_LINKER_OPTION([if $compiler static flag $lt_tmp_static_flag works], + _LT_TAGVAR(lt_cv_prog_compiler_static_works, $1), + $lt_tmp_static_flag, + [], + [_LT_TAGVAR(lt_prog_compiler_static, $1)=]) +_LT_TAGDECL([link_static_flag], [lt_prog_compiler_static], [1], + [Compiler flag to prevent dynamic linking]) +])# _LT_COMPILER_PIC + + +# _LT_LINKER_SHLIBS([TAGNAME]) +# ---------------------------- +# See if the linker supports building shared libraries. +m4_defun([_LT_LINKER_SHLIBS], +[AC_REQUIRE([LT_PATH_LD])dnl +AC_REQUIRE([LT_PATH_NM])dnl +m4_require([_LT_PATH_MANIFEST_TOOL])dnl +m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_DECL_EGREP])dnl +m4_require([_LT_DECL_SED])dnl +m4_require([_LT_CMD_GLOBAL_SYMBOLS])dnl +m4_require([_LT_TAG_COMPILER])dnl +AC_MSG_CHECKING([whether the $compiler linker ($LD) supports shared libraries]) +m4_if([$1], [CXX], [ + _LT_TAGVAR(export_symbols_cmds, $1)='$NM $libobjs $convenience | $global_symbol_pipe | $SED '\''s/.* //'\'' | sort | uniq > $export_symbols' + _LT_TAGVAR(exclude_expsyms, $1)=['_GLOBAL_OFFSET_TABLE_|_GLOBAL__F[ID]_.*'] + case $host_os in + aix[[4-9]]*) + # If we're using GNU nm, then we don't want the "-C" option. + # -C means demangle to AIX nm, but means don't demangle with GNU nm + # Also, AIX nm treats weak defined symbols like other global defined + # symbols, whereas GNU nm marks them as "W". + if $NM -V 2>&1 | $GREP 'GNU' > /dev/null; then + _LT_TAGVAR(export_symbols_cmds, $1)='$NM -Bpg $libobjs $convenience | awk '\''{ if (((\$ 2 == "T") || (\$ 2 == "D") || (\$ 2 == "B") || (\$ 2 == "W")) && ([substr](\$ 3,1,1) != ".")) { print \$ 3 } }'\'' | sort -u > $export_symbols' + else + _LT_TAGVAR(export_symbols_cmds, $1)='$NM -BCpg $libobjs $convenience | awk '\''{ if (((\$ 2 == "T") || (\$ 2 == "D") || (\$ 2 == "B")) && ([substr](\$ 3,1,1) != ".")) { print \$ 3 } }'\'' | sort -u > $export_symbols' + fi + ;; + pw32*) + _LT_TAGVAR(export_symbols_cmds, $1)="$ltdll_cmds" + ;; + cygwin* | mingw* | cegcc*) + case $cc_basename in + cl*) + _LT_TAGVAR(exclude_expsyms, $1)='_NULL_IMPORT_DESCRIPTOR|_IMPORT_DESCRIPTOR_.*' + ;; + *) + _LT_TAGVAR(export_symbols_cmds, $1)='$NM $libobjs $convenience | $global_symbol_pipe | $SED -e '\''/^[[BCDGRS]][[ ]]/s/.*[[ ]]\([[^ ]]*\)/\1 DATA/;s/^.*[[ ]]__nm__\([[^ ]]*\)[[ ]][[^ ]]*/\1 DATA/;/^I[[ ]]/d;/^[[AITW]][[ ]]/s/.* //'\'' | sort | uniq > $export_symbols' + _LT_TAGVAR(exclude_expsyms, $1)=['[_]+GLOBAL_OFFSET_TABLE_|[_]+GLOBAL__[FID]_.*|[_]+head_[A-Za-z0-9_]+_dll|[A-Za-z0-9_]+_dll_iname'] + ;; + esac + ;; + *) + _LT_TAGVAR(export_symbols_cmds, $1)='$NM $libobjs $convenience | $global_symbol_pipe | $SED '\''s/.* //'\'' | sort | uniq > $export_symbols' + ;; + esac +], [ + runpath_var= + _LT_TAGVAR(allow_undefined_flag, $1)= + _LT_TAGVAR(always_export_symbols, $1)=no + _LT_TAGVAR(archive_cmds, $1)= + _LT_TAGVAR(archive_expsym_cmds, $1)= + _LT_TAGVAR(compiler_needs_object, $1)=no + _LT_TAGVAR(enable_shared_with_static_runtimes, $1)=no + _LT_TAGVAR(export_dynamic_flag_spec, $1)= + _LT_TAGVAR(export_symbols_cmds, $1)='$NM $libobjs $convenience | $global_symbol_pipe | $SED '\''s/.* //'\'' | sort | uniq > $export_symbols' + _LT_TAGVAR(hardcode_automatic, $1)=no + _LT_TAGVAR(hardcode_direct, $1)=no + _LT_TAGVAR(hardcode_direct_absolute, $1)=no + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)= + _LT_TAGVAR(hardcode_libdir_separator, $1)= + _LT_TAGVAR(hardcode_minus_L, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=unsupported + _LT_TAGVAR(inherit_rpath, $1)=no + _LT_TAGVAR(link_all_deplibs, $1)=unknown + _LT_TAGVAR(module_cmds, $1)= + _LT_TAGVAR(module_expsym_cmds, $1)= + _LT_TAGVAR(old_archive_from_new_cmds, $1)= + _LT_TAGVAR(old_archive_from_expsyms_cmds, $1)= + _LT_TAGVAR(thread_safe_flag_spec, $1)= + _LT_TAGVAR(whole_archive_flag_spec, $1)= + # include_expsyms should be a list of space-separated symbols to be *always* + # included in the symbol list + _LT_TAGVAR(include_expsyms, $1)= + # exclude_expsyms can be an extended regexp of symbols to exclude + # it will be wrapped by ` (' and `)$', so one must not match beginning or + # end of line. Example: `a|bc|.*d.*' will exclude the symbols `a' and `bc', + # as well as any symbol that contains `d'. + _LT_TAGVAR(exclude_expsyms, $1)=['_GLOBAL_OFFSET_TABLE_|_GLOBAL__F[ID]_.*'] + # Although _GLOBAL_OFFSET_TABLE_ is a valid symbol C name, most a.out + # platforms (ab)use it in PIC code, but their linkers get confused if + # the symbol is explicitly referenced. Since portable code cannot + # rely on this symbol name, it's probably fine to never include it in + # preloaded symbol tables. + # Exclude shared library initialization/finalization symbols. +dnl Note also adjust exclude_expsyms for C++ above. + extract_expsyms_cmds= + + case $host_os in + cygwin* | mingw* | pw32* | cegcc*) + # FIXME: the MSVC++ port hasn't been tested in a loooong time + # When not using gcc, we currently assume that we are using + # Microsoft Visual C++. + if test "$GCC" != yes; then + with_gnu_ld=no + fi + ;; + interix*) + # we just hope/assume this is gcc and not c89 (= MSVC++) + with_gnu_ld=yes + ;; + openbsd*) + with_gnu_ld=no + ;; + esac + + _LT_TAGVAR(ld_shlibs, $1)=yes + + # On some targets, GNU ld is compatible enough with the native linker + # that we're better off using the native interface for both. + lt_use_gnu_ld_interface=no + if test "$with_gnu_ld" = yes; then + case $host_os in + aix*) + # The AIX port of GNU ld has always aspired to compatibility + # with the native linker. However, as the warning in the GNU ld + # block says, versions before 2.19.5* couldn't really create working + # shared libraries, regardless of the interface used. + case `$LD -v 2>&1` in + *\ \(GNU\ Binutils\)\ 2.19.5*) ;; + *\ \(GNU\ Binutils\)\ 2.[[2-9]]*) ;; + *\ \(GNU\ Binutils\)\ [[3-9]]*) ;; + *) + lt_use_gnu_ld_interface=yes + ;; + esac + ;; + *) + lt_use_gnu_ld_interface=yes + ;; + esac + fi + + if test "$lt_use_gnu_ld_interface" = yes; then + # If archive_cmds runs LD, not CC, wlarc should be empty + wlarc='${wl}' + + # Set some defaults for GNU ld with shared library support. These + # are reset later if shared libraries are not supported. Putting them + # here allows them to be overridden if necessary. + runpath_var=LD_RUN_PATH + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-dynamic' + # ancient GNU ld didn't support --whole-archive et. al. + if $LD --help 2>&1 | $GREP 'no-whole-archive' > /dev/null; then + _LT_TAGVAR(whole_archive_flag_spec, $1)="$wlarc"'--whole-archive$convenience '"$wlarc"'--no-whole-archive' + else + _LT_TAGVAR(whole_archive_flag_spec, $1)= + fi + supports_anon_versioning=no + case `$LD -v 2>&1` in + *GNU\ gold*) supports_anon_versioning=yes ;; + *\ [[01]].* | *\ 2.[[0-9]].* | *\ 2.10.*) ;; # catch versions < 2.11 + *\ 2.11.93.0.2\ *) supports_anon_versioning=yes ;; # RH7.3 ... + *\ 2.11.92.0.12\ *) supports_anon_versioning=yes ;; # Mandrake 8.2 ... + *\ 2.11.*) ;; # other 2.11 versions + *) supports_anon_versioning=yes ;; + esac + + # See if GNU ld supports shared libraries. + case $host_os in + aix[[3-9]]*) + # On AIX/PPC, the GNU linker is very broken + if test "$host_cpu" != ia64; then + _LT_TAGVAR(ld_shlibs, $1)=no + cat <<_LT_EOF 1>&2 + +*** Warning: the GNU linker, at least up to release 2.19, is reported +*** to be unable to reliably create shared libraries on AIX. +*** Therefore, libtool is disabling shared libraries support. If you +*** really care for shared libraries, you may want to install binutils +*** 2.20 or above, or modify your PATH so that a non-GNU linker is found. +*** You will then need to restart the configuration process. + +_LT_EOF + fi + ;; + + amigaos*) + case $host_cpu in + powerpc) + # see comment about AmigaOS4 .so support + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='' + ;; + m68k) + _LT_TAGVAR(archive_cmds, $1)='$RM $output_objdir/a2ixlibrary.data~$ECHO "#define NAME $libname" > $output_objdir/a2ixlibrary.data~$ECHO "#define LIBRARY_ID 1" >> $output_objdir/a2ixlibrary.data~$ECHO "#define VERSION $major" >> $output_objdir/a2ixlibrary.data~$ECHO "#define REVISION $revision" >> $output_objdir/a2ixlibrary.data~$AR $AR_FLAGS $lib $libobjs~$RANLIB $lib~(cd $output_objdir && a2ixlibrary -32)' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_minus_L, $1)=yes + ;; + esac + ;; + + beos*) + if $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + # Joseph Beckenbach says some releases of gcc + # support --undefined. This deserves some investigation. FIXME + _LT_TAGVAR(archive_cmds, $1)='$CC -nostart $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + cygwin* | mingw* | pw32* | cegcc*) + # _LT_TAGVAR(hardcode_libdir_flag_spec, $1) is actually meaningless, + # as there is no search path for DLLs. + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-all-symbols' + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + _LT_TAGVAR(always_export_symbols, $1)=no + _LT_TAGVAR(enable_shared_with_static_runtimes, $1)=yes + _LT_TAGVAR(export_symbols_cmds, $1)='$NM $libobjs $convenience | $global_symbol_pipe | $SED -e '\''/^[[BCDGRS]][[ ]]/s/.*[[ ]]\([[^ ]]*\)/\1 DATA/;s/^.*[[ ]]__nm__\([[^ ]]*\)[[ ]][[^ ]]*/\1 DATA/;/^I[[ ]]/d;/^[[AITW]][[ ]]/s/.* //'\'' | sort | uniq > $export_symbols' + _LT_TAGVAR(exclude_expsyms, $1)=['[_]+GLOBAL_OFFSET_TABLE_|[_]+GLOBAL__[FID]_.*|[_]+head_[A-Za-z0-9_]+_dll|[A-Za-z0-9_]+_dll_iname'] + + if $LD --help 2>&1 | $GREP 'auto-import' > /dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags -o $output_objdir/$soname ${wl}--enable-auto-image-base -Xlinker --out-implib -Xlinker $lib' + # If the export-symbols file already is a .def file (1st line + # is EXPORTS), use it as is; otherwise, prepend... + _LT_TAGVAR(archive_expsym_cmds, $1)='if test "x`$SED 1q $export_symbols`" = xEXPORTS; then + cp $export_symbols $output_objdir/$soname.def; + else + echo EXPORTS > $output_objdir/$soname.def; + cat $export_symbols >> $output_objdir/$soname.def; + fi~ + $CC -shared $output_objdir/$soname.def $libobjs $deplibs $compiler_flags -o $output_objdir/$soname ${wl}--enable-auto-image-base -Xlinker --out-implib -Xlinker $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + haiku*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(link_all_deplibs, $1)=yes + ;; + + interix[[3-9]]*) + _LT_TAGVAR(hardcode_direct, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + # Hack: On Interix 3.x, we cannot compile PIC because of a broken gcc. + # Instead, shared libraries are loaded at an image base (0x10000000 by + # default) and relocated if they conflict, which is a slow very memory + # consuming and fragmenting process. To avoid this, we pick a random, + # 256 KiB-aligned image base between 0x50000000 and 0x6FFC0000 at link + # time. Moving up from 0x10000000 also allows more sbrk(2) space. + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-h,$soname ${wl}--image-base,`expr ${RANDOM-$$} % 4096 / 2 \* 262144 + 1342177280` -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='sed "s,^,_," $export_symbols >$output_objdir/$soname.expsym~$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-h,$soname ${wl}--retain-symbols-file,$output_objdir/$soname.expsym ${wl}--image-base,`expr ${RANDOM-$$} % 4096 / 2 \* 262144 + 1342177280` -o $lib' + ;; + + gnu* | linux* | tpf* | k*bsd*-gnu | kopensolaris*-gnu) + tmp_diet=no + if test "$host_os" = linux-dietlibc; then + case $cc_basename in + diet\ *) tmp_diet=yes;; # linux-dietlibc with static linking (!diet-dyn) + esac + fi + if $LD --help 2>&1 | $EGREP ': supported targets:.* elf' > /dev/null \ + && test "$tmp_diet" = no + then + tmp_addflag=' $pic_flag' + tmp_sharedflag='-shared' + case $cc_basename,$host_cpu in + pgcc*) # Portland Group C compiler + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + tmp_addflag=' $pic_flag' + ;; + pgf77* | pgf90* | pgf95* | pgfortran*) + # Portland Group f77 and f90 compilers + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + tmp_addflag=' $pic_flag -Mnomain' ;; + ecc*,ia64* | icc*,ia64*) # Intel C compiler on ia64 + tmp_addflag=' -i_dynamic' ;; + efc*,ia64* | ifort*,ia64*) # Intel Fortran compiler on ia64 + tmp_addflag=' -i_dynamic -nofor_main' ;; + ifc* | ifort*) # Intel Fortran compiler + tmp_addflag=' -nofor_main' ;; + lf95*) # Lahey Fortran 8.1 + _LT_TAGVAR(whole_archive_flag_spec, $1)= + tmp_sharedflag='--shared' ;; + xl[[cC]]* | bgxl[[cC]]* | mpixl[[cC]]*) # IBM XL C 8.0 on PPC (deal with xlf below) + tmp_sharedflag='-qmkshrobj' + tmp_addflag= ;; + nvcc*) # Cuda Compiler Driver 2.2 + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + _LT_TAGVAR(compiler_needs_object, $1)=yes + ;; + esac + case `$CC -V 2>&1 | sed 5q` in + *Sun\ C*) # Sun C 5.9 + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive`new_convenience=; for conv in $convenience\"\"; do test -z \"$conv\" || new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + _LT_TAGVAR(compiler_needs_object, $1)=yes + tmp_sharedflag='-G' ;; + *Sun\ F*) # Sun Fortran 8.3 + tmp_sharedflag='-G' ;; + esac + _LT_TAGVAR(archive_cmds, $1)='$CC '"$tmp_sharedflag""$tmp_addflag"' $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + + if test "x$supports_anon_versioning" = xyes; then + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $output_objdir/$libname.ver~ + cat $export_symbols | sed -e "s/\(.*\)/\1;/" >> $output_objdir/$libname.ver~ + echo "local: *; };" >> $output_objdir/$libname.ver~ + $CC '"$tmp_sharedflag""$tmp_addflag"' $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-version-script ${wl}$output_objdir/$libname.ver -o $lib' + fi + + case $cc_basename in + xlf* | bgf* | bgxlf* | mpixlf*) + # IBM XL Fortran 10.1 on PPC cannot create shared libs itself + _LT_TAGVAR(whole_archive_flag_spec, $1)='--whole-archive$convenience --no-whole-archive' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(archive_cmds, $1)='$LD -shared $libobjs $deplibs $linker_flags -soname $soname -o $lib' + if test "x$supports_anon_versioning" = xyes; then + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $output_objdir/$libname.ver~ + cat $export_symbols | sed -e "s/\(.*\)/\1;/" >> $output_objdir/$libname.ver~ + echo "local: *; };" >> $output_objdir/$libname.ver~ + $LD -shared $libobjs $deplibs $linker_flags -soname $soname -version-script $output_objdir/$libname.ver -o $lib' + fi + ;; + esac + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + netbsd*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ >/dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$LD -Bshareable $libobjs $deplibs $linker_flags -o $lib' + wlarc= + else + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + fi + ;; + + solaris*) + if $LD -v 2>&1 | $GREP 'BFD 2\.8' > /dev/null; then + _LT_TAGVAR(ld_shlibs, $1)=no + cat <<_LT_EOF 1>&2 + +*** Warning: The releases 2.8.* of the GNU linker cannot reliably +*** create shared libraries on Solaris systems. Therefore, libtool +*** is disabling shared libraries support. We urge you to upgrade GNU +*** binutils to release 2.9.1 or newer. Another option is to modify +*** your PATH or compiler configuration so that the native linker is +*** used, and then restart. + +_LT_EOF + elif $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + sysv5* | sco3.2v5* | sco5v6* | unixware* | OpenUNIX*) + case `$LD -v 2>&1` in + *\ [[01]].* | *\ 2.[[0-9]].* | *\ 2.1[[0-5]].*) + _LT_TAGVAR(ld_shlibs, $1)=no + cat <<_LT_EOF 1>&2 + +*** Warning: Releases of the GNU linker prior to 2.16.91.0.3 can not +*** reliably create shared libraries on SCO systems. Therefore, libtool +*** is disabling shared libraries support. We urge you to upgrade GNU +*** binutils to release 2.16.91.0.3 or newer. Another option is to modify +*** your PATH or compiler configuration so that the native linker is +*** used, and then restart. + +_LT_EOF + ;; + *) + # For security reasons, it is highly recommended that you always + # use absolute paths for naming shared libraries, and exclude the + # DT_RUNPATH tag from executables and libraries. But doing so + # requires that you compile everything twice, which is a pain. + if $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + esac + ;; + + sunos4*) + _LT_TAGVAR(archive_cmds, $1)='$LD -assert pure-text -Bshareable -o $lib $libobjs $deplibs $linker_flags' + wlarc= + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + *) + if $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + esac + + if test "$_LT_TAGVAR(ld_shlibs, $1)" = no; then + runpath_var= + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)= + _LT_TAGVAR(export_dynamic_flag_spec, $1)= + _LT_TAGVAR(whole_archive_flag_spec, $1)= + fi + else + # PORTME fill in a description of your system's linker (not GNU ld) + case $host_os in + aix3*) + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + _LT_TAGVAR(always_export_symbols, $1)=yes + _LT_TAGVAR(archive_expsym_cmds, $1)='$LD -o $output_objdir/$soname $libobjs $deplibs $linker_flags -bE:$export_symbols -T512 -H512 -bM:SRE~$AR $AR_FLAGS $lib $output_objdir/$soname' + # Note: this linker hardcodes the directories in LIBPATH if there + # are no directories specified by -L. + _LT_TAGVAR(hardcode_minus_L, $1)=yes + if test "$GCC" = yes && test -z "$lt_prog_compiler_static"; then + # Neither direct hardcoding nor static linking is supported with a + # broken collect2. + _LT_TAGVAR(hardcode_direct, $1)=unsupported + fi + ;; + + aix[[4-9]]*) + if test "$host_cpu" = ia64; then + # On IA64, the linker does run time linking by default, so we don't + # have to do anything special. + aix_use_runtimelinking=no + exp_sym_flag='-Bexport' + no_entry_flag="" + else + # If we're using GNU nm, then we don't want the "-C" option. + # -C means demangle to AIX nm, but means don't demangle with GNU nm + # Also, AIX nm treats weak defined symbols like other global + # defined symbols, whereas GNU nm marks them as "W". + if $NM -V 2>&1 | $GREP 'GNU' > /dev/null; then + _LT_TAGVAR(export_symbols_cmds, $1)='$NM -Bpg $libobjs $convenience | awk '\''{ if (((\$ 2 == "T") || (\$ 2 == "D") || (\$ 2 == "B") || (\$ 2 == "W")) && ([substr](\$ 3,1,1) != ".")) { print \$ 3 } }'\'' | sort -u > $export_symbols' + else + _LT_TAGVAR(export_symbols_cmds, $1)='$NM -BCpg $libobjs $convenience | awk '\''{ if (((\$ 2 == "T") || (\$ 2 == "D") || (\$ 2 == "B")) && ([substr](\$ 3,1,1) != ".")) { print \$ 3 } }'\'' | sort -u > $export_symbols' + fi + aix_use_runtimelinking=no + + # Test if we are trying to use run time linking or normal + # AIX style linking. If -brtl is somewhere in LDFLAGS, we + # need to do runtime linking. + case $host_os in aix4.[[23]]|aix4.[[23]].*|aix[[5-9]]*) + for ld_flag in $LDFLAGS; do + if (test $ld_flag = "-brtl" || test $ld_flag = "-Wl,-brtl"); then + aix_use_runtimelinking=yes + break + fi + done + ;; + esac + + exp_sym_flag='-bexport' + no_entry_flag='-bnoentry' + fi + + # When large executables or shared objects are built, AIX ld can + # have problems creating the table of contents. If linking a library + # or program results in "error TOC overflow" add -mminimal-toc to + # CXXFLAGS/CFLAGS for g++/gcc. In the cases where that is not + # enough to fix the problem, add -Wl,-bbigtoc to LDFLAGS. + + _LT_TAGVAR(archive_cmds, $1)='' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + _LT_TAGVAR(hardcode_libdir_separator, $1)=':' + _LT_TAGVAR(link_all_deplibs, $1)=yes + _LT_TAGVAR(file_list_spec, $1)='${wl}-f,' + + if test "$GCC" = yes; then + case $host_os in aix4.[[012]]|aix4.[[012]].*) + # We only want to do this on AIX 4.2 and lower, the check + # below for broken collect2 doesn't work under 4.3+ + collect2name=`${CC} -print-prog-name=collect2` + if test -f "$collect2name" && + strings "$collect2name" | $GREP resolve_lib_name >/dev/null + then + # We have reworked collect2 + : + else + # We have old collect2 + _LT_TAGVAR(hardcode_direct, $1)=unsupported + # It fails to find uninstalled libraries when the uninstalled + # path is not listed in the libpath. Setting hardcode_minus_L + # to unsupported forces relinking + _LT_TAGVAR(hardcode_minus_L, $1)=yes + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)= + fi + ;; + esac + shared_flag='-shared' + if test "$aix_use_runtimelinking" = yes; then + shared_flag="$shared_flag "'${wl}-G' + fi + else + # not using gcc + if test "$host_cpu" = ia64; then + # VisualAge C++, Version 5.5 for AIX 5L for IA-64, Beta 3 Release + # chokes on -Wl,-G. The following line is correct: + shared_flag='-G' + else + if test "$aix_use_runtimelinking" = yes; then + shared_flag='${wl}-G' + else + shared_flag='${wl}-bM:SRE' + fi + fi + fi + + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-bexpall' + # It seems that -bexpall does not export symbols beginning with + # underscore (_), so it is better to generate a list of symbols to export. + _LT_TAGVAR(always_export_symbols, $1)=yes + if test "$aix_use_runtimelinking" = yes; then + # Warning - without using the other runtime loading flags (-brtl), + # -berok will link without error, but may produce a broken library. + _LT_TAGVAR(allow_undefined_flag, $1)='-berok' + # Determine the default libpath from the value encoded in an + # empty executable. + _LT_SYS_MODULE_PATH_AIX([$1]) + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-blibpath:$libdir:'"$aix_libpath" + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -o $output_objdir/$soname $libobjs $deplibs '"\${wl}$no_entry_flag"' $compiler_flags `if test "x${allow_undefined_flag}" != "x"; then func_echo_all "${wl}${allow_undefined_flag}"; else :; fi` '"\${wl}$exp_sym_flag:\$export_symbols $shared_flag" + else + if test "$host_cpu" = ia64; then + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-R $libdir:/usr/lib:/lib' + _LT_TAGVAR(allow_undefined_flag, $1)="-z nodefs" + _LT_TAGVAR(archive_expsym_cmds, $1)="\$CC $shared_flag"' -o $output_objdir/$soname $libobjs $deplibs '"\${wl}$no_entry_flag"' $compiler_flags ${wl}${allow_undefined_flag} '"\${wl}$exp_sym_flag:\$export_symbols" + else + # Determine the default libpath from the value encoded in an + # empty executable. + _LT_SYS_MODULE_PATH_AIX([$1]) + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-blibpath:$libdir:'"$aix_libpath" + # Warning - without using the other run time loading flags, + # -berok will link without error, but may produce a broken library. + _LT_TAGVAR(no_undefined_flag, $1)=' ${wl}-bernotok' + _LT_TAGVAR(allow_undefined_flag, $1)=' ${wl}-berok' + if test "$with_gnu_ld" = yes; then + # We only use this code for GNU lds that support --whole-archive. + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive$convenience ${wl}--no-whole-archive' + else + # Exported symbols can be pulled into shared objects from archives + _LT_TAGVAR(whole_archive_flag_spec, $1)='$convenience' + fi + _LT_TAGVAR(archive_cmds_need_lc, $1)=yes + # This is similar to how AIX traditionally builds its shared libraries. + _LT_TAGVAR(archive_expsym_cmds, $1)="\$CC $shared_flag"' -o $output_objdir/$soname $libobjs $deplibs ${wl}-bnoentry $compiler_flags ${wl}-bE:$export_symbols${allow_undefined_flag}~$AR $AR_FLAGS $output_objdir/$libname$release.a $output_objdir/$soname' + fi + fi + ;; + + amigaos*) + case $host_cpu in + powerpc) + # see comment about AmigaOS4 .so support + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='' + ;; + m68k) + _LT_TAGVAR(archive_cmds, $1)='$RM $output_objdir/a2ixlibrary.data~$ECHO "#define NAME $libname" > $output_objdir/a2ixlibrary.data~$ECHO "#define LIBRARY_ID 1" >> $output_objdir/a2ixlibrary.data~$ECHO "#define VERSION $major" >> $output_objdir/a2ixlibrary.data~$ECHO "#define REVISION $revision" >> $output_objdir/a2ixlibrary.data~$AR $AR_FLAGS $lib $libobjs~$RANLIB $lib~(cd $output_objdir && a2ixlibrary -32)' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_minus_L, $1)=yes + ;; + esac + ;; + + bsdi[[45]]*) + _LT_TAGVAR(export_dynamic_flag_spec, $1)=-rdynamic + ;; + + cygwin* | mingw* | pw32* | cegcc*) + # When not using gcc, we currently assume that we are using + # Microsoft Visual C++. + # hardcode_libdir_flag_spec is actually meaningless, as there is + # no search path for DLLs. + case $cc_basename in + cl*) + # Native MSVC + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)=' ' + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + _LT_TAGVAR(always_export_symbols, $1)=yes + _LT_TAGVAR(file_list_spec, $1)='@' + # Tell ltmain to make .lib files, not .a files. + libext=lib + # Tell ltmain to make .dll files, not .so files. + shrext_cmds=".dll" + # FIXME: Setting linknames here is a bad hack. + _LT_TAGVAR(archive_cmds, $1)='$CC -o $output_objdir/$soname $libobjs $compiler_flags $deplibs -Wl,-dll~linknames=' + _LT_TAGVAR(archive_expsym_cmds, $1)='if test "x`$SED 1q $export_symbols`" = xEXPORTS; then + sed -n -e 's/\\\\\\\(.*\\\\\\\)/-link\\\ -EXPORT:\\\\\\\1/' -e '1\\\!p' < $export_symbols > $output_objdir/$soname.exp; + else + sed -e 's/\\\\\\\(.*\\\\\\\)/-link\\\ -EXPORT:\\\\\\\1/' < $export_symbols > $output_objdir/$soname.exp; + fi~ + $CC -o $tool_output_objdir$soname $libobjs $compiler_flags $deplibs "@$tool_output_objdir$soname.exp" -Wl,-DLL,-IMPLIB:"$tool_output_objdir$libname.dll.lib"~ + linknames=' + # The linker will not automatically build a static lib if we build a DLL. + # _LT_TAGVAR(old_archive_from_new_cmds, $1)='true' + _LT_TAGVAR(enable_shared_with_static_runtimes, $1)=yes + _LT_TAGVAR(exclude_expsyms, $1)='_NULL_IMPORT_DESCRIPTOR|_IMPORT_DESCRIPTOR_.*' + _LT_TAGVAR(export_symbols_cmds, $1)='$NM $libobjs $convenience | $global_symbol_pipe | $SED -e '\''/^[[BCDGRS]][[ ]]/s/.*[[ ]]\([[^ ]]*\)/\1,DATA/'\'' | $SED -e '\''/^[[AITW]][[ ]]/s/.*[[ ]]//'\'' | sort | uniq > $export_symbols' + # Don't use ranlib + _LT_TAGVAR(old_postinstall_cmds, $1)='chmod 644 $oldlib' + _LT_TAGVAR(postlink_cmds, $1)='lt_outputfile="@OUTPUT@"~ + lt_tool_outputfile="@TOOL_OUTPUT@"~ + case $lt_outputfile in + *.exe|*.EXE) ;; + *) + lt_outputfile="$lt_outputfile.exe" + lt_tool_outputfile="$lt_tool_outputfile.exe" + ;; + esac~ + if test "$MANIFEST_TOOL" != ":" && test -f "$lt_outputfile.manifest"; then + $MANIFEST_TOOL -manifest "$lt_tool_outputfile.manifest" -outputresource:"$lt_tool_outputfile" || exit 1; + $RM "$lt_outputfile.manifest"; + fi' + ;; + *) + # Assume MSVC wrapper + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)=' ' + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + # Tell ltmain to make .lib files, not .a files. + libext=lib + # Tell ltmain to make .dll files, not .so files. + shrext_cmds=".dll" + # FIXME: Setting linknames here is a bad hack. + _LT_TAGVAR(archive_cmds, $1)='$CC -o $lib $libobjs $compiler_flags `func_echo_all "$deplibs" | $SED '\''s/ -lc$//'\''` -link -dll~linknames=' + # The linker will automatically build a .lib file if we build a DLL. + _LT_TAGVAR(old_archive_from_new_cmds, $1)='true' + # FIXME: Should let the user specify the lib program. + _LT_TAGVAR(old_archive_cmds, $1)='lib -OUT:$oldlib$oldobjs$old_deplibs' + _LT_TAGVAR(enable_shared_with_static_runtimes, $1)=yes + ;; + esac + ;; + + darwin* | rhapsody*) + _LT_DARWIN_LINKER_FEATURES($1) + ;; + + dgux*) + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + # FreeBSD 2.2.[012] allows us to include c++rt0.o to get C++ constructor + # support. Future versions do this automatically, but an explicit c++rt0.o + # does not break anything, and helps significantly (at the cost of a little + # extra space). + freebsd2.2*) + _LT_TAGVAR(archive_cmds, $1)='$LD -Bshareable -o $lib $libobjs $deplibs $linker_flags /usr/lib/c++rt0.o' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + # Unfortunately, older versions of FreeBSD 2 do not have this feature. + freebsd2.*) + _LT_TAGVAR(archive_cmds, $1)='$LD -Bshareable -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_minus_L, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + # FreeBSD 3 and greater uses gcc -shared to do shared libraries. + freebsd* | dragonfly*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + hpux9*) + if test "$GCC" = yes; then + _LT_TAGVAR(archive_cmds, $1)='$RM $output_objdir/$soname~$CC -shared $pic_flag ${wl}+b ${wl}$install_libdir -o $output_objdir/$soname $libobjs $deplibs $compiler_flags~test $output_objdir/$soname = $lib || mv $output_objdir/$soname $lib' + else + _LT_TAGVAR(archive_cmds, $1)='$RM $output_objdir/$soname~$LD -b +b $install_libdir -o $output_objdir/$soname $libobjs $deplibs $linker_flags~test $output_objdir/$soname = $lib || mv $output_objdir/$soname $lib' + fi + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}+b ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + _LT_TAGVAR(hardcode_direct, $1)=yes + + # hardcode_minus_L: Not really in the search PATH, + # but as the default location of the library. + _LT_TAGVAR(hardcode_minus_L, $1)=yes + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + ;; + + hpux10*) + if test "$GCC" = yes && test "$with_gnu_ld" = no; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $libobjs $deplibs $compiler_flags' + else + _LT_TAGVAR(archive_cmds, $1)='$LD -b +h $soname +b $install_libdir -o $lib $libobjs $deplibs $linker_flags' + fi + if test "$with_gnu_ld" = no; then + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}+b ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + # hardcode_minus_L: Not really in the search PATH, + # but as the default location of the library. + _LT_TAGVAR(hardcode_minus_L, $1)=yes + fi + ;; + + hpux11*) + if test "$GCC" = yes && test "$with_gnu_ld" = no; then + case $host_cpu in + hppa*64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared ${wl}+h ${wl}$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + ia64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag ${wl}+h ${wl}$soname ${wl}+nodefaultrpath -o $lib $libobjs $deplibs $compiler_flags' + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $libobjs $deplibs $compiler_flags' + ;; + esac + else + case $host_cpu in + hppa*64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + ia64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname ${wl}+nodefaultrpath -o $lib $libobjs $deplibs $compiler_flags' + ;; + *) + m4_if($1, [], [ + # Older versions of the 11.00 compiler do not understand -b yet + # (HP92453-01 A.11.01.20 doesn't, HP92453-01 B.11.X.35175-35176.GP does) + _LT_LINKER_OPTION([if $CC understands -b], + _LT_TAGVAR(lt_cv_prog_compiler__b, $1), [-b], + [_LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $libobjs $deplibs $compiler_flags'], + [_LT_TAGVAR(archive_cmds, $1)='$LD -b +h $soname +b $install_libdir -o $lib $libobjs $deplibs $linker_flags'])], + [_LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $libobjs $deplibs $compiler_flags']) + ;; + esac + fi + if test "$with_gnu_ld" = no; then + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}+b ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + + case $host_cpu in + hppa*64*|ia64*) + _LT_TAGVAR(hardcode_direct, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + *) + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + + # hardcode_minus_L: Not really in the search PATH, + # but as the default location of the library. + _LT_TAGVAR(hardcode_minus_L, $1)=yes + ;; + esac + fi + ;; + + irix5* | irix6* | nonstopux*) + if test "$GCC" = yes; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + # Try to use the -exported_symbol ld option, if it does not + # work, assume that -exports_file does not work either and + # implicitly export all symbols. + # This should be the same for all languages, so no per-tag cache variable. + AC_CACHE_CHECK([whether the $host_os linker accepts -exported_symbol], + [lt_cv_irix_exported_symbol], + [save_LDFLAGS="$LDFLAGS" + LDFLAGS="$LDFLAGS -shared ${wl}-exported_symbol ${wl}foo ${wl}-update_registry ${wl}/dev/null" + AC_LINK_IFELSE( + [AC_LANG_SOURCE( + [AC_LANG_CASE([C], [[int foo (void) { return 0; }]], + [C++], [[int foo (void) { return 0; }]], + [Fortran 77], [[ + subroutine foo + end]], + [Fortran], [[ + subroutine foo + end]])])], + [lt_cv_irix_exported_symbol=yes], + [lt_cv_irix_exported_symbol=no]) + LDFLAGS="$save_LDFLAGS"]) + if test "$lt_cv_irix_exported_symbol" = yes; then + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations ${wl}-exports_file ${wl}$export_symbols -o $lib' + fi + else + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -exports_file $export_symbols -o $lib' + fi + _LT_TAGVAR(archive_cmds_need_lc, $1)='no' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + _LT_TAGVAR(inherit_rpath, $1)=yes + _LT_TAGVAR(link_all_deplibs, $1)=yes + ;; + + netbsd*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ >/dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$LD -Bshareable -o $lib $libobjs $deplibs $linker_flags' # a.out + else + _LT_TAGVAR(archive_cmds, $1)='$LD -shared -o $lib $libobjs $deplibs $linker_flags' # ELF + fi + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + newsos6) + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + *nto* | *qnx*) + ;; + + openbsd*) + if test -f /usr/libexec/ld.so; then + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + if test -z "`echo __ELF__ | $CC -E - | $GREP __ELF__`" || test "$host_os-$host_cpu" = "openbsd2.8-powerpc"; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag -o $lib $libobjs $deplibs $compiler_flags ${wl}-retain-symbols-file,$export_symbols' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + else + case $host_os in + openbsd[[01]].* | openbsd2.[[0-7]] | openbsd2.[[0-7]].*) + _LT_TAGVAR(archive_cmds, $1)='$LD -Bshareable -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + ;; + esac + fi + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + os2*) + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_minus_L, $1)=yes + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + _LT_TAGVAR(archive_cmds, $1)='$ECHO "LIBRARY $libname INITINSTANCE" > $output_objdir/$libname.def~$ECHO "DESCRIPTION \"$libname\"" >> $output_objdir/$libname.def~echo DATA >> $output_objdir/$libname.def~echo " SINGLE NONSHARED" >> $output_objdir/$libname.def~echo EXPORTS >> $output_objdir/$libname.def~emxexp $libobjs >> $output_objdir/$libname.def~$CC -Zdll -Zcrtdll -o $lib $libobjs $deplibs $compiler_flags $output_objdir/$libname.def' + _LT_TAGVAR(old_archive_from_new_cmds, $1)='emximp -o $output_objdir/$libname.a $output_objdir/$libname.def' + ;; + + osf3*) + if test "$GCC" = yes; then + _LT_TAGVAR(allow_undefined_flag, $1)=' ${wl}-expect_unresolved ${wl}\*' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared${allow_undefined_flag} $libobjs $deplibs $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + else + _LT_TAGVAR(allow_undefined_flag, $1)=' -expect_unresolved \*' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared${allow_undefined_flag} $libobjs $deplibs $compiler_flags -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + fi + _LT_TAGVAR(archive_cmds_need_lc, $1)='no' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + ;; + + osf4* | osf5*) # as osf3* with the addition of -msym flag + if test "$GCC" = yes; then + _LT_TAGVAR(allow_undefined_flag, $1)=' ${wl}-expect_unresolved ${wl}\*' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared${allow_undefined_flag} $pic_flag $libobjs $deplibs $compiler_flags ${wl}-msym ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + else + _LT_TAGVAR(allow_undefined_flag, $1)=' -expect_unresolved \*' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared${allow_undefined_flag} $libobjs $deplibs $compiler_flags -msym -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='for i in `cat $export_symbols`; do printf "%s %s\\n" -exported_symbol "\$i" >> $lib.exp; done; printf "%s\\n" "-hidden">> $lib.exp~ + $CC -shared${allow_undefined_flag} ${wl}-input ${wl}$lib.exp $compiler_flags $libobjs $deplibs -soname $soname `test -n "$verstring" && $ECHO "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib~$RM $lib.exp' + + # Both c and cxx compiler support -rpath directly + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-rpath $libdir' + fi + _LT_TAGVAR(archive_cmds_need_lc, $1)='no' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + ;; + + solaris*) + _LT_TAGVAR(no_undefined_flag, $1)=' -z defs' + if test "$GCC" = yes; then + wlarc='${wl}' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag ${wl}-z ${wl}text ${wl}-h ${wl}$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -shared $pic_flag ${wl}-z ${wl}text ${wl}-M ${wl}$lib.exp ${wl}-h ${wl}$soname -o $lib $libobjs $deplibs $compiler_flags~$RM $lib.exp' + else + case `$CC -V 2>&1` in + *"Compilers 5.0"*) + wlarc='' + _LT_TAGVAR(archive_cmds, $1)='$LD -G${allow_undefined_flag} -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $LD -G${allow_undefined_flag} -M $lib.exp -h $soname -o $lib $libobjs $deplibs $linker_flags~$RM $lib.exp' + ;; + *) + wlarc='${wl}' + _LT_TAGVAR(archive_cmds, $1)='$CC -G${allow_undefined_flag} -h $soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -G${allow_undefined_flag} -M $lib.exp -h $soname -o $lib $libobjs $deplibs $compiler_flags~$RM $lib.exp' + ;; + esac + fi + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + case $host_os in + solaris2.[[0-5]] | solaris2.[[0-5]].*) ;; + *) + # The compiler driver will combine and reorder linker options, + # but understands `-z linker_flag'. GCC discards it without `$wl', + # but is careful enough not to reorder. + # Supported since Solaris 2.6 (maybe 2.5.1?) + if test "$GCC" = yes; then + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}-z ${wl}allextract$convenience ${wl}-z ${wl}defaultextract' + else + _LT_TAGVAR(whole_archive_flag_spec, $1)='-z allextract$convenience -z defaultextract' + fi + ;; + esac + _LT_TAGVAR(link_all_deplibs, $1)=yes + ;; + + sunos4*) + if test "x$host_vendor" = xsequent; then + # Use $CC to link under sequent, because it throws in some extra .o + # files that make .init and .fini sections work. + _LT_TAGVAR(archive_cmds, $1)='$CC -G ${wl}-h $soname -o $lib $libobjs $deplibs $compiler_flags' + else + _LT_TAGVAR(archive_cmds, $1)='$LD -assert pure-text -Bstatic -o $lib $libobjs $deplibs $linker_flags' + fi + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_minus_L, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + sysv4) + case $host_vendor in + sni) + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_direct, $1)=yes # is this really true??? + ;; + siemens) + ## LD is ld it makes a PLAMLIB + ## CC just makes a GrossModule. + _LT_TAGVAR(archive_cmds, $1)='$LD -G -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(reload_cmds, $1)='$CC -r -o $output$reload_objs' + _LT_TAGVAR(hardcode_direct, $1)=no + ;; + motorola) + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_direct, $1)=no #Motorola manual says yes, but my tests say they lie + ;; + esac + runpath_var='LD_RUN_PATH' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + sysv4.3*) + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(export_dynamic_flag_spec, $1)='-Bexport' + ;; + + sysv4*MP*) + if test -d /usr/nec; then + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + runpath_var=LD_RUN_PATH + hardcode_runpath_var=yes + _LT_TAGVAR(ld_shlibs, $1)=yes + fi + ;; + + sysv4*uw2* | sysv5OpenUNIX* | sysv5UnixWare7.[[01]].[[10]]* | unixware7* | sco3.2v5.0.[[024]]*) + _LT_TAGVAR(no_undefined_flag, $1)='${wl}-z,text' + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + runpath_var='LD_RUN_PATH' + + if test "$GCC" = yes; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + else + _LT_TAGVAR(archive_cmds, $1)='$CC -G ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -G ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + fi + ;; + + sysv5* | sco3.2v5* | sco5v6*) + # Note: We can NOT use -z defs as we might desire, because we do not + # link with -lc, and that would cause any symbols used from libc to + # always be unresolved, which means just about no library would + # ever link correctly. If we're not using GNU ld we use -z text + # though, which does catch some bad symbols but isn't as heavy-handed + # as -z defs. + _LT_TAGVAR(no_undefined_flag, $1)='${wl}-z,text' + _LT_TAGVAR(allow_undefined_flag, $1)='${wl}-z,nodefs' + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-R,$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=':' + _LT_TAGVAR(link_all_deplibs, $1)=yes + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-Bexport' + runpath_var='LD_RUN_PATH' + + if test "$GCC" = yes; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + else + _LT_TAGVAR(archive_cmds, $1)='$CC -G ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -G ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + fi + ;; + + uts4*) + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + *) + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + + if test x$host_vendor = xsni; then + case $host in + sysv4 | sysv4.2uw2* | sysv4.3* | sysv5*) + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-Blargedynsym' + ;; + esac + fi + fi +]) +AC_MSG_RESULT([$_LT_TAGVAR(ld_shlibs, $1)]) +test "$_LT_TAGVAR(ld_shlibs, $1)" = no && can_build_shared=no + +_LT_TAGVAR(with_gnu_ld, $1)=$with_gnu_ld + +_LT_DECL([], [libext], [0], [Old archive suffix (normally "a")])dnl +_LT_DECL([], [shrext_cmds], [1], [Shared library suffix (normally ".so")])dnl +_LT_DECL([], [extract_expsyms_cmds], [2], + [The commands to extract the exported symbol list from a shared archive]) + +# +# Do we need to explicitly link libc? +# +case "x$_LT_TAGVAR(archive_cmds_need_lc, $1)" in +x|xyes) + # Assume -lc should be added + _LT_TAGVAR(archive_cmds_need_lc, $1)=yes + + if test "$enable_shared" = yes && test "$GCC" = yes; then + case $_LT_TAGVAR(archive_cmds, $1) in + *'~'*) + # FIXME: we may have to deal with multi-command sequences. + ;; + '$CC '*) + # Test whether the compiler implicitly links with -lc since on some + # systems, -lgcc has to come before -lc. If gcc already passes -lc + # to ld, don't add -lc before -lgcc. + AC_CACHE_CHECK([whether -lc should be explicitly linked in], + [lt_cv_]_LT_TAGVAR(archive_cmds_need_lc, $1), + [$RM conftest* + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + + if AC_TRY_EVAL(ac_compile) 2>conftest.err; then + soname=conftest + lib=conftest + libobjs=conftest.$ac_objext + deplibs= + wl=$_LT_TAGVAR(lt_prog_compiler_wl, $1) + pic_flag=$_LT_TAGVAR(lt_prog_compiler_pic, $1) + compiler_flags=-v + linker_flags=-v + verstring= + output_objdir=. + libname=conftest + lt_save_allow_undefined_flag=$_LT_TAGVAR(allow_undefined_flag, $1) + _LT_TAGVAR(allow_undefined_flag, $1)= + if AC_TRY_EVAL(_LT_TAGVAR(archive_cmds, $1) 2\>\&1 \| $GREP \" -lc \" \>/dev/null 2\>\&1) + then + lt_cv_[]_LT_TAGVAR(archive_cmds_need_lc, $1)=no + else + lt_cv_[]_LT_TAGVAR(archive_cmds_need_lc, $1)=yes + fi + _LT_TAGVAR(allow_undefined_flag, $1)=$lt_save_allow_undefined_flag + else + cat conftest.err 1>&5 + fi + $RM conftest* + ]) + _LT_TAGVAR(archive_cmds_need_lc, $1)=$lt_cv_[]_LT_TAGVAR(archive_cmds_need_lc, $1) + ;; + esac + fi + ;; +esac + +_LT_TAGDECL([build_libtool_need_lc], [archive_cmds_need_lc], [0], + [Whether or not to add -lc for building shared libraries]) +_LT_TAGDECL([allow_libtool_libs_with_static_runtimes], + [enable_shared_with_static_runtimes], [0], + [Whether or not to disallow shared libs when runtime libs are static]) +_LT_TAGDECL([], [export_dynamic_flag_spec], [1], + [Compiler flag to allow reflexive dlopens]) +_LT_TAGDECL([], [whole_archive_flag_spec], [1], + [Compiler flag to generate shared objects directly from archives]) +_LT_TAGDECL([], [compiler_needs_object], [1], + [Whether the compiler copes with passing no objects directly]) +_LT_TAGDECL([], [old_archive_from_new_cmds], [2], + [Create an old-style archive from a shared archive]) +_LT_TAGDECL([], [old_archive_from_expsyms_cmds], [2], + [Create a temporary old-style archive to link instead of a shared archive]) +_LT_TAGDECL([], [archive_cmds], [2], [Commands used to build a shared archive]) +_LT_TAGDECL([], [archive_expsym_cmds], [2]) +_LT_TAGDECL([], [module_cmds], [2], + [Commands used to build a loadable module if different from building + a shared archive.]) +_LT_TAGDECL([], [module_expsym_cmds], [2]) +_LT_TAGDECL([], [with_gnu_ld], [1], + [Whether we are building with GNU ld or not]) +_LT_TAGDECL([], [allow_undefined_flag], [1], + [Flag that allows shared libraries with undefined symbols to be built]) +_LT_TAGDECL([], [no_undefined_flag], [1], + [Flag that enforces no undefined symbols]) +_LT_TAGDECL([], [hardcode_libdir_flag_spec], [1], + [Flag to hardcode $libdir into a binary during linking. + This must work even if $libdir does not exist]) +_LT_TAGDECL([], [hardcode_libdir_separator], [1], + [Whether we need a single "-rpath" flag with a separated argument]) +_LT_TAGDECL([], [hardcode_direct], [0], + [Set to "yes" if using DIR/libNAME${shared_ext} during linking hardcodes + DIR into the resulting binary]) +_LT_TAGDECL([], [hardcode_direct_absolute], [0], + [Set to "yes" if using DIR/libNAME${shared_ext} during linking hardcodes + DIR into the resulting binary and the resulting library dependency is + "absolute", i.e impossible to change by setting ${shlibpath_var} if the + library is relocated]) +_LT_TAGDECL([], [hardcode_minus_L], [0], + [Set to "yes" if using the -LDIR flag during linking hardcodes DIR + into the resulting binary]) +_LT_TAGDECL([], [hardcode_shlibpath_var], [0], + [Set to "yes" if using SHLIBPATH_VAR=DIR during linking hardcodes DIR + into the resulting binary]) +_LT_TAGDECL([], [hardcode_automatic], [0], + [Set to "yes" if building a shared library automatically hardcodes DIR + into the library and all subsequent libraries and executables linked + against it]) +_LT_TAGDECL([], [inherit_rpath], [0], + [Set to yes if linker adds runtime paths of dependent libraries + to runtime path list]) +_LT_TAGDECL([], [link_all_deplibs], [0], + [Whether libtool must link a program against all its dependency libraries]) +_LT_TAGDECL([], [always_export_symbols], [0], + [Set to "yes" if exported symbols are required]) +_LT_TAGDECL([], [export_symbols_cmds], [2], + [The commands to list exported symbols]) +_LT_TAGDECL([], [exclude_expsyms], [1], + [Symbols that should not be listed in the preloaded symbols]) +_LT_TAGDECL([], [include_expsyms], [1], + [Symbols that must always be exported]) +_LT_TAGDECL([], [prelink_cmds], [2], + [Commands necessary for linking programs (against libraries) with templates]) +_LT_TAGDECL([], [postlink_cmds], [2], + [Commands necessary for finishing linking programs]) +_LT_TAGDECL([], [file_list_spec], [1], + [Specify filename containing input files]) +dnl FIXME: Not yet implemented +dnl _LT_TAGDECL([], [thread_safe_flag_spec], [1], +dnl [Compiler flag to generate thread safe objects]) +])# _LT_LINKER_SHLIBS + + +# _LT_LANG_C_CONFIG([TAG]) +# ------------------------ +# Ensure that the configuration variables for a C compiler are suitably +# defined. These variables are subsequently used by _LT_CONFIG to write +# the compiler configuration to `libtool'. +m4_defun([_LT_LANG_C_CONFIG], +[m4_require([_LT_DECL_EGREP])dnl +lt_save_CC="$CC" +AC_LANG_PUSH(C) + +# Source file extension for C test sources. +ac_ext=c + +# Object file extension for compiled C test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# Code to be used in simple compile tests +lt_simple_compile_test_code="int some_variable = 0;" + +# Code to be used in simple link tests +lt_simple_link_test_code='int main(){return(0);}' + +_LT_TAG_COMPILER +# Save the default compiler, since it gets overwritten when the other +# tags are being tested, and _LT_TAGVAR(compiler, []) is a NOP. +compiler_DEFAULT=$CC + +# save warnings/boilerplate of simple test code +_LT_COMPILER_BOILERPLATE +_LT_LINKER_BOILERPLATE + +if test -n "$compiler"; then + _LT_COMPILER_NO_RTTI($1) + _LT_COMPILER_PIC($1) + _LT_COMPILER_C_O($1) + _LT_COMPILER_FILE_LOCKS($1) + _LT_LINKER_SHLIBS($1) + _LT_SYS_DYNAMIC_LINKER($1) + _LT_LINKER_HARDCODE_LIBPATH($1) + LT_SYS_DLOPEN_SELF + _LT_CMD_STRIPLIB + + # Report which library types will actually be built + AC_MSG_CHECKING([if libtool supports shared libraries]) + AC_MSG_RESULT([$can_build_shared]) + + AC_MSG_CHECKING([whether to build shared libraries]) + test "$can_build_shared" = "no" && enable_shared=no + + # On AIX, shared libraries and static libraries use the same namespace, and + # are all built from PIC. + case $host_os in + aix3*) + test "$enable_shared" = yes && enable_static=no + if test -n "$RANLIB"; then + archive_cmds="$archive_cmds~\$RANLIB \$lib" + postinstall_cmds='$RANLIB $lib' + fi + ;; + + aix[[4-9]]*) + if test "$host_cpu" != ia64 && test "$aix_use_runtimelinking" = no ; then + test "$enable_shared" = yes && enable_static=no + fi + ;; + esac + AC_MSG_RESULT([$enable_shared]) + + AC_MSG_CHECKING([whether to build static libraries]) + # Make sure either enable_shared or enable_static is yes. + test "$enable_shared" = yes || enable_static=yes + AC_MSG_RESULT([$enable_static]) + + _LT_CONFIG($1) +fi +AC_LANG_POP +CC="$lt_save_CC" +])# _LT_LANG_C_CONFIG + + +# _LT_LANG_CXX_CONFIG([TAG]) +# -------------------------- +# Ensure that the configuration variables for a C++ compiler are suitably +# defined. These variables are subsequently used by _LT_CONFIG to write +# the compiler configuration to `libtool'. +m4_defun([_LT_LANG_CXX_CONFIG], +[m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_DECL_EGREP])dnl +m4_require([_LT_PATH_MANIFEST_TOOL])dnl +if test -n "$CXX" && ( test "X$CXX" != "Xno" && + ( (test "X$CXX" = "Xg++" && `g++ -v >/dev/null 2>&1` ) || + (test "X$CXX" != "Xg++"))) ; then + AC_PROG_CXXCPP +else + _lt_caught_CXX_error=yes +fi + +AC_LANG_PUSH(C++) +_LT_TAGVAR(archive_cmds_need_lc, $1)=no +_LT_TAGVAR(allow_undefined_flag, $1)= +_LT_TAGVAR(always_export_symbols, $1)=no +_LT_TAGVAR(archive_expsym_cmds, $1)= +_LT_TAGVAR(compiler_needs_object, $1)=no +_LT_TAGVAR(export_dynamic_flag_spec, $1)= +_LT_TAGVAR(hardcode_direct, $1)=no +_LT_TAGVAR(hardcode_direct_absolute, $1)=no +_LT_TAGVAR(hardcode_libdir_flag_spec, $1)= +_LT_TAGVAR(hardcode_libdir_separator, $1)= +_LT_TAGVAR(hardcode_minus_L, $1)=no +_LT_TAGVAR(hardcode_shlibpath_var, $1)=unsupported +_LT_TAGVAR(hardcode_automatic, $1)=no +_LT_TAGVAR(inherit_rpath, $1)=no +_LT_TAGVAR(module_cmds, $1)= +_LT_TAGVAR(module_expsym_cmds, $1)= +_LT_TAGVAR(link_all_deplibs, $1)=unknown +_LT_TAGVAR(old_archive_cmds, $1)=$old_archive_cmds +_LT_TAGVAR(reload_flag, $1)=$reload_flag +_LT_TAGVAR(reload_cmds, $1)=$reload_cmds +_LT_TAGVAR(no_undefined_flag, $1)= +_LT_TAGVAR(whole_archive_flag_spec, $1)= +_LT_TAGVAR(enable_shared_with_static_runtimes, $1)=no + +# Source file extension for C++ test sources. +ac_ext=cpp + +# Object file extension for compiled C++ test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# No sense in running all these tests if we already determined that +# the CXX compiler isn't working. Some variables (like enable_shared) +# are currently assumed to apply to all compilers on this platform, +# and will be corrupted by setting them based on a non-working compiler. +if test "$_lt_caught_CXX_error" != yes; then + # Code to be used in simple compile tests + lt_simple_compile_test_code="int some_variable = 0;" + + # Code to be used in simple link tests + lt_simple_link_test_code='int main(int, char *[[]]) { return(0); }' + + # ltmain only uses $CC for tagged configurations so make sure $CC is set. + _LT_TAG_COMPILER + + # save warnings/boilerplate of simple test code + _LT_COMPILER_BOILERPLATE + _LT_LINKER_BOILERPLATE + + # Allow CC to be a program name with arguments. + lt_save_CC=$CC + lt_save_CFLAGS=$CFLAGS + lt_save_LD=$LD + lt_save_GCC=$GCC + GCC=$GXX + lt_save_with_gnu_ld=$with_gnu_ld + lt_save_path_LD=$lt_cv_path_LD + if test -n "${lt_cv_prog_gnu_ldcxx+set}"; then + lt_cv_prog_gnu_ld=$lt_cv_prog_gnu_ldcxx + else + $as_unset lt_cv_prog_gnu_ld + fi + if test -n "${lt_cv_path_LDCXX+set}"; then + lt_cv_path_LD=$lt_cv_path_LDCXX + else + $as_unset lt_cv_path_LD + fi + test -z "${LDCXX+set}" || LD=$LDCXX + CC=${CXX-"c++"} + CFLAGS=$CXXFLAGS + compiler=$CC + _LT_TAGVAR(compiler, $1)=$CC + _LT_CC_BASENAME([$compiler]) + + if test -n "$compiler"; then + # We don't want -fno-exception when compiling C++ code, so set the + # no_builtin_flag separately + if test "$GXX" = yes; then + _LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)=' -fno-builtin' + else + _LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)= + fi + + if test "$GXX" = yes; then + # Set up default GNU C++ configuration + + LT_PATH_LD + + # Check if GNU C++ uses GNU ld as the underlying linker, since the + # archiving commands below assume that GNU ld is being used. + if test "$with_gnu_ld" = yes; then + _LT_TAGVAR(archive_cmds, $1)='$CC $pic_flag -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC $pic_flag -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-dynamic' + + # If archive_cmds runs LD, not CC, wlarc should be empty + # XXX I think wlarc can be eliminated in ltcf-cxx, but I need to + # investigate it a little bit more. (MM) + wlarc='${wl}' + + # ancient GNU ld didn't support --whole-archive et. al. + if eval "`$CC -print-prog-name=ld` --help 2>&1" | + $GREP 'no-whole-archive' > /dev/null; then + _LT_TAGVAR(whole_archive_flag_spec, $1)="$wlarc"'--whole-archive$convenience '"$wlarc"'--no-whole-archive' + else + _LT_TAGVAR(whole_archive_flag_spec, $1)= + fi + else + with_gnu_ld=no + wlarc= + + # A generic and very simple default shared library creation + # command for GNU C++ for the case where it uses the native + # linker, instead of GNU ld. If possible, this setting should + # overridden to take advantage of the native linker features on + # the platform it is being used on. + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -o $lib' + fi + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + output_verbose_link_cmd='$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP -v "^Configured with:" | $GREP "\-L"' + + else + GXX=no + with_gnu_ld=no + wlarc= + fi + + # PORTME: fill in a description of your system's C++ link characteristics + AC_MSG_CHECKING([whether the $compiler linker ($LD) supports shared libraries]) + _LT_TAGVAR(ld_shlibs, $1)=yes + case $host_os in + aix3*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + aix[[4-9]]*) + if test "$host_cpu" = ia64; then + # On IA64, the linker does run time linking by default, so we don't + # have to do anything special. + aix_use_runtimelinking=no + exp_sym_flag='-Bexport' + no_entry_flag="" + else + aix_use_runtimelinking=no + + # Test if we are trying to use run time linking or normal + # AIX style linking. If -brtl is somewhere in LDFLAGS, we + # need to do runtime linking. + case $host_os in aix4.[[23]]|aix4.[[23]].*|aix[[5-9]]*) + for ld_flag in $LDFLAGS; do + case $ld_flag in + *-brtl*) + aix_use_runtimelinking=yes + break + ;; + esac + done + ;; + esac + + exp_sym_flag='-bexport' + no_entry_flag='-bnoentry' + fi + + # When large executables or shared objects are built, AIX ld can + # have problems creating the table of contents. If linking a library + # or program results in "error TOC overflow" add -mminimal-toc to + # CXXFLAGS/CFLAGS for g++/gcc. In the cases where that is not + # enough to fix the problem, add -Wl,-bbigtoc to LDFLAGS. + + _LT_TAGVAR(archive_cmds, $1)='' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + _LT_TAGVAR(hardcode_libdir_separator, $1)=':' + _LT_TAGVAR(link_all_deplibs, $1)=yes + _LT_TAGVAR(file_list_spec, $1)='${wl}-f,' + + if test "$GXX" = yes; then + case $host_os in aix4.[[012]]|aix4.[[012]].*) + # We only want to do this on AIX 4.2 and lower, the check + # below for broken collect2 doesn't work under 4.3+ + collect2name=`${CC} -print-prog-name=collect2` + if test -f "$collect2name" && + strings "$collect2name" | $GREP resolve_lib_name >/dev/null + then + # We have reworked collect2 + : + else + # We have old collect2 + _LT_TAGVAR(hardcode_direct, $1)=unsupported + # It fails to find uninstalled libraries when the uninstalled + # path is not listed in the libpath. Setting hardcode_minus_L + # to unsupported forces relinking + _LT_TAGVAR(hardcode_minus_L, $1)=yes + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)= + fi + esac + shared_flag='-shared' + if test "$aix_use_runtimelinking" = yes; then + shared_flag="$shared_flag "'${wl}-G' + fi + else + # not using gcc + if test "$host_cpu" = ia64; then + # VisualAge C++, Version 5.5 for AIX 5L for IA-64, Beta 3 Release + # chokes on -Wl,-G. The following line is correct: + shared_flag='-G' + else + if test "$aix_use_runtimelinking" = yes; then + shared_flag='${wl}-G' + else + shared_flag='${wl}-bM:SRE' + fi + fi + fi + + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-bexpall' + # It seems that -bexpall does not export symbols beginning with + # underscore (_), so it is better to generate a list of symbols to + # export. + _LT_TAGVAR(always_export_symbols, $1)=yes + if test "$aix_use_runtimelinking" = yes; then + # Warning - without using the other runtime loading flags (-brtl), + # -berok will link without error, but may produce a broken library. + _LT_TAGVAR(allow_undefined_flag, $1)='-berok' + # Determine the default libpath from the value encoded in an empty + # executable. + _LT_SYS_MODULE_PATH_AIX([$1]) + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-blibpath:$libdir:'"$aix_libpath" + + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -o $output_objdir/$soname $libobjs $deplibs '"\${wl}$no_entry_flag"' $compiler_flags `if test "x${allow_undefined_flag}" != "x"; then func_echo_all "${wl}${allow_undefined_flag}"; else :; fi` '"\${wl}$exp_sym_flag:\$export_symbols $shared_flag" + else + if test "$host_cpu" = ia64; then + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-R $libdir:/usr/lib:/lib' + _LT_TAGVAR(allow_undefined_flag, $1)="-z nodefs" + _LT_TAGVAR(archive_expsym_cmds, $1)="\$CC $shared_flag"' -o $output_objdir/$soname $libobjs $deplibs '"\${wl}$no_entry_flag"' $compiler_flags ${wl}${allow_undefined_flag} '"\${wl}$exp_sym_flag:\$export_symbols" + else + # Determine the default libpath from the value encoded in an + # empty executable. + _LT_SYS_MODULE_PATH_AIX([$1]) + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-blibpath:$libdir:'"$aix_libpath" + # Warning - without using the other run time loading flags, + # -berok will link without error, but may produce a broken library. + _LT_TAGVAR(no_undefined_flag, $1)=' ${wl}-bernotok' + _LT_TAGVAR(allow_undefined_flag, $1)=' ${wl}-berok' + if test "$with_gnu_ld" = yes; then + # We only use this code for GNU lds that support --whole-archive. + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive$convenience ${wl}--no-whole-archive' + else + # Exported symbols can be pulled into shared objects from archives + _LT_TAGVAR(whole_archive_flag_spec, $1)='$convenience' + fi + _LT_TAGVAR(archive_cmds_need_lc, $1)=yes + # This is similar to how AIX traditionally builds its shared + # libraries. + _LT_TAGVAR(archive_expsym_cmds, $1)="\$CC $shared_flag"' -o $output_objdir/$soname $libobjs $deplibs ${wl}-bnoentry $compiler_flags ${wl}-bE:$export_symbols${allow_undefined_flag}~$AR $AR_FLAGS $output_objdir/$libname$release.a $output_objdir/$soname' + fi + fi + ;; + + beos*) + if $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + # Joseph Beckenbach says some releases of gcc + # support --undefined. This deserves some investigation. FIXME + _LT_TAGVAR(archive_cmds, $1)='$CC -nostart $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + chorus*) + case $cc_basename in + *) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + ;; + + cygwin* | mingw* | pw32* | cegcc*) + case $GXX,$cc_basename in + ,cl* | no,cl*) + # Native MSVC + # hardcode_libdir_flag_spec is actually meaningless, as there is + # no search path for DLLs. + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)=' ' + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + _LT_TAGVAR(always_export_symbols, $1)=yes + _LT_TAGVAR(file_list_spec, $1)='@' + # Tell ltmain to make .lib files, not .a files. + libext=lib + # Tell ltmain to make .dll files, not .so files. + shrext_cmds=".dll" + # FIXME: Setting linknames here is a bad hack. + _LT_TAGVAR(archive_cmds, $1)='$CC -o $output_objdir/$soname $libobjs $compiler_flags $deplibs -Wl,-dll~linknames=' + _LT_TAGVAR(archive_expsym_cmds, $1)='if test "x`$SED 1q $export_symbols`" = xEXPORTS; then + $SED -n -e 's/\\\\\\\(.*\\\\\\\)/-link\\\ -EXPORT:\\\\\\\1/' -e '1\\\!p' < $export_symbols > $output_objdir/$soname.exp; + else + $SED -e 's/\\\\\\\(.*\\\\\\\)/-link\\\ -EXPORT:\\\\\\\1/' < $export_symbols > $output_objdir/$soname.exp; + fi~ + $CC -o $tool_output_objdir$soname $libobjs $compiler_flags $deplibs "@$tool_output_objdir$soname.exp" -Wl,-DLL,-IMPLIB:"$tool_output_objdir$libname.dll.lib"~ + linknames=' + # The linker will not automatically build a static lib if we build a DLL. + # _LT_TAGVAR(old_archive_from_new_cmds, $1)='true' + _LT_TAGVAR(enable_shared_with_static_runtimes, $1)=yes + # Don't use ranlib + _LT_TAGVAR(old_postinstall_cmds, $1)='chmod 644 $oldlib' + _LT_TAGVAR(postlink_cmds, $1)='lt_outputfile="@OUTPUT@"~ + lt_tool_outputfile="@TOOL_OUTPUT@"~ + case $lt_outputfile in + *.exe|*.EXE) ;; + *) + lt_outputfile="$lt_outputfile.exe" + lt_tool_outputfile="$lt_tool_outputfile.exe" + ;; + esac~ + func_to_tool_file "$lt_outputfile"~ + if test "$MANIFEST_TOOL" != ":" && test -f "$lt_outputfile.manifest"; then + $MANIFEST_TOOL -manifest "$lt_tool_outputfile.manifest" -outputresource:"$lt_tool_outputfile" || exit 1; + $RM "$lt_outputfile.manifest"; + fi' + ;; + *) + # g++ + # _LT_TAGVAR(hardcode_libdir_flag_spec, $1) is actually meaningless, + # as there is no search path for DLLs. + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-all-symbols' + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + _LT_TAGVAR(always_export_symbols, $1)=no + _LT_TAGVAR(enable_shared_with_static_runtimes, $1)=yes + + if $LD --help 2>&1 | $GREP 'auto-import' > /dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -o $output_objdir/$soname ${wl}--enable-auto-image-base -Xlinker --out-implib -Xlinker $lib' + # If the export-symbols file already is a .def file (1st line + # is EXPORTS), use it as is; otherwise, prepend... + _LT_TAGVAR(archive_expsym_cmds, $1)='if test "x`$SED 1q $export_symbols`" = xEXPORTS; then + cp $export_symbols $output_objdir/$soname.def; + else + echo EXPORTS > $output_objdir/$soname.def; + cat $export_symbols >> $output_objdir/$soname.def; + fi~ + $CC -shared -nostdlib $output_objdir/$soname.def $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -o $output_objdir/$soname ${wl}--enable-auto-image-base -Xlinker --out-implib -Xlinker $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + esac + ;; + darwin* | rhapsody*) + _LT_DARWIN_LINKER_FEATURES($1) + ;; + + dgux*) + case $cc_basename in + ec++*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + ghcx*) + # Green Hills C++ Compiler + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + *) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + ;; + + freebsd2.*) + # C++ shared libraries reported to be fairly broken before + # switch to ELF + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + + freebsd-elf*) + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + ;; + + freebsd* | dragonfly*) + # FreeBSD 3 and later use GNU C++ and GNU ld with standard ELF + # conventions + _LT_TAGVAR(ld_shlibs, $1)=yes + ;; + + gnu*) + ;; + + haiku*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(link_all_deplibs, $1)=yes + ;; + + hpux9*) + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}+b ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_minus_L, $1)=yes # Not in the search PATH, + # but as the default + # location of the library. + + case $cc_basename in + CC*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + aCC*) + _LT_TAGVAR(archive_cmds, $1)='$RM $output_objdir/$soname~$CC -b ${wl}+b ${wl}$install_libdir -o $output_objdir/$soname $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~test $output_objdir/$soname = $lib || mv $output_objdir/$soname $lib' + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`($CC -b $CFLAGS -v conftest.$objext 2>&1) | $EGREP "\-L"`; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "$list"' + ;; + *) + if test "$GXX" = yes; then + _LT_TAGVAR(archive_cmds, $1)='$RM $output_objdir/$soname~$CC -shared -nostdlib $pic_flag ${wl}+b ${wl}$install_libdir -o $output_objdir/$soname $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~test $output_objdir/$soname = $lib || mv $output_objdir/$soname $lib' + else + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + esac + ;; + + hpux10*|hpux11*) + if test $with_gnu_ld = no; then + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}+b ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + + case $host_cpu in + hppa*64*|ia64*) + ;; + *) + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + ;; + esac + fi + case $host_cpu in + hppa*64*|ia64*) + _LT_TAGVAR(hardcode_direct, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + *) + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + _LT_TAGVAR(hardcode_minus_L, $1)=yes # Not in the search PATH, + # but as the default + # location of the library. + ;; + esac + + case $cc_basename in + CC*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + aCC*) + case $host_cpu in + hppa*64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + ia64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname ${wl}+nodefaultrpath -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + esac + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`($CC -b $CFLAGS -v conftest.$objext 2>&1) | $GREP "\-L"`; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "$list"' + ;; + *) + if test "$GXX" = yes; then + if test $with_gnu_ld = no; then + case $host_cpu in + hppa*64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -nostdlib -fPIC ${wl}+h ${wl}$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + ia64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -nostdlib $pic_flag ${wl}+h ${wl}$soname ${wl}+nodefaultrpath -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -nostdlib $pic_flag ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + esac + fi + else + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + esac + ;; + + interix[[3-9]]*) + _LT_TAGVAR(hardcode_direct, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + # Hack: On Interix 3.x, we cannot compile PIC because of a broken gcc. + # Instead, shared libraries are loaded at an image base (0x10000000 by + # default) and relocated if they conflict, which is a slow very memory + # consuming and fragmenting process. To avoid this, we pick a random, + # 256 KiB-aligned image base between 0x50000000 and 0x6FFC0000 at link + # time. Moving up from 0x10000000 also allows more sbrk(2) space. + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-h,$soname ${wl}--image-base,`expr ${RANDOM-$$} % 4096 / 2 \* 262144 + 1342177280` -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='sed "s,^,_," $export_symbols >$output_objdir/$soname.expsym~$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-h,$soname ${wl}--retain-symbols-file,$output_objdir/$soname.expsym ${wl}--image-base,`expr ${RANDOM-$$} % 4096 / 2 \* 262144 + 1342177280` -o $lib' + ;; + irix5* | irix6*) + case $cc_basename in + CC*) + # SGI C++ + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -all -multigot $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + + # Archives containing C++ object files must be created using + # "CC -ar", where "CC" is the IRIX C++ compiler. This is + # necessary to make sure instantiated templates are included + # in the archive. + _LT_TAGVAR(old_archive_cmds, $1)='$CC -ar -WR,-u -o $oldlib $oldobjs' + ;; + *) + if test "$GXX" = yes; then + if test "$with_gnu_ld" = no; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + else + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` -o $lib' + fi + fi + _LT_TAGVAR(link_all_deplibs, $1)=yes + ;; + esac + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + _LT_TAGVAR(inherit_rpath, $1)=yes + ;; + + linux* | k*bsd*-gnu | kopensolaris*-gnu) + case $cc_basename in + KCC*) + # Kuck and Associates, Inc. (KAI) C++ Compiler + + # KCC will only create a shared library if the output file + # ends with ".so" (or ".sl" for HP-UX), so rename the library + # to its proper name (with version) after linking. + _LT_TAGVAR(archive_cmds, $1)='tempext=`echo $shared_ext | $SED -e '\''s/\([[^()0-9A-Za-z{}]]\)/\\\\\1/g'\''`; templib=`echo $lib | $SED -e "s/\${tempext}\..*/.so/"`; $CC $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags --soname $soname -o \$templib; mv \$templib $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='tempext=`echo $shared_ext | $SED -e '\''s/\([[^()0-9A-Za-z{}]]\)/\\\\\1/g'\''`; templib=`echo $lib | $SED -e "s/\${tempext}\..*/.so/"`; $CC $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags --soname $soname -o \$templib ${wl}-retain-symbols-file,$export_symbols; mv \$templib $lib' + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`$CC $CFLAGS -v conftest.$objext -o libconftest$shared_ext 2>&1 | $GREP "ld"`; rm -f libconftest$shared_ext; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "$list"' + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-dynamic' + + # Archives containing C++ object files must be created using + # "CC -Bstatic", where "CC" is the KAI C++ compiler. + _LT_TAGVAR(old_archive_cmds, $1)='$CC -Bstatic -o $oldlib $oldobjs' + ;; + icpc* | ecpc* ) + # Intel C++ + with_gnu_ld=yes + # version 8.0 and above of icpc choke on multiply defined symbols + # if we add $predep_objects and $postdep_objects, however 7.1 and + # earlier do not add the objects themselves. + case `$CC -V 2>&1` in + *"Version 7."*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + ;; + *) # Version 8.0 or newer + tmp_idyn= + case $host_cpu in + ia64*) tmp_idyn=' -i_dynamic';; + esac + _LT_TAGVAR(archive_cmds, $1)='$CC -shared'"$tmp_idyn"' $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared'"$tmp_idyn"' $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + ;; + esac + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-dynamic' + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive$convenience ${wl}--no-whole-archive' + ;; + pgCC* | pgcpp*) + # Portland Group C++ compiler + case `$CC -V` in + *pgCC\ [[1-5]].* | *pgcpp\ [[1-5]].*) + _LT_TAGVAR(prelink_cmds, $1)='tpldir=Template.dir~ + rm -rf $tpldir~ + $CC --prelink_objects --instantiation_dir $tpldir $objs $libobjs $compile_deplibs~ + compile_command="$compile_command `find $tpldir -name \*.o | sort | $NL2SP`"' + _LT_TAGVAR(old_archive_cmds, $1)='tpldir=Template.dir~ + rm -rf $tpldir~ + $CC --prelink_objects --instantiation_dir $tpldir $oldobjs$old_deplibs~ + $AR $AR_FLAGS $oldlib$oldobjs$old_deplibs `find $tpldir -name \*.o | sort | $NL2SP`~ + $RANLIB $oldlib' + _LT_TAGVAR(archive_cmds, $1)='tpldir=Template.dir~ + rm -rf $tpldir~ + $CC --prelink_objects --instantiation_dir $tpldir $predep_objects $libobjs $deplibs $convenience $postdep_objects~ + $CC -shared $pic_flag $predep_objects $libobjs $deplibs `find $tpldir -name \*.o | sort | $NL2SP` $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='tpldir=Template.dir~ + rm -rf $tpldir~ + $CC --prelink_objects --instantiation_dir $tpldir $predep_objects $libobjs $deplibs $convenience $postdep_objects~ + $CC -shared $pic_flag $predep_objects $libobjs $deplibs `find $tpldir -name \*.o | sort | $NL2SP` $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname ${wl}-retain-symbols-file ${wl}$export_symbols -o $lib' + ;; + *) # Version 6 and above use weak symbols + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname ${wl}-retain-symbols-file ${wl}$export_symbols -o $lib' + ;; + esac + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}--rpath ${wl}$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-dynamic' + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + ;; + cxx*) + # Compaq C++ + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname -o $lib ${wl}-retain-symbols-file $wl$export_symbols' + + runpath_var=LD_RUN_PATH + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-rpath $libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP "ld"`; templist=`func_echo_all "$templist" | $SED "s/\(^.*ld.*\)\( .*ld .*$\)/\1/"`; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "X$list" | $Xsed' + ;; + xl* | mpixl* | bgxl*) + # IBM XL 8.0 on PPC, with GNU ld + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-dynamic' + _LT_TAGVAR(archive_cmds, $1)='$CC -qmkshrobj $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + if test "x$supports_anon_versioning" = xyes; then + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $output_objdir/$libname.ver~ + cat $export_symbols | sed -e "s/\(.*\)/\1;/" >> $output_objdir/$libname.ver~ + echo "local: *; };" >> $output_objdir/$libname.ver~ + $CC -qmkshrobj $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-version-script ${wl}$output_objdir/$libname.ver -o $lib' + fi + ;; + *) + case `$CC -V 2>&1 | sed 5q` in + *Sun\ C*) + # Sun C++ 5.9 + _LT_TAGVAR(no_undefined_flag, $1)=' -zdefs' + _LT_TAGVAR(archive_cmds, $1)='$CC -G${allow_undefined_flag} -h$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -G${allow_undefined_flag} -h$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-retain-symbols-file ${wl}$export_symbols' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive`new_convenience=; for conv in $convenience\"\"; do test -z \"$conv\" || new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + _LT_TAGVAR(compiler_needs_object, $1)=yes + + # Not sure whether something based on + # $CC $CFLAGS -v conftest.$objext -o libconftest$shared_ext 2>&1 + # would be better. + output_verbose_link_cmd='func_echo_all' + + # Archives containing C++ object files must be created using + # "CC -xar", where "CC" is the Sun C++ compiler. This is + # necessary to make sure instantiated templates are included + # in the archive. + _LT_TAGVAR(old_archive_cmds, $1)='$CC -xar -o $oldlib $oldobjs' + ;; + esac + ;; + esac + ;; + + lynxos*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + + m88k*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + + mvs*) + case $cc_basename in + cxx*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + *) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + ;; + + netbsd*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ >/dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$LD -Bshareable -o $lib $predep_objects $libobjs $deplibs $postdep_objects $linker_flags' + wlarc= + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + fi + # Workaround some broken pre-1.5 toolchains + output_verbose_link_cmd='$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP conftest.$objext | $SED -e "s:-lgcc -lc -lgcc::"' + ;; + + *nto* | *qnx*) + _LT_TAGVAR(ld_shlibs, $1)=yes + ;; + + openbsd2*) + # C++ shared libraries are fairly broken + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + + openbsd*) + if test -f /usr/libexec/ld.so; then + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -o $lib' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + if test -z "`echo __ELF__ | $CC -E - | grep __ELF__`" || test "$host_os-$host_cpu" = "openbsd2.8-powerpc"; then + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-retain-symbols-file,$export_symbols -o $lib' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + _LT_TAGVAR(whole_archive_flag_spec, $1)="$wlarc"'--whole-archive$convenience '"$wlarc"'--no-whole-archive' + fi + output_verbose_link_cmd=func_echo_all + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + osf3* | osf4* | osf5*) + case $cc_basename in + KCC*) + # Kuck and Associates, Inc. (KAI) C++ Compiler + + # KCC will only create a shared library if the output file + # ends with ".so" (or ".sl" for HP-UX), so rename the library + # to its proper name (with version) after linking. + _LT_TAGVAR(archive_cmds, $1)='tempext=`echo $shared_ext | $SED -e '\''s/\([[^()0-9A-Za-z{}]]\)/\\\\\1/g'\''`; templib=`echo "$lib" | $SED -e "s/\${tempext}\..*/.so/"`; $CC $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags --soname $soname -o \$templib; mv \$templib $lib' + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + + # Archives containing C++ object files must be created using + # the KAI C++ compiler. + case $host in + osf3*) _LT_TAGVAR(old_archive_cmds, $1)='$CC -Bstatic -o $oldlib $oldobjs' ;; + *) _LT_TAGVAR(old_archive_cmds, $1)='$CC -o $oldlib $oldobjs' ;; + esac + ;; + RCC*) + # Rational C++ 2.4.1 + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + cxx*) + case $host in + osf3*) + _LT_TAGVAR(allow_undefined_flag, $1)=' ${wl}-expect_unresolved ${wl}\*' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared${allow_undefined_flag} $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $soname `test -n "$verstring" && func_echo_all "${wl}-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + ;; + *) + _LT_TAGVAR(allow_undefined_flag, $1)=' -expect_unresolved \*' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared${allow_undefined_flag} $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -msym -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='for i in `cat $export_symbols`; do printf "%s %s\\n" -exported_symbol "\$i" >> $lib.exp; done~ + echo "-hidden">> $lib.exp~ + $CC -shared$allow_undefined_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -msym -soname $soname ${wl}-input ${wl}$lib.exp `test -n "$verstring" && $ECHO "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib~ + $RM $lib.exp' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-rpath $libdir' + ;; + esac + + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP "ld" | $GREP -v "ld:"`; templist=`func_echo_all "$templist" | $SED "s/\(^.*ld.*\)\( .*ld.*$\)/\1/"`; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "$list"' + ;; + *) + if test "$GXX" = yes && test "$with_gnu_ld" = no; then + _LT_TAGVAR(allow_undefined_flag, $1)=' ${wl}-expect_unresolved ${wl}\*' + case $host in + osf3*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -nostdlib ${allow_undefined_flag} $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -nostdlib ${allow_undefined_flag} $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-msym ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + ;; + esac + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + output_verbose_link_cmd='$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP -v "^Configured with:" | $GREP "\-L"' + + else + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + esac + ;; + + psos*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + + sunos4*) + case $cc_basename in + CC*) + # Sun C++ 4.x + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + lcc*) + # Lucid + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + *) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + ;; + + solaris*) + case $cc_basename in + CC* | sunCC*) + # Sun C++ 4.2, 5.x and Centerline C++ + _LT_TAGVAR(archive_cmds_need_lc,$1)=yes + _LT_TAGVAR(no_undefined_flag, $1)=' -zdefs' + _LT_TAGVAR(archive_cmds, $1)='$CC -G${allow_undefined_flag} -h$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -G${allow_undefined_flag} ${wl}-M ${wl}$lib.exp -h$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~$RM $lib.exp' + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + case $host_os in + solaris2.[[0-5]] | solaris2.[[0-5]].*) ;; + *) + # The compiler driver will combine and reorder linker options, + # but understands `-z linker_flag'. + # Supported since Solaris 2.6 (maybe 2.5.1?) + _LT_TAGVAR(whole_archive_flag_spec, $1)='-z allextract$convenience -z defaultextract' + ;; + esac + _LT_TAGVAR(link_all_deplibs, $1)=yes + + output_verbose_link_cmd='func_echo_all' + + # Archives containing C++ object files must be created using + # "CC -xar", where "CC" is the Sun C++ compiler. This is + # necessary to make sure instantiated templates are included + # in the archive. + _LT_TAGVAR(old_archive_cmds, $1)='$CC -xar -o $oldlib $oldobjs' + ;; + gcx*) + # Green Hills C++ Compiler + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-h $wl$soname -o $lib' + + # The C++ compiler must be used to create the archive. + _LT_TAGVAR(old_archive_cmds, $1)='$CC $LDFLAGS -archive -o $oldlib $oldobjs' + ;; + *) + # GNU C++ compiler with Solaris linker + if test "$GXX" = yes && test "$with_gnu_ld" = no; then + _LT_TAGVAR(no_undefined_flag, $1)=' ${wl}-z ${wl}defs' + if $CC --version | $GREP -v '^2\.7' > /dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -nostdlib $LDFLAGS $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-h $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -shared $pic_flag -nostdlib ${wl}-M $wl$lib.exp -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~$RM $lib.exp' + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + output_verbose_link_cmd='$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP -v "^Configured with:" | $GREP "\-L"' + else + # g++ 2.7 appears to require `-G' NOT `-shared' on this + # platform. + _LT_TAGVAR(archive_cmds, $1)='$CC -G -nostdlib $LDFLAGS $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-h $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -G -nostdlib ${wl}-M $wl$lib.exp -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~$RM $lib.exp' + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + output_verbose_link_cmd='$CC -G $CFLAGS -v conftest.$objext 2>&1 | $GREP -v "^Configured with:" | $GREP "\-L"' + fi + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-R $wl$libdir' + case $host_os in + solaris2.[[0-5]] | solaris2.[[0-5]].*) ;; + *) + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}-z ${wl}allextract$convenience ${wl}-z ${wl}defaultextract' + ;; + esac + fi + ;; + esac + ;; + + sysv4*uw2* | sysv5OpenUNIX* | sysv5UnixWare7.[[01]].[[10]]* | unixware7* | sco3.2v5.0.[[024]]*) + _LT_TAGVAR(no_undefined_flag, $1)='${wl}-z,text' + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + runpath_var='LD_RUN_PATH' + + case $cc_basename in + CC*) + _LT_TAGVAR(archive_cmds, $1)='$CC -G ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -G ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + esac + ;; + + sysv5* | sco3.2v5* | sco5v6*) + # Note: We can NOT use -z defs as we might desire, because we do not + # link with -lc, and that would cause any symbols used from libc to + # always be unresolved, which means just about no library would + # ever link correctly. If we're not using GNU ld we use -z text + # though, which does catch some bad symbols but isn't as heavy-handed + # as -z defs. + _LT_TAGVAR(no_undefined_flag, $1)='${wl}-z,text' + _LT_TAGVAR(allow_undefined_flag, $1)='${wl}-z,nodefs' + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-R,$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=':' + _LT_TAGVAR(link_all_deplibs, $1)=yes + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-Bexport' + runpath_var='LD_RUN_PATH' + + case $cc_basename in + CC*) + _LT_TAGVAR(archive_cmds, $1)='$CC -G ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -G ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(old_archive_cmds, $1)='$CC -Tprelink_objects $oldobjs~ + '"$_LT_TAGVAR(old_archive_cmds, $1)" + _LT_TAGVAR(reload_cmds, $1)='$CC -Tprelink_objects $reload_objs~ + '"$_LT_TAGVAR(reload_cmds, $1)" + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + esac + ;; + + tandem*) + case $cc_basename in + NCC*) + # NonStop-UX NCC 3.20 + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + *) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + ;; + + vxworks*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + + *) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + + AC_MSG_RESULT([$_LT_TAGVAR(ld_shlibs, $1)]) + test "$_LT_TAGVAR(ld_shlibs, $1)" = no && can_build_shared=no + + _LT_TAGVAR(GCC, $1)="$GXX" + _LT_TAGVAR(LD, $1)="$LD" + + ## CAVEAT EMPTOR: + ## There is no encapsulation within the following macros, do not change + ## the running order or otherwise move them around unless you know exactly + ## what you are doing... + _LT_SYS_HIDDEN_LIBDEPS($1) + _LT_COMPILER_PIC($1) + _LT_COMPILER_C_O($1) + _LT_COMPILER_FILE_LOCKS($1) + _LT_LINKER_SHLIBS($1) + _LT_SYS_DYNAMIC_LINKER($1) + _LT_LINKER_HARDCODE_LIBPATH($1) + + _LT_CONFIG($1) + fi # test -n "$compiler" + + CC=$lt_save_CC + CFLAGS=$lt_save_CFLAGS + LDCXX=$LD + LD=$lt_save_LD + GCC=$lt_save_GCC + with_gnu_ld=$lt_save_with_gnu_ld + lt_cv_path_LDCXX=$lt_cv_path_LD + lt_cv_path_LD=$lt_save_path_LD + lt_cv_prog_gnu_ldcxx=$lt_cv_prog_gnu_ld + lt_cv_prog_gnu_ld=$lt_save_with_gnu_ld +fi # test "$_lt_caught_CXX_error" != yes + +AC_LANG_POP +])# _LT_LANG_CXX_CONFIG + + +# _LT_FUNC_STRIPNAME_CNF +# ---------------------- +# func_stripname_cnf prefix suffix name +# strip PREFIX and SUFFIX off of NAME. +# PREFIX and SUFFIX must not contain globbing or regex special +# characters, hashes, percent signs, but SUFFIX may contain a leading +# dot (in which case that matches only a dot). +# +# This function is identical to the (non-XSI) version of func_stripname, +# except this one can be used by m4 code that may be executed by configure, +# rather than the libtool script. +m4_defun([_LT_FUNC_STRIPNAME_CNF],[dnl +AC_REQUIRE([_LT_DECL_SED]) +AC_REQUIRE([_LT_PROG_ECHO_BACKSLASH]) +func_stripname_cnf () +{ + case ${2} in + .*) func_stripname_result=`$ECHO "${3}" | $SED "s%^${1}%%; s%\\\\${2}\$%%"`;; + *) func_stripname_result=`$ECHO "${3}" | $SED "s%^${1}%%; s%${2}\$%%"`;; + esac +} # func_stripname_cnf +])# _LT_FUNC_STRIPNAME_CNF + +# _LT_SYS_HIDDEN_LIBDEPS([TAGNAME]) +# --------------------------------- +# Figure out "hidden" library dependencies from verbose +# compiler output when linking a shared library. +# Parse the compiler output and extract the necessary +# objects, libraries and library flags. +m4_defun([_LT_SYS_HIDDEN_LIBDEPS], +[m4_require([_LT_FILEUTILS_DEFAULTS])dnl +AC_REQUIRE([_LT_FUNC_STRIPNAME_CNF])dnl +# Dependencies to place before and after the object being linked: +_LT_TAGVAR(predep_objects, $1)= +_LT_TAGVAR(postdep_objects, $1)= +_LT_TAGVAR(predeps, $1)= +_LT_TAGVAR(postdeps, $1)= +_LT_TAGVAR(compiler_lib_search_path, $1)= + +dnl we can't use the lt_simple_compile_test_code here, +dnl because it contains code intended for an executable, +dnl not a library. It's possible we should let each +dnl tag define a new lt_????_link_test_code variable, +dnl but it's only used here... +m4_if([$1], [], [cat > conftest.$ac_ext <<_LT_EOF +int a; +void foo (void) { a = 0; } +_LT_EOF +], [$1], [CXX], [cat > conftest.$ac_ext <<_LT_EOF +class Foo +{ +public: + Foo (void) { a = 0; } +private: + int a; +}; +_LT_EOF +], [$1], [F77], [cat > conftest.$ac_ext <<_LT_EOF + subroutine foo + implicit none + integer*4 a + a=0 + return + end +_LT_EOF +], [$1], [FC], [cat > conftest.$ac_ext <<_LT_EOF + subroutine foo + implicit none + integer a + a=0 + return + end +_LT_EOF +], [$1], [GCJ], [cat > conftest.$ac_ext <<_LT_EOF +public class foo { + private int a; + public void bar (void) { + a = 0; + } +}; +_LT_EOF +], [$1], [GO], [cat > conftest.$ac_ext <<_LT_EOF +package foo +func foo() { +} +_LT_EOF +]) + +_lt_libdeps_save_CFLAGS=$CFLAGS +case "$CC $CFLAGS " in #( +*\ -flto*\ *) CFLAGS="$CFLAGS -fno-lto" ;; +*\ -fwhopr*\ *) CFLAGS="$CFLAGS -fno-whopr" ;; +*\ -fuse-linker-plugin*\ *) CFLAGS="$CFLAGS -fno-use-linker-plugin" ;; +esac + +dnl Parse the compiler output and extract the necessary +dnl objects, libraries and library flags. +if AC_TRY_EVAL(ac_compile); then + # Parse the compiler output and extract the necessary + # objects, libraries and library flags. + + # Sentinel used to keep track of whether or not we are before + # the conftest object file. + pre_test_object_deps_done=no + + for p in `eval "$output_verbose_link_cmd"`; do + case ${prev}${p} in + + -L* | -R* | -l*) + # Some compilers place space between "-{L,R}" and the path. + # Remove the space. + if test $p = "-L" || + test $p = "-R"; then + prev=$p + continue + fi + + # Expand the sysroot to ease extracting the directories later. + if test -z "$prev"; then + case $p in + -L*) func_stripname_cnf '-L' '' "$p"; prev=-L; p=$func_stripname_result ;; + -R*) func_stripname_cnf '-R' '' "$p"; prev=-R; p=$func_stripname_result ;; + -l*) func_stripname_cnf '-l' '' "$p"; prev=-l; p=$func_stripname_result ;; + esac + fi + case $p in + =*) func_stripname_cnf '=' '' "$p"; p=$lt_sysroot$func_stripname_result ;; + esac + if test "$pre_test_object_deps_done" = no; then + case ${prev} in + -L | -R) + # Internal compiler library paths should come after those + # provided the user. The postdeps already come after the + # user supplied libs so there is no need to process them. + if test -z "$_LT_TAGVAR(compiler_lib_search_path, $1)"; then + _LT_TAGVAR(compiler_lib_search_path, $1)="${prev}${p}" + else + _LT_TAGVAR(compiler_lib_search_path, $1)="${_LT_TAGVAR(compiler_lib_search_path, $1)} ${prev}${p}" + fi + ;; + # The "-l" case would never come before the object being + # linked, so don't bother handling this case. + esac + else + if test -z "$_LT_TAGVAR(postdeps, $1)"; then + _LT_TAGVAR(postdeps, $1)="${prev}${p}" + else + _LT_TAGVAR(postdeps, $1)="${_LT_TAGVAR(postdeps, $1)} ${prev}${p}" + fi + fi + prev= + ;; + + *.lto.$objext) ;; # Ignore GCC LTO objects + *.$objext) + # This assumes that the test object file only shows up + # once in the compiler output. + if test "$p" = "conftest.$objext"; then + pre_test_object_deps_done=yes + continue + fi + + if test "$pre_test_object_deps_done" = no; then + if test -z "$_LT_TAGVAR(predep_objects, $1)"; then + _LT_TAGVAR(predep_objects, $1)="$p" + else + _LT_TAGVAR(predep_objects, $1)="$_LT_TAGVAR(predep_objects, $1) $p" + fi + else + if test -z "$_LT_TAGVAR(postdep_objects, $1)"; then + _LT_TAGVAR(postdep_objects, $1)="$p" + else + _LT_TAGVAR(postdep_objects, $1)="$_LT_TAGVAR(postdep_objects, $1) $p" + fi + fi + ;; + + *) ;; # Ignore the rest. + + esac + done + + # Clean up. + rm -f a.out a.exe +else + echo "libtool.m4: error: problem compiling $1 test program" +fi + +$RM -f confest.$objext +CFLAGS=$_lt_libdeps_save_CFLAGS + +# PORTME: override above test on systems where it is broken +m4_if([$1], [CXX], +[case $host_os in +interix[[3-9]]*) + # Interix 3.5 installs completely hosed .la files for C++, so rather than + # hack all around it, let's just trust "g++" to DTRT. + _LT_TAGVAR(predep_objects,$1)= + _LT_TAGVAR(postdep_objects,$1)= + _LT_TAGVAR(postdeps,$1)= + ;; + +linux*) + case `$CC -V 2>&1 | sed 5q` in + *Sun\ C*) + # Sun C++ 5.9 + + # The more standards-conforming stlport4 library is + # incompatible with the Cstd library. Avoid specifying + # it if it's in CXXFLAGS. Ignore libCrun as + # -library=stlport4 depends on it. + case " $CXX $CXXFLAGS " in + *" -library=stlport4 "*) + solaris_use_stlport4=yes + ;; + esac + + if test "$solaris_use_stlport4" != yes; then + _LT_TAGVAR(postdeps,$1)='-library=Cstd -library=Crun' + fi + ;; + esac + ;; + +solaris*) + case $cc_basename in + CC* | sunCC*) + # The more standards-conforming stlport4 library is + # incompatible with the Cstd library. Avoid specifying + # it if it's in CXXFLAGS. Ignore libCrun as + # -library=stlport4 depends on it. + case " $CXX $CXXFLAGS " in + *" -library=stlport4 "*) + solaris_use_stlport4=yes + ;; + esac + + # Adding this requires a known-good setup of shared libraries for + # Sun compiler versions before 5.6, else PIC objects from an old + # archive will be linked into the output, leading to subtle bugs. + if test "$solaris_use_stlport4" != yes; then + _LT_TAGVAR(postdeps,$1)='-library=Cstd -library=Crun' + fi + ;; + esac + ;; +esac +]) + +case " $_LT_TAGVAR(postdeps, $1) " in +*" -lc "*) _LT_TAGVAR(archive_cmds_need_lc, $1)=no ;; +esac + _LT_TAGVAR(compiler_lib_search_dirs, $1)= +if test -n "${_LT_TAGVAR(compiler_lib_search_path, $1)}"; then + _LT_TAGVAR(compiler_lib_search_dirs, $1)=`echo " ${_LT_TAGVAR(compiler_lib_search_path, $1)}" | ${SED} -e 's! -L! !g' -e 's!^ !!'` +fi +_LT_TAGDECL([], [compiler_lib_search_dirs], [1], + [The directories searched by this compiler when creating a shared library]) +_LT_TAGDECL([], [predep_objects], [1], + [Dependencies to place before and after the objects being linked to + create a shared library]) +_LT_TAGDECL([], [postdep_objects], [1]) +_LT_TAGDECL([], [predeps], [1]) +_LT_TAGDECL([], [postdeps], [1]) +_LT_TAGDECL([], [compiler_lib_search_path], [1], + [The library search path used internally by the compiler when linking + a shared library]) +])# _LT_SYS_HIDDEN_LIBDEPS + + +# _LT_LANG_F77_CONFIG([TAG]) +# -------------------------- +# Ensure that the configuration variables for a Fortran 77 compiler are +# suitably defined. These variables are subsequently used by _LT_CONFIG +# to write the compiler configuration to `libtool'. +m4_defun([_LT_LANG_F77_CONFIG], +[AC_LANG_PUSH(Fortran 77) +if test -z "$F77" || test "X$F77" = "Xno"; then + _lt_disable_F77=yes +fi + +_LT_TAGVAR(archive_cmds_need_lc, $1)=no +_LT_TAGVAR(allow_undefined_flag, $1)= +_LT_TAGVAR(always_export_symbols, $1)=no +_LT_TAGVAR(archive_expsym_cmds, $1)= +_LT_TAGVAR(export_dynamic_flag_spec, $1)= +_LT_TAGVAR(hardcode_direct, $1)=no +_LT_TAGVAR(hardcode_direct_absolute, $1)=no +_LT_TAGVAR(hardcode_libdir_flag_spec, $1)= +_LT_TAGVAR(hardcode_libdir_separator, $1)= +_LT_TAGVAR(hardcode_minus_L, $1)=no +_LT_TAGVAR(hardcode_automatic, $1)=no +_LT_TAGVAR(inherit_rpath, $1)=no +_LT_TAGVAR(module_cmds, $1)= +_LT_TAGVAR(module_expsym_cmds, $1)= +_LT_TAGVAR(link_all_deplibs, $1)=unknown +_LT_TAGVAR(old_archive_cmds, $1)=$old_archive_cmds +_LT_TAGVAR(reload_flag, $1)=$reload_flag +_LT_TAGVAR(reload_cmds, $1)=$reload_cmds +_LT_TAGVAR(no_undefined_flag, $1)= +_LT_TAGVAR(whole_archive_flag_spec, $1)= +_LT_TAGVAR(enable_shared_with_static_runtimes, $1)=no + +# Source file extension for f77 test sources. +ac_ext=f + +# Object file extension for compiled f77 test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# No sense in running all these tests if we already determined that +# the F77 compiler isn't working. Some variables (like enable_shared) +# are currently assumed to apply to all compilers on this platform, +# and will be corrupted by setting them based on a non-working compiler. +if test "$_lt_disable_F77" != yes; then + # Code to be used in simple compile tests + lt_simple_compile_test_code="\ + subroutine t + return + end +" + + # Code to be used in simple link tests + lt_simple_link_test_code="\ + program t + end +" + + # ltmain only uses $CC for tagged configurations so make sure $CC is set. + _LT_TAG_COMPILER + + # save warnings/boilerplate of simple test code + _LT_COMPILER_BOILERPLATE + _LT_LINKER_BOILERPLATE + + # Allow CC to be a program name with arguments. + lt_save_CC="$CC" + lt_save_GCC=$GCC + lt_save_CFLAGS=$CFLAGS + CC=${F77-"f77"} + CFLAGS=$FFLAGS + compiler=$CC + _LT_TAGVAR(compiler, $1)=$CC + _LT_CC_BASENAME([$compiler]) + GCC=$G77 + if test -n "$compiler"; then + AC_MSG_CHECKING([if libtool supports shared libraries]) + AC_MSG_RESULT([$can_build_shared]) + + AC_MSG_CHECKING([whether to build shared libraries]) + test "$can_build_shared" = "no" && enable_shared=no + + # On AIX, shared libraries and static libraries use the same namespace, and + # are all built from PIC. + case $host_os in + aix3*) + test "$enable_shared" = yes && enable_static=no + if test -n "$RANLIB"; then + archive_cmds="$archive_cmds~\$RANLIB \$lib" + postinstall_cmds='$RANLIB $lib' + fi + ;; + aix[[4-9]]*) + if test "$host_cpu" != ia64 && test "$aix_use_runtimelinking" = no ; then + test "$enable_shared" = yes && enable_static=no + fi + ;; + esac + AC_MSG_RESULT([$enable_shared]) + + AC_MSG_CHECKING([whether to build static libraries]) + # Make sure either enable_shared or enable_static is yes. + test "$enable_shared" = yes || enable_static=yes + AC_MSG_RESULT([$enable_static]) + + _LT_TAGVAR(GCC, $1)="$G77" + _LT_TAGVAR(LD, $1)="$LD" + + ## CAVEAT EMPTOR: + ## There is no encapsulation within the following macros, do not change + ## the running order or otherwise move them around unless you know exactly + ## what you are doing... + _LT_COMPILER_PIC($1) + _LT_COMPILER_C_O($1) + _LT_COMPILER_FILE_LOCKS($1) + _LT_LINKER_SHLIBS($1) + _LT_SYS_DYNAMIC_LINKER($1) + _LT_LINKER_HARDCODE_LIBPATH($1) + + _LT_CONFIG($1) + fi # test -n "$compiler" + + GCC=$lt_save_GCC + CC="$lt_save_CC" + CFLAGS="$lt_save_CFLAGS" +fi # test "$_lt_disable_F77" != yes + +AC_LANG_POP +])# _LT_LANG_F77_CONFIG + + +# _LT_LANG_FC_CONFIG([TAG]) +# ------------------------- +# Ensure that the configuration variables for a Fortran compiler are +# suitably defined. These variables are subsequently used by _LT_CONFIG +# to write the compiler configuration to `libtool'. +m4_defun([_LT_LANG_FC_CONFIG], +[AC_LANG_PUSH(Fortran) + +if test -z "$FC" || test "X$FC" = "Xno"; then + _lt_disable_FC=yes +fi + +_LT_TAGVAR(archive_cmds_need_lc, $1)=no +_LT_TAGVAR(allow_undefined_flag, $1)= +_LT_TAGVAR(always_export_symbols, $1)=no +_LT_TAGVAR(archive_expsym_cmds, $1)= +_LT_TAGVAR(export_dynamic_flag_spec, $1)= +_LT_TAGVAR(hardcode_direct, $1)=no +_LT_TAGVAR(hardcode_direct_absolute, $1)=no +_LT_TAGVAR(hardcode_libdir_flag_spec, $1)= +_LT_TAGVAR(hardcode_libdir_separator, $1)= +_LT_TAGVAR(hardcode_minus_L, $1)=no +_LT_TAGVAR(hardcode_automatic, $1)=no +_LT_TAGVAR(inherit_rpath, $1)=no +_LT_TAGVAR(module_cmds, $1)= +_LT_TAGVAR(module_expsym_cmds, $1)= +_LT_TAGVAR(link_all_deplibs, $1)=unknown +_LT_TAGVAR(old_archive_cmds, $1)=$old_archive_cmds +_LT_TAGVAR(reload_flag, $1)=$reload_flag +_LT_TAGVAR(reload_cmds, $1)=$reload_cmds +_LT_TAGVAR(no_undefined_flag, $1)= +_LT_TAGVAR(whole_archive_flag_spec, $1)= +_LT_TAGVAR(enable_shared_with_static_runtimes, $1)=no + +# Source file extension for fc test sources. +ac_ext=${ac_fc_srcext-f} + +# Object file extension for compiled fc test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# No sense in running all these tests if we already determined that +# the FC compiler isn't working. Some variables (like enable_shared) +# are currently assumed to apply to all compilers on this platform, +# and will be corrupted by setting them based on a non-working compiler. +if test "$_lt_disable_FC" != yes; then + # Code to be used in simple compile tests + lt_simple_compile_test_code="\ + subroutine t + return + end +" + + # Code to be used in simple link tests + lt_simple_link_test_code="\ + program t + end +" + + # ltmain only uses $CC for tagged configurations so make sure $CC is set. + _LT_TAG_COMPILER + + # save warnings/boilerplate of simple test code + _LT_COMPILER_BOILERPLATE + _LT_LINKER_BOILERPLATE + + # Allow CC to be a program name with arguments. + lt_save_CC="$CC" + lt_save_GCC=$GCC + lt_save_CFLAGS=$CFLAGS + CC=${FC-"f95"} + CFLAGS=$FCFLAGS + compiler=$CC + GCC=$ac_cv_fc_compiler_gnu + + _LT_TAGVAR(compiler, $1)=$CC + _LT_CC_BASENAME([$compiler]) + + if test -n "$compiler"; then + AC_MSG_CHECKING([if libtool supports shared libraries]) + AC_MSG_RESULT([$can_build_shared]) + + AC_MSG_CHECKING([whether to build shared libraries]) + test "$can_build_shared" = "no" && enable_shared=no + + # On AIX, shared libraries and static libraries use the same namespace, and + # are all built from PIC. + case $host_os in + aix3*) + test "$enable_shared" = yes && enable_static=no + if test -n "$RANLIB"; then + archive_cmds="$archive_cmds~\$RANLIB \$lib" + postinstall_cmds='$RANLIB $lib' + fi + ;; + aix[[4-9]]*) + if test "$host_cpu" != ia64 && test "$aix_use_runtimelinking" = no ; then + test "$enable_shared" = yes && enable_static=no + fi + ;; + esac + AC_MSG_RESULT([$enable_shared]) + + AC_MSG_CHECKING([whether to build static libraries]) + # Make sure either enable_shared or enable_static is yes. + test "$enable_shared" = yes || enable_static=yes + AC_MSG_RESULT([$enable_static]) + + _LT_TAGVAR(GCC, $1)="$ac_cv_fc_compiler_gnu" + _LT_TAGVAR(LD, $1)="$LD" + + ## CAVEAT EMPTOR: + ## There is no encapsulation within the following macros, do not change + ## the running order or otherwise move them around unless you know exactly + ## what you are doing... + _LT_SYS_HIDDEN_LIBDEPS($1) + _LT_COMPILER_PIC($1) + _LT_COMPILER_C_O($1) + _LT_COMPILER_FILE_LOCKS($1) + _LT_LINKER_SHLIBS($1) + _LT_SYS_DYNAMIC_LINKER($1) + _LT_LINKER_HARDCODE_LIBPATH($1) + + _LT_CONFIG($1) + fi # test -n "$compiler" + + GCC=$lt_save_GCC + CC=$lt_save_CC + CFLAGS=$lt_save_CFLAGS +fi # test "$_lt_disable_FC" != yes + +AC_LANG_POP +])# _LT_LANG_FC_CONFIG + + +# _LT_LANG_GCJ_CONFIG([TAG]) +# -------------------------- +# Ensure that the configuration variables for the GNU Java Compiler compiler +# are suitably defined. These variables are subsequently used by _LT_CONFIG +# to write the compiler configuration to `libtool'. +m4_defun([_LT_LANG_GCJ_CONFIG], +[AC_REQUIRE([LT_PROG_GCJ])dnl +AC_LANG_SAVE + +# Source file extension for Java test sources. +ac_ext=java + +# Object file extension for compiled Java test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# Code to be used in simple compile tests +lt_simple_compile_test_code="class foo {}" + +# Code to be used in simple link tests +lt_simple_link_test_code='public class conftest { public static void main(String[[]] argv) {}; }' + +# ltmain only uses $CC for tagged configurations so make sure $CC is set. +_LT_TAG_COMPILER + +# save warnings/boilerplate of simple test code +_LT_COMPILER_BOILERPLATE +_LT_LINKER_BOILERPLATE + +# Allow CC to be a program name with arguments. +lt_save_CC=$CC +lt_save_CFLAGS=$CFLAGS +lt_save_GCC=$GCC +GCC=yes +CC=${GCJ-"gcj"} +CFLAGS=$GCJFLAGS +compiler=$CC +_LT_TAGVAR(compiler, $1)=$CC +_LT_TAGVAR(LD, $1)="$LD" +_LT_CC_BASENAME([$compiler]) + +# GCJ did not exist at the time GCC didn't implicitly link libc in. +_LT_TAGVAR(archive_cmds_need_lc, $1)=no + +_LT_TAGVAR(old_archive_cmds, $1)=$old_archive_cmds +_LT_TAGVAR(reload_flag, $1)=$reload_flag +_LT_TAGVAR(reload_cmds, $1)=$reload_cmds + +if test -n "$compiler"; then + _LT_COMPILER_NO_RTTI($1) + _LT_COMPILER_PIC($1) + _LT_COMPILER_C_O($1) + _LT_COMPILER_FILE_LOCKS($1) + _LT_LINKER_SHLIBS($1) + _LT_LINKER_HARDCODE_LIBPATH($1) + + _LT_CONFIG($1) +fi + +AC_LANG_RESTORE + +GCC=$lt_save_GCC +CC=$lt_save_CC +CFLAGS=$lt_save_CFLAGS +])# _LT_LANG_GCJ_CONFIG + + +# _LT_LANG_GO_CONFIG([TAG]) +# -------------------------- +# Ensure that the configuration variables for the GNU Go compiler +# are suitably defined. These variables are subsequently used by _LT_CONFIG +# to write the compiler configuration to `libtool'. +m4_defun([_LT_LANG_GO_CONFIG], +[AC_REQUIRE([LT_PROG_GO])dnl +AC_LANG_SAVE + +# Source file extension for Go test sources. +ac_ext=go + +# Object file extension for compiled Go test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# Code to be used in simple compile tests +lt_simple_compile_test_code="package main; func main() { }" + +# Code to be used in simple link tests +lt_simple_link_test_code='package main; func main() { }' + +# ltmain only uses $CC for tagged configurations so make sure $CC is set. +_LT_TAG_COMPILER + +# save warnings/boilerplate of simple test code +_LT_COMPILER_BOILERPLATE +_LT_LINKER_BOILERPLATE + +# Allow CC to be a program name with arguments. +lt_save_CC=$CC +lt_save_CFLAGS=$CFLAGS +lt_save_GCC=$GCC +GCC=yes +CC=${GOC-"gccgo"} +CFLAGS=$GOFLAGS +compiler=$CC +_LT_TAGVAR(compiler, $1)=$CC +_LT_TAGVAR(LD, $1)="$LD" +_LT_CC_BASENAME([$compiler]) + +# Go did not exist at the time GCC didn't implicitly link libc in. +_LT_TAGVAR(archive_cmds_need_lc, $1)=no + +_LT_TAGVAR(old_archive_cmds, $1)=$old_archive_cmds +_LT_TAGVAR(reload_flag, $1)=$reload_flag +_LT_TAGVAR(reload_cmds, $1)=$reload_cmds + +if test -n "$compiler"; then + _LT_COMPILER_NO_RTTI($1) + _LT_COMPILER_PIC($1) + _LT_COMPILER_C_O($1) + _LT_COMPILER_FILE_LOCKS($1) + _LT_LINKER_SHLIBS($1) + _LT_LINKER_HARDCODE_LIBPATH($1) + + _LT_CONFIG($1) +fi + +AC_LANG_RESTORE + +GCC=$lt_save_GCC +CC=$lt_save_CC +CFLAGS=$lt_save_CFLAGS +])# _LT_LANG_GO_CONFIG + + +# _LT_LANG_RC_CONFIG([TAG]) +# ------------------------- +# Ensure that the configuration variables for the Windows resource compiler +# are suitably defined. These variables are subsequently used by _LT_CONFIG +# to write the compiler configuration to `libtool'. +m4_defun([_LT_LANG_RC_CONFIG], +[AC_REQUIRE([LT_PROG_RC])dnl +AC_LANG_SAVE + +# Source file extension for RC test sources. +ac_ext=rc + +# Object file extension for compiled RC test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# Code to be used in simple compile tests +lt_simple_compile_test_code='sample MENU { MENUITEM "&Soup", 100, CHECKED }' + +# Code to be used in simple link tests +lt_simple_link_test_code="$lt_simple_compile_test_code" + +# ltmain only uses $CC for tagged configurations so make sure $CC is set. +_LT_TAG_COMPILER + +# save warnings/boilerplate of simple test code +_LT_COMPILER_BOILERPLATE +_LT_LINKER_BOILERPLATE + +# Allow CC to be a program name with arguments. +lt_save_CC="$CC" +lt_save_CFLAGS=$CFLAGS +lt_save_GCC=$GCC +GCC= +CC=${RC-"windres"} +CFLAGS= +compiler=$CC +_LT_TAGVAR(compiler, $1)=$CC +_LT_CC_BASENAME([$compiler]) +_LT_TAGVAR(lt_cv_prog_compiler_c_o, $1)=yes + +if test -n "$compiler"; then + : + _LT_CONFIG($1) +fi + +GCC=$lt_save_GCC +AC_LANG_RESTORE +CC=$lt_save_CC +CFLAGS=$lt_save_CFLAGS +])# _LT_LANG_RC_CONFIG + + +# LT_PROG_GCJ +# ----------- +AC_DEFUN([LT_PROG_GCJ], +[m4_ifdef([AC_PROG_GCJ], [AC_PROG_GCJ], + [m4_ifdef([A][M_PROG_GCJ], [A][M_PROG_GCJ], + [AC_CHECK_TOOL(GCJ, gcj,) + test "x${GCJFLAGS+set}" = xset || GCJFLAGS="-g -O2" + AC_SUBST(GCJFLAGS)])])[]dnl +]) + +# Old name: +AU_ALIAS([LT_AC_PROG_GCJ], [LT_PROG_GCJ]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([LT_AC_PROG_GCJ], []) + + +# LT_PROG_GO +# ---------- +AC_DEFUN([LT_PROG_GO], +[AC_CHECK_TOOL(GOC, gccgo,) +]) + + +# LT_PROG_RC +# ---------- +AC_DEFUN([LT_PROG_RC], +[AC_CHECK_TOOL(RC, windres,) +]) + +# Old name: +AU_ALIAS([LT_AC_PROG_RC], [LT_PROG_RC]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([LT_AC_PROG_RC], []) + + +# _LT_DECL_EGREP +# -------------- +# If we don't have a new enough Autoconf to choose the best grep +# available, choose the one first in the user's PATH. +m4_defun([_LT_DECL_EGREP], +[AC_REQUIRE([AC_PROG_EGREP])dnl +AC_REQUIRE([AC_PROG_FGREP])dnl +test -z "$GREP" && GREP=grep +_LT_DECL([], [GREP], [1], [A grep program that handles long lines]) +_LT_DECL([], [EGREP], [1], [An ERE matcher]) +_LT_DECL([], [FGREP], [1], [A literal string matcher]) +dnl Non-bleeding-edge autoconf doesn't subst GREP, so do it here too +AC_SUBST([GREP]) +]) + + +# _LT_DECL_OBJDUMP +# -------------- +# If we don't have a new enough Autoconf to choose the best objdump +# available, choose the one first in the user's PATH. +m4_defun([_LT_DECL_OBJDUMP], +[AC_CHECK_TOOL(OBJDUMP, objdump, false) +test -z "$OBJDUMP" && OBJDUMP=objdump +_LT_DECL([], [OBJDUMP], [1], [An object symbol dumper]) +AC_SUBST([OBJDUMP]) +]) + +# _LT_DECL_DLLTOOL +# ---------------- +# Ensure DLLTOOL variable is set. +m4_defun([_LT_DECL_DLLTOOL], +[AC_CHECK_TOOL(DLLTOOL, dlltool, false) +test -z "$DLLTOOL" && DLLTOOL=dlltool +_LT_DECL([], [DLLTOOL], [1], [DLL creation program]) +AC_SUBST([DLLTOOL]) +]) + +# _LT_DECL_SED +# ------------ +# Check for a fully-functional sed program, that truncates +# as few characters as possible. Prefer GNU sed if found. +m4_defun([_LT_DECL_SED], +[AC_PROG_SED +test -z "$SED" && SED=sed +Xsed="$SED -e 1s/^X//" +_LT_DECL([], [SED], [1], [A sed program that does not truncate output]) +_LT_DECL([], [Xsed], ["\$SED -e 1s/^X//"], + [Sed that helps us avoid accidentally triggering echo(1) options like -n]) +])# _LT_DECL_SED + +m4_ifndef([AC_PROG_SED], [ +# NOTE: This macro has been submitted for inclusion into # +# GNU Autoconf as AC_PROG_SED. When it is available in # +# a released version of Autoconf we should remove this # +# macro and use it instead. # + +m4_defun([AC_PROG_SED], +[AC_MSG_CHECKING([for a sed that does not truncate output]) +AC_CACHE_VAL(lt_cv_path_SED, +[# Loop through the user's path and test for sed and gsed. +# Then use that list of sed's as ones to test for truncation. +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for lt_ac_prog in sed gsed; do + for ac_exec_ext in '' $ac_executable_extensions; do + if $as_executable_p "$as_dir/$lt_ac_prog$ac_exec_ext"; then + lt_ac_sed_list="$lt_ac_sed_list $as_dir/$lt_ac_prog$ac_exec_ext" + fi + done + done +done +IFS=$as_save_IFS +lt_ac_max=0 +lt_ac_count=0 +# Add /usr/xpg4/bin/sed as it is typically found on Solaris +# along with /bin/sed that truncates output. +for lt_ac_sed in $lt_ac_sed_list /usr/xpg4/bin/sed; do + test ! -f $lt_ac_sed && continue + cat /dev/null > conftest.in + lt_ac_count=0 + echo $ECHO_N "0123456789$ECHO_C" >conftest.in + # Check for GNU sed and select it if it is found. + if "$lt_ac_sed" --version 2>&1 < /dev/null | grep 'GNU' > /dev/null; then + lt_cv_path_SED=$lt_ac_sed + break + fi + while true; do + cat conftest.in conftest.in >conftest.tmp + mv conftest.tmp conftest.in + cp conftest.in conftest.nl + echo >>conftest.nl + $lt_ac_sed -e 's/a$//' < conftest.nl >conftest.out || break + cmp -s conftest.out conftest.nl || break + # 10000 chars as input seems more than enough + test $lt_ac_count -gt 10 && break + lt_ac_count=`expr $lt_ac_count + 1` + if test $lt_ac_count -gt $lt_ac_max; then + lt_ac_max=$lt_ac_count + lt_cv_path_SED=$lt_ac_sed + fi + done +done +]) +SED=$lt_cv_path_SED +AC_SUBST([SED]) +AC_MSG_RESULT([$SED]) +])#AC_PROG_SED +])#m4_ifndef + +# Old name: +AU_ALIAS([LT_AC_PROG_SED], [AC_PROG_SED]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([LT_AC_PROG_SED], []) + + +# _LT_CHECK_SHELL_FEATURES +# ------------------------ +# Find out whether the shell is Bourne or XSI compatible, +# or has some other useful features. +m4_defun([_LT_CHECK_SHELL_FEATURES], +[AC_MSG_CHECKING([whether the shell understands some XSI constructs]) +# Try some XSI features +xsi_shell=no +( _lt_dummy="a/b/c" + test "${_lt_dummy##*/},${_lt_dummy%/*},${_lt_dummy#??}"${_lt_dummy%"$_lt_dummy"}, \ + = c,a/b,b/c, \ + && eval 'test $(( 1 + 1 )) -eq 2 \ + && test "${#_lt_dummy}" -eq 5' ) >/dev/null 2>&1 \ + && xsi_shell=yes +AC_MSG_RESULT([$xsi_shell]) +_LT_CONFIG_LIBTOOL_INIT([xsi_shell='$xsi_shell']) + +AC_MSG_CHECKING([whether the shell understands "+="]) +lt_shell_append=no +( foo=bar; set foo baz; eval "$[1]+=\$[2]" && test "$foo" = barbaz ) \ + >/dev/null 2>&1 \ + && lt_shell_append=yes +AC_MSG_RESULT([$lt_shell_append]) +_LT_CONFIG_LIBTOOL_INIT([lt_shell_append='$lt_shell_append']) + +if ( (MAIL=60; unset MAIL) || exit) >/dev/null 2>&1; then + lt_unset=unset +else + lt_unset=false +fi +_LT_DECL([], [lt_unset], [0], [whether the shell understands "unset"])dnl + +# test EBCDIC or ASCII +case `echo X|tr X '\101'` in + A) # ASCII based system + # \n is not interpreted correctly by Solaris 8 /usr/ucb/tr + lt_SP2NL='tr \040 \012' + lt_NL2SP='tr \015\012 \040\040' + ;; + *) # EBCDIC based system + lt_SP2NL='tr \100 \n' + lt_NL2SP='tr \r\n \100\100' + ;; +esac +_LT_DECL([SP2NL], [lt_SP2NL], [1], [turn spaces into newlines])dnl +_LT_DECL([NL2SP], [lt_NL2SP], [1], [turn newlines into spaces])dnl +])# _LT_CHECK_SHELL_FEATURES + + +# _LT_PROG_FUNCTION_REPLACE (FUNCNAME, REPLACEMENT-BODY) +# ------------------------------------------------------ +# In `$cfgfile', look for function FUNCNAME delimited by `^FUNCNAME ()$' and +# '^} FUNCNAME ', and replace its body with REPLACEMENT-BODY. +m4_defun([_LT_PROG_FUNCTION_REPLACE], +[dnl { +sed -e '/^$1 ()$/,/^} # $1 /c\ +$1 ()\ +{\ +m4_bpatsubsts([$2], [$], [\\], [^\([ ]\)], [\\\1]) +} # Extended-shell $1 implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: +]) + + +# _LT_PROG_REPLACE_SHELLFNS +# ------------------------- +# Replace existing portable implementations of several shell functions with +# equivalent extended shell implementations where those features are available.. +m4_defun([_LT_PROG_REPLACE_SHELLFNS], +[if test x"$xsi_shell" = xyes; then + _LT_PROG_FUNCTION_REPLACE([func_dirname], [dnl + case ${1} in + */*) func_dirname_result="${1%/*}${2}" ;; + * ) func_dirname_result="${3}" ;; + esac]) + + _LT_PROG_FUNCTION_REPLACE([func_basename], [dnl + func_basename_result="${1##*/}"]) + + _LT_PROG_FUNCTION_REPLACE([func_dirname_and_basename], [dnl + case ${1} in + */*) func_dirname_result="${1%/*}${2}" ;; + * ) func_dirname_result="${3}" ;; + esac + func_basename_result="${1##*/}"]) + + _LT_PROG_FUNCTION_REPLACE([func_stripname], [dnl + # pdksh 5.2.14 does not do ${X%$Y} correctly if both X and Y are + # positional parameters, so assign one to ordinary parameter first. + func_stripname_result=${3} + func_stripname_result=${func_stripname_result#"${1}"} + func_stripname_result=${func_stripname_result%"${2}"}]) + + _LT_PROG_FUNCTION_REPLACE([func_split_long_opt], [dnl + func_split_long_opt_name=${1%%=*} + func_split_long_opt_arg=${1#*=}]) + + _LT_PROG_FUNCTION_REPLACE([func_split_short_opt], [dnl + func_split_short_opt_arg=${1#??} + func_split_short_opt_name=${1%"$func_split_short_opt_arg"}]) + + _LT_PROG_FUNCTION_REPLACE([func_lo2o], [dnl + case ${1} in + *.lo) func_lo2o_result=${1%.lo}.${objext} ;; + *) func_lo2o_result=${1} ;; + esac]) + + _LT_PROG_FUNCTION_REPLACE([func_xform], [ func_xform_result=${1%.*}.lo]) + + _LT_PROG_FUNCTION_REPLACE([func_arith], [ func_arith_result=$(( $[*] ))]) + + _LT_PROG_FUNCTION_REPLACE([func_len], [ func_len_result=${#1}]) +fi + +if test x"$lt_shell_append" = xyes; then + _LT_PROG_FUNCTION_REPLACE([func_append], [ eval "${1}+=\\${2}"]) + + _LT_PROG_FUNCTION_REPLACE([func_append_quoted], [dnl + func_quote_for_eval "${2}" +dnl m4 expansion turns \\\\ into \\, and then the shell eval turns that into \ + eval "${1}+=\\\\ \\$func_quote_for_eval_result"]) + + # Save a `func_append' function call where possible by direct use of '+=' + sed -e 's%func_append \([[a-zA-Z_]]\{1,\}\) "%\1+="%g' $cfgfile > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") + test 0 -eq $? || _lt_function_replace_fail=: +else + # Save a `func_append' function call even when '+=' is not available + sed -e 's%func_append \([[a-zA-Z_]]\{1,\}\) "%\1="$\1%g' $cfgfile > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") + test 0 -eq $? || _lt_function_replace_fail=: +fi + +if test x"$_lt_function_replace_fail" = x":"; then + AC_MSG_WARN([Unable to substitute extended shell functions in $ofile]) +fi +]) + +# _LT_PATH_CONVERSION_FUNCTIONS +# ----------------------------- +# Determine which file name conversion functions should be used by +# func_to_host_file (and, implicitly, by func_to_host_path). These are needed +# for certain cross-compile configurations and native mingw. +m4_defun([_LT_PATH_CONVERSION_FUNCTIONS], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +AC_REQUIRE([AC_CANONICAL_BUILD])dnl +AC_MSG_CHECKING([how to convert $build file names to $host format]) +AC_CACHE_VAL(lt_cv_to_host_file_cmd, +[case $host in + *-*-mingw* ) + case $build in + *-*-mingw* ) # actually msys + lt_cv_to_host_file_cmd=func_convert_file_msys_to_w32 + ;; + *-*-cygwin* ) + lt_cv_to_host_file_cmd=func_convert_file_cygwin_to_w32 + ;; + * ) # otherwise, assume *nix + lt_cv_to_host_file_cmd=func_convert_file_nix_to_w32 + ;; + esac + ;; + *-*-cygwin* ) + case $build in + *-*-mingw* ) # actually msys + lt_cv_to_host_file_cmd=func_convert_file_msys_to_cygwin + ;; + *-*-cygwin* ) + lt_cv_to_host_file_cmd=func_convert_file_noop + ;; + * ) # otherwise, assume *nix + lt_cv_to_host_file_cmd=func_convert_file_nix_to_cygwin + ;; + esac + ;; + * ) # unhandled hosts (and "normal" native builds) + lt_cv_to_host_file_cmd=func_convert_file_noop + ;; +esac +]) +to_host_file_cmd=$lt_cv_to_host_file_cmd +AC_MSG_RESULT([$lt_cv_to_host_file_cmd]) +_LT_DECL([to_host_file_cmd], [lt_cv_to_host_file_cmd], + [0], [convert $build file names to $host format])dnl + +AC_MSG_CHECKING([how to convert $build file names to toolchain format]) +AC_CACHE_VAL(lt_cv_to_tool_file_cmd, +[#assume ordinary cross tools, or native build. +lt_cv_to_tool_file_cmd=func_convert_file_noop +case $host in + *-*-mingw* ) + case $build in + *-*-mingw* ) # actually msys + lt_cv_to_tool_file_cmd=func_convert_file_msys_to_w32 + ;; + esac + ;; +esac +]) +to_tool_file_cmd=$lt_cv_to_tool_file_cmd +AC_MSG_RESULT([$lt_cv_to_tool_file_cmd]) +_LT_DECL([to_tool_file_cmd], [lt_cv_to_tool_file_cmd], + [0], [convert $build files to toolchain format])dnl +])# _LT_PATH_CONVERSION_FUNCTIONS + +# Helper functions for option handling. -*- Autoconf -*- +# +# Copyright (C) 2004, 2005, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# Written by Gary V. Vaughan, 2004 +# +# This file is free software; the Free Software Foundation gives +# unlimited permission to copy and/or distribute it, with or without +# modifications, as long as this notice is preserved. + +# serial 7 ltoptions.m4 + +# This is to help aclocal find these macros, as it can't see m4_define. +AC_DEFUN([LTOPTIONS_VERSION], [m4_if([1])]) + + +# _LT_MANGLE_OPTION(MACRO-NAME, OPTION-NAME) +# ------------------------------------------ +m4_define([_LT_MANGLE_OPTION], +[[_LT_OPTION_]m4_bpatsubst($1__$2, [[^a-zA-Z0-9_]], [_])]) + + +# _LT_SET_OPTION(MACRO-NAME, OPTION-NAME) +# --------------------------------------- +# Set option OPTION-NAME for macro MACRO-NAME, and if there is a +# matching handler defined, dispatch to it. Other OPTION-NAMEs are +# saved as a flag. +m4_define([_LT_SET_OPTION], +[m4_define(_LT_MANGLE_OPTION([$1], [$2]))dnl +m4_ifdef(_LT_MANGLE_DEFUN([$1], [$2]), + _LT_MANGLE_DEFUN([$1], [$2]), + [m4_warning([Unknown $1 option `$2'])])[]dnl +]) + + +# _LT_IF_OPTION(MACRO-NAME, OPTION-NAME, IF-SET, [IF-NOT-SET]) +# ------------------------------------------------------------ +# Execute IF-SET if OPTION is set, IF-NOT-SET otherwise. +m4_define([_LT_IF_OPTION], +[m4_ifdef(_LT_MANGLE_OPTION([$1], [$2]), [$3], [$4])]) + + +# _LT_UNLESS_OPTIONS(MACRO-NAME, OPTION-LIST, IF-NOT-SET) +# ------------------------------------------------------- +# Execute IF-NOT-SET unless all options in OPTION-LIST for MACRO-NAME +# are set. +m4_define([_LT_UNLESS_OPTIONS], +[m4_foreach([_LT_Option], m4_split(m4_normalize([$2])), + [m4_ifdef(_LT_MANGLE_OPTION([$1], _LT_Option), + [m4_define([$0_found])])])[]dnl +m4_ifdef([$0_found], [m4_undefine([$0_found])], [$3 +])[]dnl +]) + + +# _LT_SET_OPTIONS(MACRO-NAME, OPTION-LIST) +# ---------------------------------------- +# OPTION-LIST is a space-separated list of Libtool options associated +# with MACRO-NAME. If any OPTION has a matching handler declared with +# LT_OPTION_DEFINE, dispatch to that macro; otherwise complain about +# the unknown option and exit. +m4_defun([_LT_SET_OPTIONS], +[# Set options +m4_foreach([_LT_Option], m4_split(m4_normalize([$2])), + [_LT_SET_OPTION([$1], _LT_Option)]) + +m4_if([$1],[LT_INIT],[ + dnl + dnl Simply set some default values (i.e off) if boolean options were not + dnl specified: + _LT_UNLESS_OPTIONS([LT_INIT], [dlopen], [enable_dlopen=no + ]) + _LT_UNLESS_OPTIONS([LT_INIT], [win32-dll], [enable_win32_dll=no + ]) + dnl + dnl If no reference was made to various pairs of opposing options, then + dnl we run the default mode handler for the pair. For example, if neither + dnl `shared' nor `disable-shared' was passed, we enable building of shared + dnl archives by default: + _LT_UNLESS_OPTIONS([LT_INIT], [shared disable-shared], [_LT_ENABLE_SHARED]) + _LT_UNLESS_OPTIONS([LT_INIT], [static disable-static], [_LT_ENABLE_STATIC]) + _LT_UNLESS_OPTIONS([LT_INIT], [pic-only no-pic], [_LT_WITH_PIC]) + _LT_UNLESS_OPTIONS([LT_INIT], [fast-install disable-fast-install], + [_LT_ENABLE_FAST_INSTALL]) + ]) +])# _LT_SET_OPTIONS + + + +# _LT_MANGLE_DEFUN(MACRO-NAME, OPTION-NAME) +# ----------------------------------------- +m4_define([_LT_MANGLE_DEFUN], +[[_LT_OPTION_DEFUN_]m4_bpatsubst(m4_toupper([$1__$2]), [[^A-Z0-9_]], [_])]) + + +# LT_OPTION_DEFINE(MACRO-NAME, OPTION-NAME, CODE) +# ----------------------------------------------- +m4_define([LT_OPTION_DEFINE], +[m4_define(_LT_MANGLE_DEFUN([$1], [$2]), [$3])[]dnl +])# LT_OPTION_DEFINE + + +# dlopen +# ------ +LT_OPTION_DEFINE([LT_INIT], [dlopen], [enable_dlopen=yes +]) + +AU_DEFUN([AC_LIBTOOL_DLOPEN], +[_LT_SET_OPTION([LT_INIT], [dlopen]) +AC_DIAGNOSE([obsolete], +[$0: Remove this warning and the call to _LT_SET_OPTION when you +put the `dlopen' option into LT_INIT's first parameter.]) +]) + +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_DLOPEN], []) + + +# win32-dll +# --------- +# Declare package support for building win32 dll's. +LT_OPTION_DEFINE([LT_INIT], [win32-dll], +[enable_win32_dll=yes + +case $host in +*-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-cegcc*) + AC_CHECK_TOOL(AS, as, false) + AC_CHECK_TOOL(DLLTOOL, dlltool, false) + AC_CHECK_TOOL(OBJDUMP, objdump, false) + ;; +esac + +test -z "$AS" && AS=as +_LT_DECL([], [AS], [1], [Assembler program])dnl + +test -z "$DLLTOOL" && DLLTOOL=dlltool +_LT_DECL([], [DLLTOOL], [1], [DLL creation program])dnl + +test -z "$OBJDUMP" && OBJDUMP=objdump +_LT_DECL([], [OBJDUMP], [1], [Object dumper program])dnl +])# win32-dll + +AU_DEFUN([AC_LIBTOOL_WIN32_DLL], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +_LT_SET_OPTION([LT_INIT], [win32-dll]) +AC_DIAGNOSE([obsolete], +[$0: Remove this warning and the call to _LT_SET_OPTION when you +put the `win32-dll' option into LT_INIT's first parameter.]) +]) + +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_WIN32_DLL], []) + + +# _LT_ENABLE_SHARED([DEFAULT]) +# ---------------------------- +# implement the --enable-shared flag, and supports the `shared' and +# `disable-shared' LT_INIT options. +# DEFAULT is either `yes' or `no'. If omitted, it defaults to `yes'. +m4_define([_LT_ENABLE_SHARED], +[m4_define([_LT_ENABLE_SHARED_DEFAULT], [m4_if($1, no, no, yes)])dnl +AC_ARG_ENABLE([shared], + [AS_HELP_STRING([--enable-shared@<:@=PKGS@:>@], + [build shared libraries @<:@default=]_LT_ENABLE_SHARED_DEFAULT[@:>@])], + [p=${PACKAGE-default} + case $enableval in + yes) enable_shared=yes ;; + no) enable_shared=no ;; + *) + enable_shared=no + # Look at the argument we got. We use all the common list separators. + lt_save_ifs="$IFS"; IFS="${IFS}$PATH_SEPARATOR," + for pkg in $enableval; do + IFS="$lt_save_ifs" + if test "X$pkg" = "X$p"; then + enable_shared=yes + fi + done + IFS="$lt_save_ifs" + ;; + esac], + [enable_shared=]_LT_ENABLE_SHARED_DEFAULT) + + _LT_DECL([build_libtool_libs], [enable_shared], [0], + [Whether or not to build shared libraries]) +])# _LT_ENABLE_SHARED + +LT_OPTION_DEFINE([LT_INIT], [shared], [_LT_ENABLE_SHARED([yes])]) +LT_OPTION_DEFINE([LT_INIT], [disable-shared], [_LT_ENABLE_SHARED([no])]) + +# Old names: +AC_DEFUN([AC_ENABLE_SHARED], +[_LT_SET_OPTION([LT_INIT], m4_if([$1], [no], [disable-])[shared]) +]) + +AC_DEFUN([AC_DISABLE_SHARED], +[_LT_SET_OPTION([LT_INIT], [disable-shared]) +]) + +AU_DEFUN([AM_ENABLE_SHARED], [AC_ENABLE_SHARED($@)]) +AU_DEFUN([AM_DISABLE_SHARED], [AC_DISABLE_SHARED($@)]) + +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AM_ENABLE_SHARED], []) +dnl AC_DEFUN([AM_DISABLE_SHARED], []) + + + +# _LT_ENABLE_STATIC([DEFAULT]) +# ---------------------------- +# implement the --enable-static flag, and support the `static' and +# `disable-static' LT_INIT options. +# DEFAULT is either `yes' or `no'. If omitted, it defaults to `yes'. +m4_define([_LT_ENABLE_STATIC], +[m4_define([_LT_ENABLE_STATIC_DEFAULT], [m4_if($1, no, no, yes)])dnl +AC_ARG_ENABLE([static], + [AS_HELP_STRING([--enable-static@<:@=PKGS@:>@], + [build static libraries @<:@default=]_LT_ENABLE_STATIC_DEFAULT[@:>@])], + [p=${PACKAGE-default} + case $enableval in + yes) enable_static=yes ;; + no) enable_static=no ;; + *) + enable_static=no + # Look at the argument we got. We use all the common list separators. + lt_save_ifs="$IFS"; IFS="${IFS}$PATH_SEPARATOR," + for pkg in $enableval; do + IFS="$lt_save_ifs" + if test "X$pkg" = "X$p"; then + enable_static=yes + fi + done + IFS="$lt_save_ifs" + ;; + esac], + [enable_static=]_LT_ENABLE_STATIC_DEFAULT) + + _LT_DECL([build_old_libs], [enable_static], [0], + [Whether or not to build static libraries]) +])# _LT_ENABLE_STATIC + +LT_OPTION_DEFINE([LT_INIT], [static], [_LT_ENABLE_STATIC([yes])]) +LT_OPTION_DEFINE([LT_INIT], [disable-static], [_LT_ENABLE_STATIC([no])]) + +# Old names: +AC_DEFUN([AC_ENABLE_STATIC], +[_LT_SET_OPTION([LT_INIT], m4_if([$1], [no], [disable-])[static]) +]) + +AC_DEFUN([AC_DISABLE_STATIC], +[_LT_SET_OPTION([LT_INIT], [disable-static]) +]) + +AU_DEFUN([AM_ENABLE_STATIC], [AC_ENABLE_STATIC($@)]) +AU_DEFUN([AM_DISABLE_STATIC], [AC_DISABLE_STATIC($@)]) + +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AM_ENABLE_STATIC], []) +dnl AC_DEFUN([AM_DISABLE_STATIC], []) + + + +# _LT_ENABLE_FAST_INSTALL([DEFAULT]) +# ---------------------------------- +# implement the --enable-fast-install flag, and support the `fast-install' +# and `disable-fast-install' LT_INIT options. +# DEFAULT is either `yes' or `no'. If omitted, it defaults to `yes'. +m4_define([_LT_ENABLE_FAST_INSTALL], +[m4_define([_LT_ENABLE_FAST_INSTALL_DEFAULT], [m4_if($1, no, no, yes)])dnl +AC_ARG_ENABLE([fast-install], + [AS_HELP_STRING([--enable-fast-install@<:@=PKGS@:>@], + [optimize for fast installation @<:@default=]_LT_ENABLE_FAST_INSTALL_DEFAULT[@:>@])], + [p=${PACKAGE-default} + case $enableval in + yes) enable_fast_install=yes ;; + no) enable_fast_install=no ;; + *) + enable_fast_install=no + # Look at the argument we got. We use all the common list separators. + lt_save_ifs="$IFS"; IFS="${IFS}$PATH_SEPARATOR," + for pkg in $enableval; do + IFS="$lt_save_ifs" + if test "X$pkg" = "X$p"; then + enable_fast_install=yes + fi + done + IFS="$lt_save_ifs" + ;; + esac], + [enable_fast_install=]_LT_ENABLE_FAST_INSTALL_DEFAULT) + +_LT_DECL([fast_install], [enable_fast_install], [0], + [Whether or not to optimize for fast installation])dnl +])# _LT_ENABLE_FAST_INSTALL + +LT_OPTION_DEFINE([LT_INIT], [fast-install], [_LT_ENABLE_FAST_INSTALL([yes])]) +LT_OPTION_DEFINE([LT_INIT], [disable-fast-install], [_LT_ENABLE_FAST_INSTALL([no])]) + +# Old names: +AU_DEFUN([AC_ENABLE_FAST_INSTALL], +[_LT_SET_OPTION([LT_INIT], m4_if([$1], [no], [disable-])[fast-install]) +AC_DIAGNOSE([obsolete], +[$0: Remove this warning and the call to _LT_SET_OPTION when you put +the `fast-install' option into LT_INIT's first parameter.]) +]) + +AU_DEFUN([AC_DISABLE_FAST_INSTALL], +[_LT_SET_OPTION([LT_INIT], [disable-fast-install]) +AC_DIAGNOSE([obsolete], +[$0: Remove this warning and the call to _LT_SET_OPTION when you put +the `disable-fast-install' option into LT_INIT's first parameter.]) +]) + +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_ENABLE_FAST_INSTALL], []) +dnl AC_DEFUN([AM_DISABLE_FAST_INSTALL], []) + + +# _LT_WITH_PIC([MODE]) +# -------------------- +# implement the --with-pic flag, and support the `pic-only' and `no-pic' +# LT_INIT options. +# MODE is either `yes' or `no'. If omitted, it defaults to `both'. +m4_define([_LT_WITH_PIC], +[AC_ARG_WITH([pic], + [AS_HELP_STRING([--with-pic@<:@=PKGS@:>@], + [try to use only PIC/non-PIC objects @<:@default=use both@:>@])], + [lt_p=${PACKAGE-default} + case $withval in + yes|no) pic_mode=$withval ;; + *) + pic_mode=default + # Look at the argument we got. We use all the common list separators. + lt_save_ifs="$IFS"; IFS="${IFS}$PATH_SEPARATOR," + for lt_pkg in $withval; do + IFS="$lt_save_ifs" + if test "X$lt_pkg" = "X$lt_p"; then + pic_mode=yes + fi + done + IFS="$lt_save_ifs" + ;; + esac], + [pic_mode=default]) + +test -z "$pic_mode" && pic_mode=m4_default([$1], [default]) + +_LT_DECL([], [pic_mode], [0], [What type of objects to build])dnl +])# _LT_WITH_PIC + +LT_OPTION_DEFINE([LT_INIT], [pic-only], [_LT_WITH_PIC([yes])]) +LT_OPTION_DEFINE([LT_INIT], [no-pic], [_LT_WITH_PIC([no])]) + +# Old name: +AU_DEFUN([AC_LIBTOOL_PICMODE], +[_LT_SET_OPTION([LT_INIT], [pic-only]) +AC_DIAGNOSE([obsolete], +[$0: Remove this warning and the call to _LT_SET_OPTION when you +put the `pic-only' option into LT_INIT's first parameter.]) +]) + +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_PICMODE], []) + + +m4_define([_LTDL_MODE], []) +LT_OPTION_DEFINE([LTDL_INIT], [nonrecursive], + [m4_define([_LTDL_MODE], [nonrecursive])]) +LT_OPTION_DEFINE([LTDL_INIT], [recursive], + [m4_define([_LTDL_MODE], [recursive])]) +LT_OPTION_DEFINE([LTDL_INIT], [subproject], + [m4_define([_LTDL_MODE], [subproject])]) + +m4_define([_LTDL_TYPE], []) +LT_OPTION_DEFINE([LTDL_INIT], [installable], + [m4_define([_LTDL_TYPE], [installable])]) +LT_OPTION_DEFINE([LTDL_INIT], [convenience], + [m4_define([_LTDL_TYPE], [convenience])]) + +# ltsugar.m4 -- libtool m4 base layer. -*-Autoconf-*- +# +# Copyright (C) 2004, 2005, 2007, 2008 Free Software Foundation, Inc. +# Written by Gary V. Vaughan, 2004 +# +# This file is free software; the Free Software Foundation gives +# unlimited permission to copy and/or distribute it, with or without +# modifications, as long as this notice is preserved. + +# serial 6 ltsugar.m4 + +# This is to help aclocal find these macros, as it can't see m4_define. +AC_DEFUN([LTSUGAR_VERSION], [m4_if([0.1])]) + + +# lt_join(SEP, ARG1, [ARG2...]) +# ----------------------------- +# Produce ARG1SEPARG2...SEPARGn, omitting [] arguments and their +# associated separator. +# Needed until we can rely on m4_join from Autoconf 2.62, since all earlier +# versions in m4sugar had bugs. +m4_define([lt_join], +[m4_if([$#], [1], [], + [$#], [2], [[$2]], + [m4_if([$2], [], [], [[$2]_])$0([$1], m4_shift(m4_shift($@)))])]) +m4_define([_lt_join], +[m4_if([$#$2], [2], [], + [m4_if([$2], [], [], [[$1$2]])$0([$1], m4_shift(m4_shift($@)))])]) + + +# lt_car(LIST) +# lt_cdr(LIST) +# ------------ +# Manipulate m4 lists. +# These macros are necessary as long as will still need to support +# Autoconf-2.59 which quotes differently. +m4_define([lt_car], [[$1]]) +m4_define([lt_cdr], +[m4_if([$#], 0, [m4_fatal([$0: cannot be called without arguments])], + [$#], 1, [], + [m4_dquote(m4_shift($@))])]) +m4_define([lt_unquote], $1) + + +# lt_append(MACRO-NAME, STRING, [SEPARATOR]) +# ------------------------------------------ +# Redefine MACRO-NAME to hold its former content plus `SEPARATOR'`STRING'. +# Note that neither SEPARATOR nor STRING are expanded; they are appended +# to MACRO-NAME as is (leaving the expansion for when MACRO-NAME is invoked). +# No SEPARATOR is output if MACRO-NAME was previously undefined (different +# than defined and empty). +# +# This macro is needed until we can rely on Autoconf 2.62, since earlier +# versions of m4sugar mistakenly expanded SEPARATOR but not STRING. +m4_define([lt_append], +[m4_define([$1], + m4_ifdef([$1], [m4_defn([$1])[$3]])[$2])]) + + + +# lt_combine(SEP, PREFIX-LIST, INFIX, SUFFIX1, [SUFFIX2...]) +# ---------------------------------------------------------- +# Produce a SEP delimited list of all paired combinations of elements of +# PREFIX-LIST with SUFFIX1 through SUFFIXn. Each element of the list +# has the form PREFIXmINFIXSUFFIXn. +# Needed until we can rely on m4_combine added in Autoconf 2.62. +m4_define([lt_combine], +[m4_if(m4_eval([$# > 3]), [1], + [m4_pushdef([_Lt_sep], [m4_define([_Lt_sep], m4_defn([lt_car]))])]]dnl +[[m4_foreach([_Lt_prefix], [$2], + [m4_foreach([_Lt_suffix], + ]m4_dquote(m4_dquote(m4_shift(m4_shift(m4_shift($@)))))[, + [_Lt_sep([$1])[]m4_defn([_Lt_prefix])[$3]m4_defn([_Lt_suffix])])])])]) + + +# lt_if_append_uniq(MACRO-NAME, VARNAME, [SEPARATOR], [UNIQ], [NOT-UNIQ]) +# ----------------------------------------------------------------------- +# Iff MACRO-NAME does not yet contain VARNAME, then append it (delimited +# by SEPARATOR if supplied) and expand UNIQ, else NOT-UNIQ. +m4_define([lt_if_append_uniq], +[m4_ifdef([$1], + [m4_if(m4_index([$3]m4_defn([$1])[$3], [$3$2$3]), [-1], + [lt_append([$1], [$2], [$3])$4], + [$5])], + [lt_append([$1], [$2], [$3])$4])]) + + +# lt_dict_add(DICT, KEY, VALUE) +# ----------------------------- +m4_define([lt_dict_add], +[m4_define([$1($2)], [$3])]) + + +# lt_dict_add_subkey(DICT, KEY, SUBKEY, VALUE) +# -------------------------------------------- +m4_define([lt_dict_add_subkey], +[m4_define([$1($2:$3)], [$4])]) + + +# lt_dict_fetch(DICT, KEY, [SUBKEY]) +# ---------------------------------- +m4_define([lt_dict_fetch], +[m4_ifval([$3], + m4_ifdef([$1($2:$3)], [m4_defn([$1($2:$3)])]), + m4_ifdef([$1($2)], [m4_defn([$1($2)])]))]) + + +# lt_if_dict_fetch(DICT, KEY, [SUBKEY], VALUE, IF-TRUE, [IF-FALSE]) +# ----------------------------------------------------------------- +m4_define([lt_if_dict_fetch], +[m4_if(lt_dict_fetch([$1], [$2], [$3]), [$4], + [$5], + [$6])]) + + +# lt_dict_filter(DICT, [SUBKEY], VALUE, [SEPARATOR], KEY, [...]) +# -------------------------------------------------------------- +m4_define([lt_dict_filter], +[m4_if([$5], [], [], + [lt_join(m4_quote(m4_default([$4], [[, ]])), + lt_unquote(m4_split(m4_normalize(m4_foreach(_Lt_key, lt_car([m4_shiftn(4, $@)]), + [lt_if_dict_fetch([$1], _Lt_key, [$2], [$3], [_Lt_key ])])))))])[]dnl +]) + +# ltversion.m4 -- version numbers -*- Autoconf -*- +# +# Copyright (C) 2004 Free Software Foundation, Inc. +# Written by Scott James Remnant, 2004 +# +# This file is free software; the Free Software Foundation gives +# unlimited permission to copy and/or distribute it, with or without +# modifications, as long as this notice is preserved. + +# @configure_input@ + +# serial 3337 ltversion.m4 +# This file is part of GNU Libtool + +m4_define([LT_PACKAGE_VERSION], [2.4.2]) +m4_define([LT_PACKAGE_REVISION], [1.3337]) + +AC_DEFUN([LTVERSION_VERSION], +[macro_version='2.4.2' +macro_revision='1.3337' +_LT_DECL(, macro_version, 0, [Which release of libtool.m4 was used?]) +_LT_DECL(, macro_revision, 0) +]) + +# lt~obsolete.m4 -- aclocal satisfying obsolete definitions. -*-Autoconf-*- +# +# Copyright (C) 2004, 2005, 2007, 2009 Free Software Foundation, Inc. +# Written by Scott James Remnant, 2004. +# +# This file is free software; the Free Software Foundation gives +# unlimited permission to copy and/or distribute it, with or without +# modifications, as long as this notice is preserved. + +# serial 5 lt~obsolete.m4 + +# These exist entirely to fool aclocal when bootstrapping libtool. +# +# In the past libtool.m4 has provided macros via AC_DEFUN (or AU_DEFUN) +# which have later been changed to m4_define as they aren't part of the +# exported API, or moved to Autoconf or Automake where they belong. +# +# The trouble is, aclocal is a bit thick. It'll see the old AC_DEFUN +# in /usr/share/aclocal/libtool.m4 and remember it, then when it sees us +# using a macro with the same name in our local m4/libtool.m4 it'll +# pull the old libtool.m4 in (it doesn't see our shiny new m4_define +# and doesn't know about Autoconf macros at all.) +# +# So we provide this file, which has a silly filename so it's always +# included after everything else. This provides aclocal with the +# AC_DEFUNs it wants, but when m4 processes it, it doesn't do anything +# because those macros already exist, or will be overwritten later. +# We use AC_DEFUN over AU_DEFUN for compatibility with aclocal-1.6. +# +# Anytime we withdraw an AC_DEFUN or AU_DEFUN, remember to add it here. +# Yes, that means every name once taken will need to remain here until +# we give up compatibility with versions before 1.7, at which point +# we need to keep only those names which we still refer to. + +# This is to help aclocal find these macros, as it can't see m4_define. +AC_DEFUN([LTOBSOLETE_VERSION], [m4_if([1])]) + +m4_ifndef([AC_LIBTOOL_LINKER_OPTION], [AC_DEFUN([AC_LIBTOOL_LINKER_OPTION])]) +m4_ifndef([AC_PROG_EGREP], [AC_DEFUN([AC_PROG_EGREP])]) +m4_ifndef([_LT_AC_PROG_ECHO_BACKSLASH], [AC_DEFUN([_LT_AC_PROG_ECHO_BACKSLASH])]) +m4_ifndef([_LT_AC_SHELL_INIT], [AC_DEFUN([_LT_AC_SHELL_INIT])]) +m4_ifndef([_LT_AC_SYS_LIBPATH_AIX], [AC_DEFUN([_LT_AC_SYS_LIBPATH_AIX])]) +m4_ifndef([_LT_PROG_LTMAIN], [AC_DEFUN([_LT_PROG_LTMAIN])]) +m4_ifndef([_LT_AC_TAGVAR], [AC_DEFUN([_LT_AC_TAGVAR])]) +m4_ifndef([AC_LTDL_ENABLE_INSTALL], [AC_DEFUN([AC_LTDL_ENABLE_INSTALL])]) +m4_ifndef([AC_LTDL_PREOPEN], [AC_DEFUN([AC_LTDL_PREOPEN])]) +m4_ifndef([_LT_AC_SYS_COMPILER], [AC_DEFUN([_LT_AC_SYS_COMPILER])]) +m4_ifndef([_LT_AC_LOCK], [AC_DEFUN([_LT_AC_LOCK])]) +m4_ifndef([AC_LIBTOOL_SYS_OLD_ARCHIVE], [AC_DEFUN([AC_LIBTOOL_SYS_OLD_ARCHIVE])]) +m4_ifndef([_LT_AC_TRY_DLOPEN_SELF], [AC_DEFUN([_LT_AC_TRY_DLOPEN_SELF])]) +m4_ifndef([AC_LIBTOOL_PROG_CC_C_O], [AC_DEFUN([AC_LIBTOOL_PROG_CC_C_O])]) +m4_ifndef([AC_LIBTOOL_SYS_HARD_LINK_LOCKS], [AC_DEFUN([AC_LIBTOOL_SYS_HARD_LINK_LOCKS])]) +m4_ifndef([AC_LIBTOOL_OBJDIR], [AC_DEFUN([AC_LIBTOOL_OBJDIR])]) +m4_ifndef([AC_LTDL_OBJDIR], [AC_DEFUN([AC_LTDL_OBJDIR])]) +m4_ifndef([AC_LIBTOOL_PROG_LD_HARDCODE_LIBPATH], [AC_DEFUN([AC_LIBTOOL_PROG_LD_HARDCODE_LIBPATH])]) +m4_ifndef([AC_LIBTOOL_SYS_LIB_STRIP], [AC_DEFUN([AC_LIBTOOL_SYS_LIB_STRIP])]) +m4_ifndef([AC_PATH_MAGIC], [AC_DEFUN([AC_PATH_MAGIC])]) +m4_ifndef([AC_PROG_LD_GNU], [AC_DEFUN([AC_PROG_LD_GNU])]) +m4_ifndef([AC_PROG_LD_RELOAD_FLAG], [AC_DEFUN([AC_PROG_LD_RELOAD_FLAG])]) +m4_ifndef([AC_DEPLIBS_CHECK_METHOD], [AC_DEFUN([AC_DEPLIBS_CHECK_METHOD])]) +m4_ifndef([AC_LIBTOOL_PROG_COMPILER_NO_RTTI], [AC_DEFUN([AC_LIBTOOL_PROG_COMPILER_NO_RTTI])]) +m4_ifndef([AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE], [AC_DEFUN([AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE])]) +m4_ifndef([AC_LIBTOOL_PROG_COMPILER_PIC], [AC_DEFUN([AC_LIBTOOL_PROG_COMPILER_PIC])]) +m4_ifndef([AC_LIBTOOL_PROG_LD_SHLIBS], [AC_DEFUN([AC_LIBTOOL_PROG_LD_SHLIBS])]) +m4_ifndef([AC_LIBTOOL_POSTDEP_PREDEP], [AC_DEFUN([AC_LIBTOOL_POSTDEP_PREDEP])]) +m4_ifndef([LT_AC_PROG_EGREP], [AC_DEFUN([LT_AC_PROG_EGREP])]) +m4_ifndef([LT_AC_PROG_SED], [AC_DEFUN([LT_AC_PROG_SED])]) +m4_ifndef([_LT_CC_BASENAME], [AC_DEFUN([_LT_CC_BASENAME])]) +m4_ifndef([_LT_COMPILER_BOILERPLATE], [AC_DEFUN([_LT_COMPILER_BOILERPLATE])]) +m4_ifndef([_LT_LINKER_BOILERPLATE], [AC_DEFUN([_LT_LINKER_BOILERPLATE])]) +m4_ifndef([_AC_PROG_LIBTOOL], [AC_DEFUN([_AC_PROG_LIBTOOL])]) +m4_ifndef([AC_LIBTOOL_SETUP], [AC_DEFUN([AC_LIBTOOL_SETUP])]) +m4_ifndef([_LT_AC_CHECK_DLFCN], [AC_DEFUN([_LT_AC_CHECK_DLFCN])]) +m4_ifndef([AC_LIBTOOL_SYS_DYNAMIC_LINKER], [AC_DEFUN([AC_LIBTOOL_SYS_DYNAMIC_LINKER])]) +m4_ifndef([_LT_AC_TAGCONFIG], [AC_DEFUN([_LT_AC_TAGCONFIG])]) +m4_ifndef([AC_DISABLE_FAST_INSTALL], [AC_DEFUN([AC_DISABLE_FAST_INSTALL])]) +m4_ifndef([_LT_AC_LANG_CXX], [AC_DEFUN([_LT_AC_LANG_CXX])]) +m4_ifndef([_LT_AC_LANG_F77], [AC_DEFUN([_LT_AC_LANG_F77])]) +m4_ifndef([_LT_AC_LANG_GCJ], [AC_DEFUN([_LT_AC_LANG_GCJ])]) +m4_ifndef([AC_LIBTOOL_LANG_C_CONFIG], [AC_DEFUN([AC_LIBTOOL_LANG_C_CONFIG])]) +m4_ifndef([_LT_AC_LANG_C_CONFIG], [AC_DEFUN([_LT_AC_LANG_C_CONFIG])]) +m4_ifndef([AC_LIBTOOL_LANG_CXX_CONFIG], [AC_DEFUN([AC_LIBTOOL_LANG_CXX_CONFIG])]) +m4_ifndef([_LT_AC_LANG_CXX_CONFIG], [AC_DEFUN([_LT_AC_LANG_CXX_CONFIG])]) +m4_ifndef([AC_LIBTOOL_LANG_F77_CONFIG], [AC_DEFUN([AC_LIBTOOL_LANG_F77_CONFIG])]) +m4_ifndef([_LT_AC_LANG_F77_CONFIG], [AC_DEFUN([_LT_AC_LANG_F77_CONFIG])]) +m4_ifndef([AC_LIBTOOL_LANG_GCJ_CONFIG], [AC_DEFUN([AC_LIBTOOL_LANG_GCJ_CONFIG])]) +m4_ifndef([_LT_AC_LANG_GCJ_CONFIG], [AC_DEFUN([_LT_AC_LANG_GCJ_CONFIG])]) +m4_ifndef([AC_LIBTOOL_LANG_RC_CONFIG], [AC_DEFUN([AC_LIBTOOL_LANG_RC_CONFIG])]) +m4_ifndef([_LT_AC_LANG_RC_CONFIG], [AC_DEFUN([_LT_AC_LANG_RC_CONFIG])]) +m4_ifndef([AC_LIBTOOL_CONFIG], [AC_DEFUN([AC_LIBTOOL_CONFIG])]) +m4_ifndef([_LT_AC_FILE_LTDLL_C], [AC_DEFUN([_LT_AC_FILE_LTDLL_C])]) +m4_ifndef([_LT_REQUIRED_DARWIN_CHECKS], [AC_DEFUN([_LT_REQUIRED_DARWIN_CHECKS])]) +m4_ifndef([_LT_AC_PROG_CXXCPP], [AC_DEFUN([_LT_AC_PROG_CXXCPP])]) +m4_ifndef([_LT_PREPARE_SED_QUOTE_VARS], [AC_DEFUN([_LT_PREPARE_SED_QUOTE_VARS])]) +m4_ifndef([_LT_PROG_ECHO_BACKSLASH], [AC_DEFUN([_LT_PROG_ECHO_BACKSLASH])]) +m4_ifndef([_LT_PROG_F77], [AC_DEFUN([_LT_PROG_F77])]) +m4_ifndef([_LT_PROG_FC], [AC_DEFUN([_LT_PROG_FC])]) +m4_ifndef([_LT_PROG_CXX], [AC_DEFUN([_LT_PROG_CXX])]) + +# Copyright (C) 2002, 2003, 2005, 2006, 2007, 2008 Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# AM_AUTOMAKE_VERSION(VERSION) +# ---------------------------- +# Automake X.Y traces this macro to ensure aclocal.m4 has been +# generated from the m4 files accompanying Automake X.Y. +# (This private macro should not be called outside this file.) +AC_DEFUN([AM_AUTOMAKE_VERSION], +[am__api_version='1.11' +dnl Some users find AM_AUTOMAKE_VERSION and mistake it for a way to +dnl require some minimum version. Point them to the right macro. +m4_if([$1], [1.11.1], [], + [AC_FATAL([Do not call $0, use AM_INIT_AUTOMAKE([$1]).])])dnl +]) + +# _AM_AUTOCONF_VERSION(VERSION) +# ----------------------------- +# aclocal traces this macro to find the Autoconf version. +# This is a private macro too. Using m4_define simplifies +# the logic in aclocal, which can simply ignore this definition. +m4_define([_AM_AUTOCONF_VERSION], []) + +# AM_SET_CURRENT_AUTOMAKE_VERSION +# ------------------------------- +# Call AM_AUTOMAKE_VERSION and AM_AUTOMAKE_VERSION so they can be traced. +# This function is AC_REQUIREd by AM_INIT_AUTOMAKE. +AC_DEFUN([AM_SET_CURRENT_AUTOMAKE_VERSION], +[AM_AUTOMAKE_VERSION([1.11.1])dnl +m4_ifndef([AC_AUTOCONF_VERSION], + [m4_copy([m4_PACKAGE_VERSION], [AC_AUTOCONF_VERSION])])dnl +_AM_AUTOCONF_VERSION(m4_defn([AC_AUTOCONF_VERSION]))]) + +# AM_AUX_DIR_EXPAND -*- Autoconf -*- + +# Copyright (C) 2001, 2003, 2005 Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# For projects using AC_CONFIG_AUX_DIR([foo]), Autoconf sets +# $ac_aux_dir to `$srcdir/foo'. In other projects, it is set to +# `$srcdir', `$srcdir/..', or `$srcdir/../..'. +# +# Of course, Automake must honor this variable whenever it calls a +# tool from the auxiliary directory. The problem is that $srcdir (and +# therefore $ac_aux_dir as well) can be either absolute or relative, +# depending on how configure is run. This is pretty annoying, since +# it makes $ac_aux_dir quite unusable in subdirectories: in the top +# source directory, any form will work fine, but in subdirectories a +# relative path needs to be adjusted first. +# +# $ac_aux_dir/missing +# fails when called from a subdirectory if $ac_aux_dir is relative +# $top_srcdir/$ac_aux_dir/missing +# fails if $ac_aux_dir is absolute, +# fails when called from a subdirectory in a VPATH build with +# a relative $ac_aux_dir +# +# The reason of the latter failure is that $top_srcdir and $ac_aux_dir +# are both prefixed by $srcdir. In an in-source build this is usually +# harmless because $srcdir is `.', but things will broke when you +# start a VPATH build or use an absolute $srcdir. +# +# So we could use something similar to $top_srcdir/$ac_aux_dir/missing, +# iff we strip the leading $srcdir from $ac_aux_dir. That would be: +# am_aux_dir='\$(top_srcdir)/'`expr "$ac_aux_dir" : "$srcdir//*\(.*\)"` +# and then we would define $MISSING as +# MISSING="\${SHELL} $am_aux_dir/missing" +# This will work as long as MISSING is not called from configure, because +# unfortunately $(top_srcdir) has no meaning in configure. +# However there are other variables, like CC, which are often used in +# configure, and could therefore not use this "fixed" $ac_aux_dir. +# +# Another solution, used here, is to always expand $ac_aux_dir to an +# absolute PATH. The drawback is that using absolute paths prevent a +# configured tree to be moved without reconfiguration. + +AC_DEFUN([AM_AUX_DIR_EXPAND], +[dnl Rely on autoconf to set up CDPATH properly. +AC_PREREQ([2.50])dnl +# expand $ac_aux_dir to an absolute path +am_aux_dir=`cd $ac_aux_dir && pwd` +]) + +# AM_CONDITIONAL -*- Autoconf -*- + +# Copyright (C) 1997, 2000, 2001, 2003, 2004, 2005, 2006, 2008 +# Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# serial 9 + +# AM_CONDITIONAL(NAME, SHELL-CONDITION) +# ------------------------------------- +# Define a conditional. +AC_DEFUN([AM_CONDITIONAL], +[AC_PREREQ(2.52)dnl + ifelse([$1], [TRUE], [AC_FATAL([$0: invalid condition: $1])], + [$1], [FALSE], [AC_FATAL([$0: invalid condition: $1])])dnl +AC_SUBST([$1_TRUE])dnl +AC_SUBST([$1_FALSE])dnl +_AM_SUBST_NOTMAKE([$1_TRUE])dnl +_AM_SUBST_NOTMAKE([$1_FALSE])dnl +m4_define([_AM_COND_VALUE_$1], [$2])dnl +if $2; then + $1_TRUE= + $1_FALSE='#' +else + $1_TRUE='#' + $1_FALSE= +fi +AC_CONFIG_COMMANDS_PRE( +[if test -z "${$1_TRUE}" && test -z "${$1_FALSE}"; then + AC_MSG_ERROR([[conditional "$1" was never defined. +Usually this means the macro was only invoked conditionally.]]) +fi])]) + +# Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2009 +# Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# serial 10 + +# There are a few dirty hacks below to avoid letting `AC_PROG_CC' be +# written in clear, in which case automake, when reading aclocal.m4, +# will think it sees a *use*, and therefore will trigger all it's +# C support machinery. Also note that it means that autoscan, seeing +# CC etc. in the Makefile, will ask for an AC_PROG_CC use... + + +# _AM_DEPENDENCIES(NAME) +# ---------------------- +# See how the compiler implements dependency checking. +# NAME is "CC", "CXX", "GCJ", or "OBJC". +# We try a few techniques and use that to set a single cache variable. +# +# We don't AC_REQUIRE the corresponding AC_PROG_CC since the latter was +# modified to invoke _AM_DEPENDENCIES(CC); we would have a circular +# dependency, and given that the user is not expected to run this macro, +# just rely on AC_PROG_CC. +AC_DEFUN([_AM_DEPENDENCIES], +[AC_REQUIRE([AM_SET_DEPDIR])dnl +AC_REQUIRE([AM_OUTPUT_DEPENDENCY_COMMANDS])dnl +AC_REQUIRE([AM_MAKE_INCLUDE])dnl +AC_REQUIRE([AM_DEP_TRACK])dnl + +ifelse([$1], CC, [depcc="$CC" am_compiler_list=], + [$1], CXX, [depcc="$CXX" am_compiler_list=], + [$1], OBJC, [depcc="$OBJC" am_compiler_list='gcc3 gcc'], + [$1], UPC, [depcc="$UPC" am_compiler_list=], + [$1], GCJ, [depcc="$GCJ" am_compiler_list='gcc3 gcc'], + [depcc="$$1" am_compiler_list=]) + +AC_CACHE_CHECK([dependency style of $depcc], + [am_cv_$1_dependencies_compiler_type], +[if test -z "$AMDEP_TRUE" && test -f "$am_depcomp"; then + # We make a subdir and do the tests there. Otherwise we can end up + # making bogus files that we don't know about and never remove. For + # instance it was reported that on HP-UX the gcc test will end up + # making a dummy file named `D' -- because `-MD' means `put the output + # in D'. + mkdir conftest.dir + # Copy depcomp to subdir because otherwise we won't find it if we're + # using a relative directory. + cp "$am_depcomp" conftest.dir + cd conftest.dir + # We will build objects and dependencies in a subdirectory because + # it helps to detect inapplicable dependency modes. For instance + # both Tru64's cc and ICC support -MD to output dependencies as a + # side effect of compilation, but ICC will put the dependencies in + # the current directory while Tru64 will put them in the object + # directory. + mkdir sub + + am_cv_$1_dependencies_compiler_type=none + if test "$am_compiler_list" = ""; then + am_compiler_list=`sed -n ['s/^#*\([a-zA-Z0-9]*\))$/\1/p'] < ./depcomp` + fi + am__universal=false + m4_case([$1], [CC], + [case " $depcc " in #( + *\ -arch\ *\ -arch\ *) am__universal=true ;; + esac], + [CXX], + [case " $depcc " in #( + *\ -arch\ *\ -arch\ *) am__universal=true ;; + esac]) + + for depmode in $am_compiler_list; do + # Setup a source with many dependencies, because some compilers + # like to wrap large dependency lists on column 80 (with \), and + # we should not choose a depcomp mode which is confused by this. + # + # We need to recreate these files for each test, as the compiler may + # overwrite some of them when testing with obscure command lines. + # This happens at least with the AIX C compiler. + : > sub/conftest.c + for i in 1 2 3 4 5 6; do + echo '#include "conftst'$i'.h"' >> sub/conftest.c + # Using `: > sub/conftst$i.h' creates only sub/conftst1.h with + # Solaris 8's {/usr,}/bin/sh. + touch sub/conftst$i.h + done + echo "${am__include} ${am__quote}sub/conftest.Po${am__quote}" > confmf + + # We check with `-c' and `-o' for the sake of the "dashmstdout" + # mode. It turns out that the SunPro C++ compiler does not properly + # handle `-M -o', and we need to detect this. Also, some Intel + # versions had trouble with output in subdirs + am__obj=sub/conftest.${OBJEXT-o} + am__minus_obj="-o $am__obj" + case $depmode in + gcc) + # This depmode causes a compiler race in universal mode. + test "$am__universal" = false || continue + ;; + nosideeffect) + # after this tag, mechanisms are not by side-effect, so they'll + # only be used when explicitly requested + if test "x$enable_dependency_tracking" = xyes; then + continue + else + break + fi + ;; + msvisualcpp | msvcmsys) + # This compiler won't grok `-c -o', but also, the minuso test has + # not run yet. These depmodes are late enough in the game, and + # so weak that their functioning should not be impacted. + am__obj=conftest.${OBJEXT-o} + am__minus_obj= + ;; + none) break ;; + esac + if depmode=$depmode \ + source=sub/conftest.c object=$am__obj \ + depfile=sub/conftest.Po tmpdepfile=sub/conftest.TPo \ + $SHELL ./depcomp $depcc -c $am__minus_obj sub/conftest.c \ + >/dev/null 2>conftest.err && + grep sub/conftst1.h sub/conftest.Po > /dev/null 2>&1 && + grep sub/conftst6.h sub/conftest.Po > /dev/null 2>&1 && + grep $am__obj sub/conftest.Po > /dev/null 2>&1 && + ${MAKE-make} -s -f confmf > /dev/null 2>&1; then + # icc doesn't choke on unknown options, it will just issue warnings + # or remarks (even with -Werror). So we grep stderr for any message + # that says an option was ignored or not supported. + # When given -MP, icc 7.0 and 7.1 complain thusly: + # icc: Command line warning: ignoring option '-M'; no argument required + # The diagnosis changed in icc 8.0: + # icc: Command line remark: option '-MP' not supported + if (grep 'ignoring option' conftest.err || + grep 'not supported' conftest.err) >/dev/null 2>&1; then :; else + am_cv_$1_dependencies_compiler_type=$depmode + break + fi + fi + done + + cd .. + rm -rf conftest.dir +else + am_cv_$1_dependencies_compiler_type=none +fi +]) +AC_SUBST([$1DEPMODE], [depmode=$am_cv_$1_dependencies_compiler_type]) +AM_CONDITIONAL([am__fastdep$1], [ + test "x$enable_dependency_tracking" != xno \ + && test "$am_cv_$1_dependencies_compiler_type" = gcc3]) +]) + + +# AM_SET_DEPDIR +# ------------- +# Choose a directory name for dependency files. +# This macro is AC_REQUIREd in _AM_DEPENDENCIES +AC_DEFUN([AM_SET_DEPDIR], +[AC_REQUIRE([AM_SET_LEADING_DOT])dnl +AC_SUBST([DEPDIR], ["${am__leading_dot}deps"])dnl +]) + + +# AM_DEP_TRACK +# ------------ +AC_DEFUN([AM_DEP_TRACK], +[AC_ARG_ENABLE(dependency-tracking, +[ --disable-dependency-tracking speeds up one-time build + --enable-dependency-tracking do not reject slow dependency extractors]) +if test "x$enable_dependency_tracking" != xno; then + am_depcomp="$ac_aux_dir/depcomp" + AMDEPBACKSLASH='\' +fi +AM_CONDITIONAL([AMDEP], [test "x$enable_dependency_tracking" != xno]) +AC_SUBST([AMDEPBACKSLASH])dnl +_AM_SUBST_NOTMAKE([AMDEPBACKSLASH])dnl +]) + +# Generate code to set up dependency tracking. -*- Autoconf -*- + +# Copyright (C) 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2008 +# Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +#serial 5 + +# _AM_OUTPUT_DEPENDENCY_COMMANDS +# ------------------------------ +AC_DEFUN([_AM_OUTPUT_DEPENDENCY_COMMANDS], +[{ + # Autoconf 2.62 quotes --file arguments for eval, but not when files + # are listed without --file. Let's play safe and only enable the eval + # if we detect the quoting. + case $CONFIG_FILES in + *\'*) eval set x "$CONFIG_FILES" ;; + *) set x $CONFIG_FILES ;; + esac + shift + for mf + do + # Strip MF so we end up with the name of the file. + mf=`echo "$mf" | sed -e 's/:.*$//'` + # Check whether this is an Automake generated Makefile or not. + # We used to match only the files named `Makefile.in', but + # some people rename them; so instead we look at the file content. + # Grep'ing the first line is not enough: some people post-process + # each Makefile.in and add a new line on top of each file to say so. + # Grep'ing the whole file is not good either: AIX grep has a line + # limit of 2048, but all sed's we know have understand at least 4000. + if sed -n 's,^#.*generated by automake.*,X,p' "$mf" | grep X >/dev/null 2>&1; then + dirpart=`AS_DIRNAME("$mf")` + else + continue + fi + # Extract the definition of DEPDIR, am__include, and am__quote + # from the Makefile without running `make'. + DEPDIR=`sed -n 's/^DEPDIR = //p' < "$mf"` + test -z "$DEPDIR" && continue + am__include=`sed -n 's/^am__include = //p' < "$mf"` + test -z "am__include" && continue + am__quote=`sed -n 's/^am__quote = //p' < "$mf"` + # When using ansi2knr, U may be empty or an underscore; expand it + U=`sed -n 's/^U = //p' < "$mf"` + # Find all dependency output files, they are included files with + # $(DEPDIR) in their names. We invoke sed twice because it is the + # simplest approach to changing $(DEPDIR) to its actual value in the + # expansion. + for file in `sed -n " + s/^$am__include $am__quote\(.*(DEPDIR).*\)$am__quote"'$/\1/p' <"$mf" | \ + sed -e 's/\$(DEPDIR)/'"$DEPDIR"'/g' -e 's/\$U/'"$U"'/g'`; do + # Make sure the directory exists. + test -f "$dirpart/$file" && continue + fdir=`AS_DIRNAME(["$file"])` + AS_MKDIR_P([$dirpart/$fdir]) + # echo "creating $dirpart/$file" + echo '# dummy' > "$dirpart/$file" + done + done +} +])# _AM_OUTPUT_DEPENDENCY_COMMANDS + + +# AM_OUTPUT_DEPENDENCY_COMMANDS +# ----------------------------- +# This macro should only be invoked once -- use via AC_REQUIRE. +# +# This code is only required when automatic dependency tracking +# is enabled. FIXME. This creates each `.P' file that we will +# need in order to bootstrap the dependency handling code. +AC_DEFUN([AM_OUTPUT_DEPENDENCY_COMMANDS], +[AC_CONFIG_COMMANDS([depfiles], + [test x"$AMDEP_TRUE" != x"" || _AM_OUTPUT_DEPENDENCY_COMMANDS], + [AMDEP_TRUE="$AMDEP_TRUE" ac_aux_dir="$ac_aux_dir"]) +]) + +# Copyright (C) 1996, 1997, 2000, 2001, 2003, 2005 +# Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# serial 8 + +# AM_CONFIG_HEADER is obsolete. It has been replaced by AC_CONFIG_HEADERS. +AU_DEFUN([AM_CONFIG_HEADER], [AC_CONFIG_HEADERS($@)]) + +# Do all the work for Automake. -*- Autoconf -*- + +# Copyright (C) 1996, 1997, 1998, 1999, 2000, 2001, 2002, 2003, 2004, +# 2005, 2006, 2008, 2009 Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# serial 16 + +# This macro actually does too much. Some checks are only needed if +# your package does certain things. But this isn't really a big deal. + +# AM_INIT_AUTOMAKE(PACKAGE, VERSION, [NO-DEFINE]) +# AM_INIT_AUTOMAKE([OPTIONS]) +# ----------------------------------------------- +# The call with PACKAGE and VERSION arguments is the old style +# call (pre autoconf-2.50), which is being phased out. PACKAGE +# and VERSION should now be passed to AC_INIT and removed from +# the call to AM_INIT_AUTOMAKE. +# We support both call styles for the transition. After +# the next Automake release, Autoconf can make the AC_INIT +# arguments mandatory, and then we can depend on a new Autoconf +# release and drop the old call support. +AC_DEFUN([AM_INIT_AUTOMAKE], +[AC_PREREQ([2.62])dnl +dnl Autoconf wants to disallow AM_ names. We explicitly allow +dnl the ones we care about. +m4_pattern_allow([^AM_[A-Z]+FLAGS$])dnl +AC_REQUIRE([AM_SET_CURRENT_AUTOMAKE_VERSION])dnl +AC_REQUIRE([AC_PROG_INSTALL])dnl +if test "`cd $srcdir && pwd`" != "`pwd`"; then + # Use -I$(srcdir) only when $(srcdir) != ., so that make's output + # is not polluted with repeated "-I." + AC_SUBST([am__isrc], [' -I$(srcdir)'])_AM_SUBST_NOTMAKE([am__isrc])dnl + # test to see if srcdir already configured + if test -f $srcdir/config.status; then + AC_MSG_ERROR([source directory already configured; run "make distclean" there first]) + fi +fi + +# test whether we have cygpath +if test -z "$CYGPATH_W"; then + if (cygpath --version) >/dev/null 2>/dev/null; then + CYGPATH_W='cygpath -w' + else + CYGPATH_W=echo + fi +fi +AC_SUBST([CYGPATH_W]) + +# Define the identity of the package. +dnl Distinguish between old-style and new-style calls. +m4_ifval([$2], +[m4_ifval([$3], [_AM_SET_OPTION([no-define])])dnl + AC_SUBST([PACKAGE], [$1])dnl + AC_SUBST([VERSION], [$2])], +[_AM_SET_OPTIONS([$1])dnl +dnl Diagnose old-style AC_INIT with new-style AM_AUTOMAKE_INIT. +m4_if(m4_ifdef([AC_PACKAGE_NAME], 1)m4_ifdef([AC_PACKAGE_VERSION], 1), 11,, + [m4_fatal([AC_INIT should be called with package and version arguments])])dnl + AC_SUBST([PACKAGE], ['AC_PACKAGE_TARNAME'])dnl + AC_SUBST([VERSION], ['AC_PACKAGE_VERSION'])])dnl + +_AM_IF_OPTION([no-define],, +[AC_DEFINE_UNQUOTED(PACKAGE, "$PACKAGE", [Name of package]) + AC_DEFINE_UNQUOTED(VERSION, "$VERSION", [Version number of package])])dnl + +# Some tools Automake needs. +AC_REQUIRE([AM_SANITY_CHECK])dnl +AC_REQUIRE([AC_ARG_PROGRAM])dnl +AM_MISSING_PROG(ACLOCAL, aclocal-${am__api_version}) +AM_MISSING_PROG(AUTOCONF, autoconf) +AM_MISSING_PROG(AUTOMAKE, automake-${am__api_version}) +AM_MISSING_PROG(AUTOHEADER, autoheader) +AM_MISSING_PROG(MAKEINFO, makeinfo) +AC_REQUIRE([AM_PROG_INSTALL_SH])dnl +AC_REQUIRE([AM_PROG_INSTALL_STRIP])dnl +AC_REQUIRE([AM_PROG_MKDIR_P])dnl +# We need awk for the "check" target. The system "awk" is bad on +# some platforms. +AC_REQUIRE([AC_PROG_AWK])dnl +AC_REQUIRE([AC_PROG_MAKE_SET])dnl +AC_REQUIRE([AM_SET_LEADING_DOT])dnl +_AM_IF_OPTION([tar-ustar], [_AM_PROG_TAR([ustar])], + [_AM_IF_OPTION([tar-pax], [_AM_PROG_TAR([pax])], + [_AM_PROG_TAR([v7])])]) +_AM_IF_OPTION([no-dependencies],, +[AC_PROVIDE_IFELSE([AC_PROG_CC], + [_AM_DEPENDENCIES(CC)], + [define([AC_PROG_CC], + defn([AC_PROG_CC])[_AM_DEPENDENCIES(CC)])])dnl +AC_PROVIDE_IFELSE([AC_PROG_CXX], + [_AM_DEPENDENCIES(CXX)], + [define([AC_PROG_CXX], + defn([AC_PROG_CXX])[_AM_DEPENDENCIES(CXX)])])dnl +AC_PROVIDE_IFELSE([AC_PROG_OBJC], + [_AM_DEPENDENCIES(OBJC)], + [define([AC_PROG_OBJC], + defn([AC_PROG_OBJC])[_AM_DEPENDENCIES(OBJC)])])dnl +]) +_AM_IF_OPTION([silent-rules], [AC_REQUIRE([AM_SILENT_RULES])])dnl +dnl The `parallel-tests' driver may need to know about EXEEXT, so add the +dnl `am__EXEEXT' conditional if _AM_COMPILER_EXEEXT was seen. This macro +dnl is hooked onto _AC_COMPILER_EXEEXT early, see below. +AC_CONFIG_COMMANDS_PRE(dnl +[m4_provide_if([_AM_COMPILER_EXEEXT], + [AM_CONDITIONAL([am__EXEEXT], [test -n "$EXEEXT"])])])dnl +]) + +dnl Hook into `_AC_COMPILER_EXEEXT' early to learn its expansion. Do not +dnl add the conditional right here, as _AC_COMPILER_EXEEXT may be further +dnl mangled by Autoconf and run in a shell conditional statement. +m4_define([_AC_COMPILER_EXEEXT], +m4_defn([_AC_COMPILER_EXEEXT])[m4_provide([_AM_COMPILER_EXEEXT])]) + + +# When config.status generates a header, we must update the stamp-h file. +# This file resides in the same directory as the config header +# that is generated. The stamp files are numbered to have different names. + +# Autoconf calls _AC_AM_CONFIG_HEADER_HOOK (when defined) in the +# loop where config.status creates the headers, so we can generate +# our stamp files there. +AC_DEFUN([_AC_AM_CONFIG_HEADER_HOOK], +[# Compute $1's index in $config_headers. +_am_arg=$1 +_am_stamp_count=1 +for _am_header in $config_headers :; do + case $_am_header in + $_am_arg | $_am_arg:* ) + break ;; + * ) + _am_stamp_count=`expr $_am_stamp_count + 1` ;; + esac +done +echo "timestamp for $_am_arg" >`AS_DIRNAME(["$_am_arg"])`/stamp-h[]$_am_stamp_count]) + +# Copyright (C) 2001, 2003, 2005, 2008 Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# AM_PROG_INSTALL_SH +# ------------------ +# Define $install_sh. +AC_DEFUN([AM_PROG_INSTALL_SH], +[AC_REQUIRE([AM_AUX_DIR_EXPAND])dnl +if test x"${install_sh}" != xset; then + case $am_aux_dir in + *\ * | *\ *) + install_sh="\${SHELL} '$am_aux_dir/install-sh'" ;; + *) + install_sh="\${SHELL} $am_aux_dir/install-sh" + esac +fi +AC_SUBST(install_sh)]) + +# Copyright (C) 2003, 2005 Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# serial 2 + +# Check whether the underlying file-system supports filenames +# with a leading dot. For instance MS-DOS doesn't. +AC_DEFUN([AM_SET_LEADING_DOT], +[rm -rf .tst 2>/dev/null +mkdir .tst 2>/dev/null +if test -d .tst; then + am__leading_dot=. +else + am__leading_dot=_ +fi +rmdir .tst 2>/dev/null +AC_SUBST([am__leading_dot])]) + +# Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2005 +# Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# serial 5 + +# AM_PROG_LEX +# ----------- +# Autoconf leaves LEX=: if lex or flex can't be found. Change that to a +# "missing" invocation, for better error output. +AC_DEFUN([AM_PROG_LEX], +[AC_PREREQ(2.50)dnl +AC_REQUIRE([AM_MISSING_HAS_RUN])dnl +AC_REQUIRE([AC_PROG_LEX])dnl +if test "$LEX" = :; then + LEX=${am_missing_run}flex +fi]) + +# Check to see how 'make' treats includes. -*- Autoconf -*- + +# Copyright (C) 2001, 2002, 2003, 2005, 2009 Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# serial 4 + +# AM_MAKE_INCLUDE() +# ----------------- +# Check to see how make treats includes. +AC_DEFUN([AM_MAKE_INCLUDE], +[am_make=${MAKE-make} +cat > confinc << 'END' +am__doit: + @echo this is the am__doit target +.PHONY: am__doit +END +# If we don't find an include directive, just comment out the code. +AC_MSG_CHECKING([for style of include used by $am_make]) +am__include="#" +am__quote= +_am_result=none +# First try GNU make style include. +echo "include confinc" > confmf +# Ignore all kinds of additional output from `make'. +case `$am_make -s -f confmf 2> /dev/null` in #( +*the\ am__doit\ target*) + am__include=include + am__quote= + _am_result=GNU + ;; +esac +# Now try BSD make style include. +if test "$am__include" = "#"; then + echo '.include "confinc"' > confmf + case `$am_make -s -f confmf 2> /dev/null` in #( + *the\ am__doit\ target*) + am__include=.include + am__quote="\"" + _am_result=BSD + ;; + esac +fi +AC_SUBST([am__include]) +AC_SUBST([am__quote]) +AC_MSG_RESULT([$_am_result]) +rm -f confinc confmf +]) + +# Copyright (C) 1999, 2000, 2001, 2003, 2004, 2005, 2008 +# Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# serial 6 + +# AM_PROG_CC_C_O +# -------------- +# Like AC_PROG_CC_C_O, but changed for automake. +AC_DEFUN([AM_PROG_CC_C_O], +[AC_REQUIRE([AC_PROG_CC_C_O])dnl +AC_REQUIRE([AM_AUX_DIR_EXPAND])dnl +AC_REQUIRE_AUX_FILE([compile])dnl +# FIXME: we rely on the cache variable name because +# there is no other way. +set dummy $CC +am_cc=`echo $[2] | sed ['s/[^a-zA-Z0-9_]/_/g;s/^[0-9]/_/']` +eval am_t=\$ac_cv_prog_cc_${am_cc}_c_o +if test "$am_t" != yes; then + # Losing compiler, so override with the script. + # FIXME: It is wrong to rewrite CC. + # But if we don't then we get into trouble of one sort or another. + # A longer-term fix would be to have automake use am__CC in this case, + # and then we could set am__CC="\$(top_srcdir)/compile \$(CC)" + CC="$am_aux_dir/compile $CC" +fi +dnl Make sure AC_PROG_CC is never called again, or it will override our +dnl setting of CC. +m4_define([AC_PROG_CC], + [m4_fatal([AC_PROG_CC cannot be called after AM_PROG_CC_C_O])]) +]) + +# Fake the existence of programs that GNU maintainers use. -*- Autoconf -*- + +# Copyright (C) 1997, 1999, 2000, 2001, 2003, 2004, 2005, 2008 +# Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# serial 6 + +# AM_MISSING_PROG(NAME, PROGRAM) +# ------------------------------ +AC_DEFUN([AM_MISSING_PROG], +[AC_REQUIRE([AM_MISSING_HAS_RUN]) +$1=${$1-"${am_missing_run}$2"} +AC_SUBST($1)]) + + +# AM_MISSING_HAS_RUN +# ------------------ +# Define MISSING if not defined so far and test if it supports --run. +# If it does, set am_missing_run to use it, otherwise, to nothing. +AC_DEFUN([AM_MISSING_HAS_RUN], +[AC_REQUIRE([AM_AUX_DIR_EXPAND])dnl +AC_REQUIRE_AUX_FILE([missing])dnl +if test x"${MISSING+set}" != xset; then + case $am_aux_dir in + *\ * | *\ *) + MISSING="\${SHELL} \"$am_aux_dir/missing\"" ;; + *) + MISSING="\${SHELL} $am_aux_dir/missing" ;; + esac +fi +# Use eval to expand $SHELL +if eval "$MISSING --run true"; then + am_missing_run="$MISSING --run " +else + am_missing_run= + AC_MSG_WARN([`missing' script is too old or missing]) +fi +]) + +# Copyright (C) 2003, 2004, 2005, 2006 Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# AM_PROG_MKDIR_P +# --------------- +# Check for `mkdir -p'. +AC_DEFUN([AM_PROG_MKDIR_P], +[AC_PREREQ([2.60])dnl +AC_REQUIRE([AC_PROG_MKDIR_P])dnl +dnl Automake 1.8 to 1.9.6 used to define mkdir_p. We now use MKDIR_P, +dnl while keeping a definition of mkdir_p for backward compatibility. +dnl @MKDIR_P@ is magic: AC_OUTPUT adjusts its value for each Makefile. +dnl However we cannot define mkdir_p as $(MKDIR_P) for the sake of +dnl Makefile.ins that do not define MKDIR_P, so we do our own +dnl adjustment using top_builddir (which is defined more often than +dnl MKDIR_P). +AC_SUBST([mkdir_p], ["$MKDIR_P"])dnl +case $mkdir_p in + [[\\/$]]* | ?:[[\\/]]*) ;; + */*) mkdir_p="\$(top_builddir)/$mkdir_p" ;; +esac +]) + +# Helper functions for option handling. -*- Autoconf -*- + +# Copyright (C) 2001, 2002, 2003, 2005, 2008 Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# serial 4 + +# _AM_MANGLE_OPTION(NAME) +# ----------------------- +AC_DEFUN([_AM_MANGLE_OPTION], +[[_AM_OPTION_]m4_bpatsubst($1, [[^a-zA-Z0-9_]], [_])]) + +# _AM_SET_OPTION(NAME) +# ------------------------------ +# Set option NAME. Presently that only means defining a flag for this option. +AC_DEFUN([_AM_SET_OPTION], +[m4_define(_AM_MANGLE_OPTION([$1]), 1)]) + +# _AM_SET_OPTIONS(OPTIONS) +# ---------------------------------- +# OPTIONS is a space-separated list of Automake options. +AC_DEFUN([_AM_SET_OPTIONS], +[m4_foreach_w([_AM_Option], [$1], [_AM_SET_OPTION(_AM_Option)])]) + +# _AM_IF_OPTION(OPTION, IF-SET, [IF-NOT-SET]) +# ------------------------------------------- +# Execute IF-SET if OPTION is set, IF-NOT-SET otherwise. +AC_DEFUN([_AM_IF_OPTION], +[m4_ifset(_AM_MANGLE_OPTION([$1]), [$2], [$3])]) + +# Check to make sure that the build environment is sane. -*- Autoconf -*- + +# Copyright (C) 1996, 1997, 2000, 2001, 2003, 2005, 2008 +# Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# serial 5 + +# AM_SANITY_CHECK +# --------------- +AC_DEFUN([AM_SANITY_CHECK], +[AC_MSG_CHECKING([whether build environment is sane]) +# Just in case +sleep 1 +echo timestamp > conftest.file +# Reject unsafe characters in $srcdir or the absolute working directory +# name. Accept space and tab only in the latter. +am_lf=' +' +case `pwd` in + *[[\\\"\#\$\&\'\`$am_lf]]*) + AC_MSG_ERROR([unsafe absolute working directory name]);; +esac +case $srcdir in + *[[\\\"\#\$\&\'\`$am_lf\ \ ]]*) + AC_MSG_ERROR([unsafe srcdir value: `$srcdir']);; +esac + +# Do `set' in a subshell so we don't clobber the current shell's +# arguments. Must try -L first in case configure is actually a +# symlink; some systems play weird games with the mod time of symlinks +# (eg FreeBSD returns the mod time of the symlink's containing +# directory). +if ( + set X `ls -Lt "$srcdir/configure" conftest.file 2> /dev/null` + if test "$[*]" = "X"; then + # -L didn't work. + set X `ls -t "$srcdir/configure" conftest.file` + fi + rm -f conftest.file + if test "$[*]" != "X $srcdir/configure conftest.file" \ + && test "$[*]" != "X conftest.file $srcdir/configure"; then + + # If neither matched, then we have a broken ls. This can happen + # if, for instance, CONFIG_SHELL is bash and it inherits a + # broken ls alias from the environment. This has actually + # happened. Such a system could not be considered "sane". + AC_MSG_ERROR([ls -t appears to fail. Make sure there is not a broken +alias in your environment]) + fi + + test "$[2]" = conftest.file + ) +then + # Ok. + : +else + AC_MSG_ERROR([newly created file is older than distributed files! +Check your system clock]) +fi +AC_MSG_RESULT(yes)]) + +# Copyright (C) 2001, 2003, 2005 Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# AM_PROG_INSTALL_STRIP +# --------------------- +# One issue with vendor `install' (even GNU) is that you can't +# specify the program used to strip binaries. This is especially +# annoying in cross-compiling environments, where the build's strip +# is unlikely to handle the host's binaries. +# Fortunately install-sh will honor a STRIPPROG variable, so we +# always use install-sh in `make install-strip', and initialize +# STRIPPROG with the value of the STRIP variable (set by the user). +AC_DEFUN([AM_PROG_INSTALL_STRIP], +[AC_REQUIRE([AM_PROG_INSTALL_SH])dnl +# Installed binaries are usually stripped using `strip' when the user +# run `make install-strip'. However `strip' might not be the right +# tool to use in cross-compilation environments, therefore Automake +# will honor the `STRIP' environment variable to overrule this program. +dnl Don't test for $cross_compiling = yes, because it might be `maybe'. +if test "$cross_compiling" != no; then + AC_CHECK_TOOL([STRIP], [strip], :) +fi +INSTALL_STRIP_PROGRAM="\$(install_sh) -c -s" +AC_SUBST([INSTALL_STRIP_PROGRAM])]) + +# Copyright (C) 2006, 2008 Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# serial 2 + +# _AM_SUBST_NOTMAKE(VARIABLE) +# --------------------------- +# Prevent Automake from outputting VARIABLE = @VARIABLE@ in Makefile.in. +# This macro is traced by Automake. +AC_DEFUN([_AM_SUBST_NOTMAKE]) + +# AM_SUBST_NOTMAKE(VARIABLE) +# --------------------------- +# Public sister of _AM_SUBST_NOTMAKE. +AC_DEFUN([AM_SUBST_NOTMAKE], [_AM_SUBST_NOTMAKE($@)]) + +# Check how to create a tarball. -*- Autoconf -*- + +# Copyright (C) 2004, 2005 Free Software Foundation, Inc. +# +# This file is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# serial 2 + +# _AM_PROG_TAR(FORMAT) +# -------------------- +# Check how to create a tarball in format FORMAT. +# FORMAT should be one of `v7', `ustar', or `pax'. +# +# Substitute a variable $(am__tar) that is a command +# writing to stdout a FORMAT-tarball containing the directory +# $tardir. +# tardir=directory && $(am__tar) > result.tar +# +# Substitute a variable $(am__untar) that extract such +# a tarball read from stdin. +# $(am__untar) < result.tar +AC_DEFUN([_AM_PROG_TAR], +[# Always define AMTAR for backward compatibility. +AM_MISSING_PROG([AMTAR], [tar]) +m4_if([$1], [v7], + [am__tar='${AMTAR} chof - "$$tardir"'; am__untar='${AMTAR} xf -'], + [m4_case([$1], [ustar],, [pax],, + [m4_fatal([Unknown tar format])]) +AC_MSG_CHECKING([how to create a $1 tar archive]) +# Loop over all known methods to create a tar archive until one works. +_am_tools='gnutar m4_if([$1], [ustar], [plaintar]) pax cpio none' +_am_tools=${am_cv_prog_tar_$1-$_am_tools} +# Do not fold the above two line into one, because Tru64 sh and +# Solaris sh will not grok spaces in the rhs of `-'. +for _am_tool in $_am_tools +do + case $_am_tool in + gnutar) + for _am_tar in tar gnutar gtar; + do + AM_RUN_LOG([$_am_tar --version]) && break + done + am__tar="$_am_tar --format=m4_if([$1], [pax], [posix], [$1]) -chf - "'"$$tardir"' + am__tar_="$_am_tar --format=m4_if([$1], [pax], [posix], [$1]) -chf - "'"$tardir"' + am__untar="$_am_tar -xf -" + ;; + plaintar) + # Must skip GNU tar: if it does not support --format= it doesn't create + # ustar tarball either. + (tar --version) >/dev/null 2>&1 && continue + am__tar='tar chf - "$$tardir"' + am__tar_='tar chf - "$tardir"' + am__untar='tar xf -' + ;; + pax) + am__tar='pax -L -x $1 -w "$$tardir"' + am__tar_='pax -L -x $1 -w "$tardir"' + am__untar='pax -r' + ;; + cpio) + am__tar='find "$$tardir" -print | cpio -o -H $1 -L' + am__tar_='find "$tardir" -print | cpio -o -H $1 -L' + am__untar='cpio -i -H $1 -d' + ;; + none) + am__tar=false + am__tar_=false + am__untar=false + ;; + esac + + # If the value was cached, stop now. We just wanted to have am__tar + # and am__untar set. + test -n "${am_cv_prog_tar_$1}" && break + + # tar/untar a dummy directory, and stop if the command works + rm -rf conftest.dir + mkdir conftest.dir + echo GrepMe > conftest.dir/file + AM_RUN_LOG([tardir=conftest.dir && eval $am__tar_ >conftest.tar]) + rm -rf conftest.dir + if test -s conftest.tar; then + AM_RUN_LOG([$am__untar /dev/null 2>&1 && break + fi +done +rm -rf conftest.dir + +AC_CACHE_VAL([am_cv_prog_tar_$1], [am_cv_prog_tar_$1=$_am_tool]) +AC_MSG_RESULT([$am_cv_prog_tar_$1])]) +AC_SUBST([am__tar]) +AC_SUBST([am__untar]) +]) # _AM_PROG_TAR + diff --git a/libconfig-1.4.9/aux-build/compile b/libconfig-1.4.9/aux-build/compile new file mode 100755 index 0000000000000000000000000000000000000000..c0096a7b563231c0c7ade728962574ec3b8df270 --- /dev/null +++ b/libconfig-1.4.9/aux-build/compile @@ -0,0 +1,143 @@ +#! /bin/sh +# Wrapper for compilers which do not understand `-c -o'. + +scriptversion=2009-10-06.20; # UTC + +# Copyright (C) 1999, 2000, 2003, 2004, 2005, 2009 Free Software +# Foundation, Inc. +# Written by Tom Tromey . +# +# This program is free software; you can redistribute it and/or modify +# it under the terms of the GNU General Public License as published by +# the Free Software Foundation; either version 2, or (at your option) +# any later version. +# +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY; without even the implied warranty of +# MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +# GNU General Public License for more details. +# +# You should have received a copy of the GNU General Public License +# along with this program. If not, see . + +# As a special exception to the GNU General Public License, if you +# distribute this file as part of a program that contains a +# configuration script generated by Autoconf, you may include it under +# the same distribution terms that you use for the rest of that program. + +# This file is maintained in Automake, please report +# bugs to or send patches to +# . + +case $1 in + '') + echo "$0: No command. Try \`$0 --help' for more information." 1>&2 + exit 1; + ;; + -h | --h*) + cat <<\EOF +Usage: compile [--help] [--version] PROGRAM [ARGS] + +Wrapper for compilers which do not understand `-c -o'. +Remove `-o dest.o' from ARGS, run PROGRAM with the remaining +arguments, and rename the output as expected. + +If you are trying to build a whole package this is not the +right script to run: please start by reading the file `INSTALL'. + +Report bugs to . +EOF + exit $? + ;; + -v | --v*) + echo "compile $scriptversion" + exit $? + ;; +esac + +ofile= +cfile= +eat= + +for arg +do + if test -n "$eat"; then + eat= + else + case $1 in + -o) + # configure might choose to run compile as `compile cc -o foo foo.c'. + # So we strip `-o arg' only if arg is an object. + eat=1 + case $2 in + *.o | *.obj) + ofile=$2 + ;; + *) + set x "$@" -o "$2" + shift + ;; + esac + ;; + *.c) + cfile=$1 + set x "$@" "$1" + shift + ;; + *) + set x "$@" "$1" + shift + ;; + esac + fi + shift +done + +if test -z "$ofile" || test -z "$cfile"; then + # If no `-o' option was seen then we might have been invoked from a + # pattern rule where we don't need one. That is ok -- this is a + # normal compilation that the losing compiler can handle. If no + # `.c' file was seen then we are probably linking. That is also + # ok. + exec "$@" +fi + +# Name of file we expect compiler to create. +cofile=`echo "$cfile" | sed 's|^.*[\\/]||; s|^[a-zA-Z]:||; s/\.c$/.o/'` + +# Create the lock directory. +# Note: use `[/\\:.-]' here to ensure that we don't use the same name +# that we are using for the .o file. Also, base the name on the expected +# object file name, since that is what matters with a parallel build. +lockdir=`echo "$cofile" | sed -e 's|[/\\:.-]|_|g'`.d +while true; do + if mkdir "$lockdir" >/dev/null 2>&1; then + break + fi + sleep 1 +done +# FIXME: race condition here if user kills between mkdir and trap. +trap "rmdir '$lockdir'; exit 1" 1 2 15 + +# Run the compile. +"$@" +ret=$? + +if test -f "$cofile"; then + test "$cofile" = "$ofile" || mv "$cofile" "$ofile" +elif test -f "${cofile}bj"; then + test "${cofile}bj" = "$ofile" || mv "${cofile}bj" "$ofile" +fi + +rmdir "$lockdir" +exit $ret + +# Local Variables: +# mode: shell-script +# sh-indentation: 2 +# eval: (add-hook 'write-file-hooks 'time-stamp) +# time-stamp-start: "scriptversion=" +# time-stamp-format: "%:y-%02m-%02d.%02H" +# time-stamp-time-zone: "UTC" +# time-stamp-end: "; # UTC" +# End: diff --git a/libconfig-1.4.9/aux-build/config.guess b/libconfig-1.4.9/aux-build/config.guess new file mode 100755 index 0000000000000000000000000000000000000000..fb9a2bade594e1841845e8518af6860577d2d39c --- /dev/null +++ b/libconfig-1.4.9/aux-build/config.guess @@ -0,0 +1,1325 @@ +#! /bin/sh +# Attempt to guess a canonical system name. +# Copyright (C) 1992, 1993, 1994, 1995, 1996, 1997, 1998, 1999, +# 2000, 2001, 2002 Free Software Foundation, Inc. + +timestamp='2002-05-29' + +# This file is free software; you can redistribute it and/or modify it +# under the terms of the GNU General Public License as published by +# the Free Software Foundation; either version 2 of the License, or +# (at your option) any later version. +# +# This program is distributed in the hope that it will be useful, but +# WITHOUT ANY WARRANTY; without even the implied warranty of +# MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU +# General Public License for more details. +# +# You should have received a copy of the GNU General Public License +# along with this program; if not, write to the Free Software +# Foundation, Inc., 59 Temple Place - Suite 330, Boston, MA 02111-1307, USA. +# +# As a special exception to the GNU General Public License, if you +# distribute this file as part of a program that contains a +# configuration script generated by Autoconf, you may include it under +# the same distribution terms that you use for the rest of that program. + +# Originally written by Per Bothner . +# Please send patches to . Submit a context +# diff and a properly formatted ChangeLog entry. +# +# This script attempts to guess a canonical system name similar to +# config.sub. If it succeeds, it prints the system name on stdout, and +# exits with 0. Otherwise, it exits with 1. +# +# The plan is that this can be called by configure scripts if you +# don't specify an explicit build system type. + +me=`echo "$0" | sed -e 's,.*/,,'` + +usage="\ +Usage: $0 [OPTION] + +Output the configuration name of the system \`$me' is run on. + +Operation modes: + -h, --help print this help, then exit + -t, --time-stamp print date of last modification, then exit + -v, --version print version number, then exit + +Report bugs and patches to ." + +version="\ +GNU config.guess ($timestamp) + +Originally written by Per Bothner. +Copyright (C) 1992, 1993, 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001 +Free Software Foundation, Inc. + +This is free software; see the source for copying conditions. There is NO +warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE." + +help=" +Try \`$me --help' for more information." + +# Parse command line +while test $# -gt 0 ; do + case $1 in + --time-stamp | --time* | -t ) + echo "$timestamp" ; exit 0 ;; + --version | -v ) + echo "$version" ; exit 0 ;; + --help | --h* | -h ) + echo "$usage"; exit 0 ;; + -- ) # Stop option processing + shift; break ;; + - ) # Use stdin as input. + break ;; + -* ) + echo "$me: invalid option $1$help" >&2 + exit 1 ;; + * ) + break ;; + esac +done + +if test $# != 0; then + echo "$me: too many arguments$help" >&2 + exit 1 +fi + + +dummy=dummy-$$ +trap 'rm -f $dummy.c $dummy.o $dummy.rel $dummy; exit 1' 1 2 15 + +# CC_FOR_BUILD -- compiler used by this script. +# Historically, `CC_FOR_BUILD' used to be named `HOST_CC'. We still +# use `HOST_CC' if defined, but it is deprecated. + +set_cc_for_build='case $CC_FOR_BUILD,$HOST_CC,$CC in + ,,) echo "int dummy(){}" > $dummy.c ; + for c in cc gcc c89 c99 ; do + ($c $dummy.c -c -o $dummy.o) >/dev/null 2>&1 ; + if test $? = 0 ; then + CC_FOR_BUILD="$c"; break ; + fi ; + done ; + rm -f $dummy.c $dummy.o $dummy.rel ; + if test x"$CC_FOR_BUILD" = x ; then + CC_FOR_BUILD=no_compiler_found ; + fi + ;; + ,,*) CC_FOR_BUILD=$CC ;; + ,*,*) CC_FOR_BUILD=$HOST_CC ;; +esac' + +# This is needed to find uname on a Pyramid OSx when run in the BSD universe. +# (ghazi@noc.rutgers.edu 1994-08-24) +if (test -f /.attbin/uname) >/dev/null 2>&1 ; then + PATH=$PATH:/.attbin ; export PATH +fi + +UNAME_MACHINE=`(uname -m) 2>/dev/null` || UNAME_MACHINE=unknown +UNAME_RELEASE=`(uname -r) 2>/dev/null` || UNAME_RELEASE=unknown +UNAME_SYSTEM=`(uname -s) 2>/dev/null` || UNAME_SYSTEM=unknown +UNAME_VERSION=`(uname -v) 2>/dev/null` || UNAME_VERSION=unknown + +# Note: order is significant - the case branches are not exclusive. + +case "${UNAME_MACHINE}:${UNAME_SYSTEM}:${UNAME_RELEASE}:${UNAME_VERSION}" in + *:NetBSD:*:*) + # NetBSD (nbsd) targets should (where applicable) match one or + # more of the tupples: *-*-netbsdelf*, *-*-netbsdaout*, + # *-*-netbsdecoff* and *-*-netbsd*. For targets that recently + # switched to ELF, *-*-netbsd* would select the old + # object file format. This provides both forward + # compatibility and a consistent mechanism for selecting the + # object file format. + # + # Note: NetBSD doesn't particularly care about the vendor + # portion of the name. We always set it to "unknown". + sysctl="sysctl -n hw.machine_arch" + UNAME_MACHINE_ARCH=`(/sbin/$sysctl 2>/dev/null || \ + /usr/sbin/$sysctl 2>/dev/null || echo unknown)` + case "${UNAME_MACHINE_ARCH}" in + armeb) machine=armeb-unknown ;; + arm*) machine=arm-unknown ;; + sh3el) machine=shl-unknown ;; + sh3eb) machine=sh-unknown ;; + *) machine=${UNAME_MACHINE_ARCH}-unknown ;; + esac + # The Operating System including object format, if it has switched + # to ELF recently, or will in the future. + case "${UNAME_MACHINE_ARCH}" in + arm*|i386|m68k|ns32k|sh3*|sparc|vax) + eval $set_cc_for_build + if echo __ELF__ | $CC_FOR_BUILD -E - 2>/dev/null \ + | grep __ELF__ >/dev/null + then + # Once all utilities can be ECOFF (netbsdecoff) or a.out (netbsdaout). + # Return netbsd for either. FIX? + os=netbsd + else + os=netbsdelf + fi + ;; + *) + os=netbsd + ;; + esac + # The OS release + release=`echo ${UNAME_RELEASE}|sed -e 's/[-_].*/\./'` + # Since CPU_TYPE-MANUFACTURER-KERNEL-OPERATING_SYSTEM: + # contains redundant information, the shorter form: + # CPU_TYPE-MANUFACTURER-OPERATING_SYSTEM is used. + echo "${machine}-${os}${release}" + exit 0 ;; + amiga:OpenBSD:*:*) + echo m68k-unknown-openbsd${UNAME_RELEASE} + exit 0 ;; + arc:OpenBSD:*:*) + echo mipsel-unknown-openbsd${UNAME_RELEASE} + exit 0 ;; + hp300:OpenBSD:*:*) + echo m68k-unknown-openbsd${UNAME_RELEASE} + exit 0 ;; + mac68k:OpenBSD:*:*) + echo m68k-unknown-openbsd${UNAME_RELEASE} + exit 0 ;; + macppc:OpenBSD:*:*) + echo powerpc-unknown-openbsd${UNAME_RELEASE} + exit 0 ;; + mvme68k:OpenBSD:*:*) + echo m68k-unknown-openbsd${UNAME_RELEASE} + exit 0 ;; + mvme88k:OpenBSD:*:*) + echo m88k-unknown-openbsd${UNAME_RELEASE} + exit 0 ;; + mvmeppc:OpenBSD:*:*) + echo powerpc-unknown-openbsd${UNAME_RELEASE} + exit 0 ;; + pmax:OpenBSD:*:*) + echo mipsel-unknown-openbsd${UNAME_RELEASE} + exit 0 ;; + sgi:OpenBSD:*:*) + echo mipseb-unknown-openbsd${UNAME_RELEASE} + exit 0 ;; + sun3:OpenBSD:*:*) + echo m68k-unknown-openbsd${UNAME_RELEASE} + exit 0 ;; + wgrisc:OpenBSD:*:*) + echo mipsel-unknown-openbsd${UNAME_RELEASE} + exit 0 ;; + *:OpenBSD:*:*) + echo ${UNAME_MACHINE}-unknown-openbsd${UNAME_RELEASE} + exit 0 ;; + alpha:OSF1:*:*) + if test $UNAME_RELEASE = "V4.0"; then + UNAME_RELEASE=`/usr/sbin/sizer -v | awk '{print $3}'` + fi + # A Vn.n version is a released version. + # A Tn.n version is a released field test version. + # A Xn.n version is an unreleased experimental baselevel. + # 1.2 uses "1.2" for uname -r. + cat <$dummy.s + .data +\$Lformat: + .byte 37,100,45,37,120,10,0 # "%d-%x\n" + + .text + .globl main + .align 4 + .ent main +main: + .frame \$30,16,\$26,0 + ldgp \$29,0(\$27) + .prologue 1 + .long 0x47e03d80 # implver \$0 + lda \$2,-1 + .long 0x47e20c21 # amask \$2,\$1 + lda \$16,\$Lformat + mov \$0,\$17 + not \$1,\$18 + jsr \$26,printf + ldgp \$29,0(\$26) + mov 0,\$16 + jsr \$26,exit + .end main +EOF + eval $set_cc_for_build + $CC_FOR_BUILD $dummy.s -o $dummy 2>/dev/null + if test "$?" = 0 ; then + case `./$dummy` in + 0-0) + UNAME_MACHINE="alpha" + ;; + 1-0) + UNAME_MACHINE="alphaev5" + ;; + 1-1) + UNAME_MACHINE="alphaev56" + ;; + 1-101) + UNAME_MACHINE="alphapca56" + ;; + 2-303) + UNAME_MACHINE="alphaev6" + ;; + 2-307) + UNAME_MACHINE="alphaev67" + ;; + 2-1307) + UNAME_MACHINE="alphaev68" + ;; + esac + fi + rm -f $dummy.s $dummy + echo ${UNAME_MACHINE}-dec-osf`echo ${UNAME_RELEASE} | sed -e 's/^[VTX]//' | tr 'ABCDEFGHIJKLMNOPQRSTUVWXYZ' 'abcdefghijklmnopqrstuvwxyz'` + exit 0 ;; + Alpha\ *:Windows_NT*:*) + # How do we know it's Interix rather than the generic POSIX subsystem? + # Should we change UNAME_MACHINE based on the output of uname instead + # of the specific Alpha model? + echo alpha-pc-interix + exit 0 ;; + 21064:Windows_NT:50:3) + echo alpha-dec-winnt3.5 + exit 0 ;; + Amiga*:UNIX_System_V:4.0:*) + echo m68k-unknown-sysv4 + exit 0;; + *:[Aa]miga[Oo][Ss]:*:*) + echo ${UNAME_MACHINE}-unknown-amigaos + exit 0 ;; + *:[Mm]orph[Oo][Ss]:*:*) + echo ${UNAME_MACHINE}-unknown-morphos + exit 0 ;; + *:OS/390:*:*) + echo i370-ibm-openedition + exit 0 ;; + arm:RISC*:1.[012]*:*|arm:riscix:1.[012]*:*) + echo arm-acorn-riscix${UNAME_RELEASE} + exit 0;; + SR2?01:HI-UX/MPP:*:* | SR8000:HI-UX/MPP:*:*) + echo hppa1.1-hitachi-hiuxmpp + exit 0;; + Pyramid*:OSx*:*:* | MIS*:OSx*:*:* | MIS*:SMP_DC-OSx*:*:*) + # akee@wpdis03.wpafb.af.mil (Earle F. Ake) contributed MIS and NILE. + if test "`(/bin/universe) 2>/dev/null`" = att ; then + echo pyramid-pyramid-sysv3 + else + echo pyramid-pyramid-bsd + fi + exit 0 ;; + NILE*:*:*:dcosx) + echo pyramid-pyramid-svr4 + exit 0 ;; + sun4H:SunOS:5.*:*) + echo sparc-hal-solaris2`echo ${UNAME_RELEASE}|sed -e 's/[^.]*//'` + exit 0 ;; + sun4*:SunOS:5.*:* | tadpole*:SunOS:5.*:*) + echo sparc-sun-solaris2`echo ${UNAME_RELEASE}|sed -e 's/[^.]*//'` + exit 0 ;; + i86pc:SunOS:5.*:*) + echo i386-pc-solaris2`echo ${UNAME_RELEASE}|sed -e 's/[^.]*//'` + exit 0 ;; + sun4*:SunOS:6*:*) + # According to config.sub, this is the proper way to canonicalize + # SunOS6. Hard to guess exactly what SunOS6 will be like, but + # it's likely to be more like Solaris than SunOS4. + echo sparc-sun-solaris3`echo ${UNAME_RELEASE}|sed -e 's/[^.]*//'` + exit 0 ;; + sun4*:SunOS:*:*) + case "`/usr/bin/arch -k`" in + Series*|S4*) + UNAME_RELEASE=`uname -v` + ;; + esac + # Japanese Language versions have a version number like `4.1.3-JL'. + echo sparc-sun-sunos`echo ${UNAME_RELEASE}|sed -e 's/-/_/'` + exit 0 ;; + sun3*:SunOS:*:*) + echo m68k-sun-sunos${UNAME_RELEASE} + exit 0 ;; + sun*:*:4.2BSD:*) + UNAME_RELEASE=`(sed 1q /etc/motd | awk '{print substr($5,1,3)}') 2>/dev/null` + test "x${UNAME_RELEASE}" = "x" && UNAME_RELEASE=3 + case "`/bin/arch`" in + sun3) + echo m68k-sun-sunos${UNAME_RELEASE} + ;; + sun4) + echo sparc-sun-sunos${UNAME_RELEASE} + ;; + esac + exit 0 ;; + aushp:SunOS:*:*) + echo sparc-auspex-sunos${UNAME_RELEASE} + exit 0 ;; + # The situation for MiNT is a little confusing. The machine name + # can be virtually everything (everything which is not + # "atarist" or "atariste" at least should have a processor + # > m68000). The system name ranges from "MiNT" over "FreeMiNT" + # to the lowercase version "mint" (or "freemint"). Finally + # the system name "TOS" denotes a system which is actually not + # MiNT. But MiNT is downward compatible to TOS, so this should + # be no problem. + atarist[e]:*MiNT:*:* | atarist[e]:*mint:*:* | atarist[e]:*TOS:*:*) + echo m68k-atari-mint${UNAME_RELEASE} + exit 0 ;; + atari*:*MiNT:*:* | atari*:*mint:*:* | atarist[e]:*TOS:*:*) + echo m68k-atari-mint${UNAME_RELEASE} + exit 0 ;; + *falcon*:*MiNT:*:* | *falcon*:*mint:*:* | *falcon*:*TOS:*:*) + echo m68k-atari-mint${UNAME_RELEASE} + exit 0 ;; + milan*:*MiNT:*:* | milan*:*mint:*:* | *milan*:*TOS:*:*) + echo m68k-milan-mint${UNAME_RELEASE} + exit 0 ;; + hades*:*MiNT:*:* | hades*:*mint:*:* | *hades*:*TOS:*:*) + echo m68k-hades-mint${UNAME_RELEASE} + exit 0 ;; + *:*MiNT:*:* | *:*mint:*:* | *:*TOS:*:*) + echo m68k-unknown-mint${UNAME_RELEASE} + exit 0 ;; + powerpc:machten:*:*) + echo powerpc-apple-machten${UNAME_RELEASE} + exit 0 ;; + RISC*:Mach:*:*) + echo mips-dec-mach_bsd4.3 + exit 0 ;; + RISC*:ULTRIX:*:*) + echo mips-dec-ultrix${UNAME_RELEASE} + exit 0 ;; + VAX*:ULTRIX*:*:*) + echo vax-dec-ultrix${UNAME_RELEASE} + exit 0 ;; + 2020:CLIX:*:* | 2430:CLIX:*:*) + echo clipper-intergraph-clix${UNAME_RELEASE} + exit 0 ;; + mips:*:*:UMIPS | mips:*:*:RISCos) + eval $set_cc_for_build + sed 's/^ //' << EOF >$dummy.c +#ifdef __cplusplus +#include /* for printf() prototype */ + int main (int argc, char *argv[]) { +#else + int main (argc, argv) int argc; char *argv[]; { +#endif + #if defined (host_mips) && defined (MIPSEB) + #if defined (SYSTYPE_SYSV) + printf ("mips-mips-riscos%ssysv\n", argv[1]); exit (0); + #endif + #if defined (SYSTYPE_SVR4) + printf ("mips-mips-riscos%ssvr4\n", argv[1]); exit (0); + #endif + #if defined (SYSTYPE_BSD43) || defined(SYSTYPE_BSD) + printf ("mips-mips-riscos%sbsd\n", argv[1]); exit (0); + #endif + #endif + exit (-1); + } +EOF + $CC_FOR_BUILD $dummy.c -o $dummy \ + && ./$dummy `echo "${UNAME_RELEASE}" | sed -n 's/\([0-9]*\).*/\1/p'` \ + && rm -f $dummy.c $dummy && exit 0 + rm -f $dummy.c $dummy + echo mips-mips-riscos${UNAME_RELEASE} + exit 0 ;; + Motorola:PowerMAX_OS:*:*) + echo powerpc-motorola-powermax + exit 0 ;; + Night_Hawk:*:*:PowerMAX_OS) + echo powerpc-harris-powermax + exit 0 ;; + Night_Hawk:Power_UNIX:*:*) + echo powerpc-harris-powerunix + exit 0 ;; + m88k:CX/UX:7*:*) + echo m88k-harris-cxux7 + exit 0 ;; + m88k:*:4*:R4*) + echo m88k-motorola-sysv4 + exit 0 ;; + m88k:*:3*:R3*) + echo m88k-motorola-sysv3 + exit 0 ;; + AViiON:dgux:*:*) + # DG/UX returns AViiON for all architectures + UNAME_PROCESSOR=`/usr/bin/uname -p` + if [ $UNAME_PROCESSOR = mc88100 ] || [ $UNAME_PROCESSOR = mc88110 ] + then + if [ ${TARGET_BINARY_INTERFACE}x = m88kdguxelfx ] || \ + [ ${TARGET_BINARY_INTERFACE}x = x ] + then + echo m88k-dg-dgux${UNAME_RELEASE} + else + echo m88k-dg-dguxbcs${UNAME_RELEASE} + fi + else + echo i586-dg-dgux${UNAME_RELEASE} + fi + exit 0 ;; + M88*:DolphinOS:*:*) # DolphinOS (SVR3) + echo m88k-dolphin-sysv3 + exit 0 ;; + M88*:*:R3*:*) + # Delta 88k system running SVR3 + echo m88k-motorola-sysv3 + exit 0 ;; + XD88*:*:*:*) # Tektronix XD88 system running UTekV (SVR3) + echo m88k-tektronix-sysv3 + exit 0 ;; + Tek43[0-9][0-9]:UTek:*:*) # Tektronix 4300 system running UTek (BSD) + echo m68k-tektronix-bsd + exit 0 ;; + *:IRIX*:*:*) + echo mips-sgi-irix`echo ${UNAME_RELEASE}|sed -e 's/-/_/g'` + exit 0 ;; + ????????:AIX?:[12].1:2) # AIX 2.2.1 or AIX 2.1.1 is RT/PC AIX. + echo romp-ibm-aix # uname -m gives an 8 hex-code CPU id + exit 0 ;; # Note that: echo "'`uname -s`'" gives 'AIX ' + i*86:AIX:*:*) + echo i386-ibm-aix + exit 0 ;; + ia64:AIX:*:*) + if [ -x /usr/bin/oslevel ] ; then + IBM_REV=`/usr/bin/oslevel` + else + IBM_REV=${UNAME_VERSION}.${UNAME_RELEASE} + fi + echo ${UNAME_MACHINE}-ibm-aix${IBM_REV} + exit 0 ;; + *:AIX:2:3) + if grep bos325 /usr/include/stdio.h >/dev/null 2>&1; then + eval $set_cc_for_build + sed 's/^ //' << EOF >$dummy.c + #include + + main() + { + if (!__power_pc()) + exit(1); + puts("powerpc-ibm-aix3.2.5"); + exit(0); + } +EOF + $CC_FOR_BUILD $dummy.c -o $dummy && ./$dummy && rm -f $dummy.c $dummy && exit 0 + rm -f $dummy.c $dummy + echo rs6000-ibm-aix3.2.5 + elif grep bos324 /usr/include/stdio.h >/dev/null 2>&1; then + echo rs6000-ibm-aix3.2.4 + else + echo rs6000-ibm-aix3.2 + fi + exit 0 ;; + *:AIX:*:[45]) + IBM_CPU_ID=`/usr/sbin/lsdev -C -c processor -S available | sed 1q | awk '{ print $1 }'` + if /usr/sbin/lsattr -El ${IBM_CPU_ID} | grep ' POWER' >/dev/null 2>&1; then + IBM_ARCH=rs6000 + else + IBM_ARCH=powerpc + fi + if [ -x /usr/bin/oslevel ] ; then + IBM_REV=`/usr/bin/oslevel` + else + IBM_REV=${UNAME_VERSION}.${UNAME_RELEASE} + fi + echo ${IBM_ARCH}-ibm-aix${IBM_REV} + exit 0 ;; + *:AIX:*:*) + echo rs6000-ibm-aix + exit 0 ;; + ibmrt:4.4BSD:*|romp-ibm:BSD:*) + echo romp-ibm-bsd4.4 + exit 0 ;; + ibmrt:*BSD:*|romp-ibm:BSD:*) # covers RT/PC BSD and + echo romp-ibm-bsd${UNAME_RELEASE} # 4.3 with uname added to + exit 0 ;; # report: romp-ibm BSD 4.3 + *:BOSX:*:*) + echo rs6000-bull-bosx + exit 0 ;; + DPX/2?00:B.O.S.:*:*) + echo m68k-bull-sysv3 + exit 0 ;; + 9000/[34]??:4.3bsd:1.*:*) + echo m68k-hp-bsd + exit 0 ;; + hp300:4.4BSD:*:* | 9000/[34]??:4.3bsd:2.*:*) + echo m68k-hp-bsd4.4 + exit 0 ;; + 9000/[34678]??:HP-UX:*:*) + HPUX_REV=`echo ${UNAME_RELEASE}|sed -e 's/[^.]*.[0B]*//'` + case "${UNAME_MACHINE}" in + 9000/31? ) HP_ARCH=m68000 ;; + 9000/[34]?? ) HP_ARCH=m68k ;; + 9000/[678][0-9][0-9]) + if [ -x /usr/bin/getconf ]; then + sc_cpu_version=`/usr/bin/getconf SC_CPU_VERSION 2>/dev/null` + sc_kernel_bits=`/usr/bin/getconf SC_KERNEL_BITS 2>/dev/null` + case "${sc_cpu_version}" in + 523) HP_ARCH="hppa1.0" ;; # CPU_PA_RISC1_0 + 528) HP_ARCH="hppa1.1" ;; # CPU_PA_RISC1_1 + 532) # CPU_PA_RISC2_0 + case "${sc_kernel_bits}" in + 32) HP_ARCH="hppa2.0n" ;; + 64) HP_ARCH="hppa2.0w" ;; + '') HP_ARCH="hppa2.0" ;; # HP-UX 10.20 + esac ;; + esac + fi + if [ "${HP_ARCH}" = "" ]; then + eval $set_cc_for_build + sed 's/^ //' << EOF >$dummy.c + + #define _HPUX_SOURCE + #include + #include + + int main () + { + #if defined(_SC_KERNEL_BITS) + long bits = sysconf(_SC_KERNEL_BITS); + #endif + long cpu = sysconf (_SC_CPU_VERSION); + + switch (cpu) + { + case CPU_PA_RISC1_0: puts ("hppa1.0"); break; + case CPU_PA_RISC1_1: puts ("hppa1.1"); break; + case CPU_PA_RISC2_0: + #if defined(_SC_KERNEL_BITS) + switch (bits) + { + case 64: puts ("hppa2.0w"); break; + case 32: puts ("hppa2.0n"); break; + default: puts ("hppa2.0"); break; + } break; + #else /* !defined(_SC_KERNEL_BITS) */ + puts ("hppa2.0"); break; + #endif + default: puts ("hppa1.0"); break; + } + exit (0); + } +EOF + (CCOPTS= $CC_FOR_BUILD $dummy.c -o $dummy 2>/dev/null) && HP_ARCH=`./$dummy` + if test -z "$HP_ARCH"; then HP_ARCH=hppa; fi + rm -f $dummy.c $dummy + fi ;; + esac + echo ${HP_ARCH}-hp-hpux${HPUX_REV} + exit 0 ;; + ia64:HP-UX:*:*) + HPUX_REV=`echo ${UNAME_RELEASE}|sed -e 's/[^.]*.[0B]*//'` + echo ia64-hp-hpux${HPUX_REV} + exit 0 ;; + 3050*:HI-UX:*:*) + eval $set_cc_for_build + sed 's/^ //' << EOF >$dummy.c + #include + int + main () + { + long cpu = sysconf (_SC_CPU_VERSION); + /* The order matters, because CPU_IS_HP_MC68K erroneously returns + true for CPU_PA_RISC1_0. CPU_IS_PA_RISC returns correct + results, however. */ + if (CPU_IS_PA_RISC (cpu)) + { + switch (cpu) + { + case CPU_PA_RISC1_0: puts ("hppa1.0-hitachi-hiuxwe2"); break; + case CPU_PA_RISC1_1: puts ("hppa1.1-hitachi-hiuxwe2"); break; + case CPU_PA_RISC2_0: puts ("hppa2.0-hitachi-hiuxwe2"); break; + default: puts ("hppa-hitachi-hiuxwe2"); break; + } + } + else if (CPU_IS_HP_MC68K (cpu)) + puts ("m68k-hitachi-hiuxwe2"); + else puts ("unknown-hitachi-hiuxwe2"); + exit (0); + } +EOF + $CC_FOR_BUILD $dummy.c -o $dummy && ./$dummy && rm -f $dummy.c $dummy && exit 0 + rm -f $dummy.c $dummy + echo unknown-hitachi-hiuxwe2 + exit 0 ;; + 9000/7??:4.3bsd:*:* | 9000/8?[79]:4.3bsd:*:* ) + echo hppa1.1-hp-bsd + exit 0 ;; + 9000/8??:4.3bsd:*:*) + echo hppa1.0-hp-bsd + exit 0 ;; + *9??*:MPE/iX:*:* | *3000*:MPE/iX:*:*) + echo hppa1.0-hp-mpeix + exit 0 ;; + hp7??:OSF1:*:* | hp8?[79]:OSF1:*:* ) + echo hppa1.1-hp-osf + exit 0 ;; + hp8??:OSF1:*:*) + echo hppa1.0-hp-osf + exit 0 ;; + i*86:OSF1:*:*) + if [ -x /usr/sbin/sysversion ] ; then + echo ${UNAME_MACHINE}-unknown-osf1mk + else + echo ${UNAME_MACHINE}-unknown-osf1 + fi + exit 0 ;; + parisc*:Lites*:*:*) + echo hppa1.1-hp-lites + exit 0 ;; + C1*:ConvexOS:*:* | convex:ConvexOS:C1*:*) + echo c1-convex-bsd + exit 0 ;; + C2*:ConvexOS:*:* | convex:ConvexOS:C2*:*) + if getsysinfo -f scalar_acc + then echo c32-convex-bsd + else echo c2-convex-bsd + fi + exit 0 ;; + C34*:ConvexOS:*:* | convex:ConvexOS:C34*:*) + echo c34-convex-bsd + exit 0 ;; + C38*:ConvexOS:*:* | convex:ConvexOS:C38*:*) + echo c38-convex-bsd + exit 0 ;; + C4*:ConvexOS:*:* | convex:ConvexOS:C4*:*) + echo c4-convex-bsd + exit 0 ;; + CRAY*Y-MP:*:*:*) + echo ymp-cray-unicos${UNAME_RELEASE} | sed -e 's/\.[^.]*$/.X/' + exit 0 ;; + CRAY*[A-Z]90:*:*:*) + echo ${UNAME_MACHINE}-cray-unicos${UNAME_RELEASE} \ + | sed -e 's/CRAY.*\([A-Z]90\)/\1/' \ + -e y/ABCDEFGHIJKLMNOPQRSTUVWXYZ/abcdefghijklmnopqrstuvwxyz/ \ + -e 's/\.[^.]*$/.X/' + exit 0 ;; + CRAY*TS:*:*:*) + echo t90-cray-unicos${UNAME_RELEASE} | sed -e 's/\.[^.]*$/.X/' + exit 0 ;; + CRAY*T3D:*:*:*) + echo alpha-cray-unicosmk${UNAME_RELEASE} | sed -e 's/\.[^.]*$/.X/' + exit 0 ;; + CRAY*T3E:*:*:*) + echo alphaev5-cray-unicosmk${UNAME_RELEASE} | sed -e 's/\.[^.]*$/.X/' + exit 0 ;; + CRAY*SV1:*:*:*) + echo sv1-cray-unicos${UNAME_RELEASE} | sed -e 's/\.[^.]*$/.X/' + exit 0 ;; + F30[01]:UNIX_System_V:*:* | F700:UNIX_System_V:*:*) + FUJITSU_PROC=`uname -m | tr 'ABCDEFGHIJKLMNOPQRSTUVWXYZ' 'abcdefghijklmnopqrstuvwxyz'` + FUJITSU_SYS=`uname -p | tr 'ABCDEFGHIJKLMNOPQRSTUVWXYZ' 'abcdefghijklmnopqrstuvwxyz' | sed -e 's/\///'` + FUJITSU_REL=`echo ${UNAME_RELEASE} | sed -e 's/ /_/'` + echo "${FUJITSU_PROC}-fujitsu-${FUJITSU_SYS}${FUJITSU_REL}" + exit 0 ;; + i*86:BSD/386:*:* | i*86:BSD/OS:*:* | *:Ascend\ Embedded/OS:*:*) + echo ${UNAME_MACHINE}-pc-bsdi${UNAME_RELEASE} + exit 0 ;; + sparc*:BSD/OS:*:*) + echo sparc-unknown-bsdi${UNAME_RELEASE} + exit 0 ;; + *:BSD/OS:*:*) + echo ${UNAME_MACHINE}-unknown-bsdi${UNAME_RELEASE} + exit 0 ;; + *:FreeBSD:*:*) + echo ${UNAME_MACHINE}-unknown-freebsd`echo ${UNAME_RELEASE}|sed -e 's/[-(].*//'` + exit 0 ;; + i*:CYGWIN*:*) + echo ${UNAME_MACHINE}-pc-cygwin + exit 0 ;; + i*:MINGW*:*) + echo ${UNAME_MACHINE}-pc-mingw32 + exit 0 ;; + i*:PW*:*) + echo ${UNAME_MACHINE}-pc-pw32 + exit 0 ;; + x86:Interix*:3*) + echo i386-pc-interix3 + exit 0 ;; + i*:Windows_NT*:* | Pentium*:Windows_NT*:*) + # How do we know it's Interix rather than the generic POSIX subsystem? + # It also conflicts with pre-2.0 versions of AT&T UWIN. Should we + # UNAME_MACHINE based on the output of uname instead of i386? + echo i386-pc-interix + exit 0 ;; + i*:UWIN*:*) + echo ${UNAME_MACHINE}-pc-uwin + exit 0 ;; + p*:CYGWIN*:*) + echo powerpcle-unknown-cygwin + exit 0 ;; + prep*:SunOS:5.*:*) + echo powerpcle-unknown-solaris2`echo ${UNAME_RELEASE}|sed -e 's/[^.]*//'` + exit 0 ;; + *:GNU:*:*) + echo `echo ${UNAME_MACHINE}|sed -e 's,[-/].*$,,'`-unknown-gnu`echo ${UNAME_RELEASE}|sed -e 's,/.*$,,'` + exit 0 ;; + i*86:Minix:*:*) + echo ${UNAME_MACHINE}-pc-minix + exit 0 ;; + arm*:Linux:*:*) + echo ${UNAME_MACHINE}-unknown-linux-gnu + exit 0 ;; + ia64:Linux:*:*) + echo ${UNAME_MACHINE}-unknown-linux-gnu + exit 0 ;; + m68*:Linux:*:*) + echo ${UNAME_MACHINE}-unknown-linux-gnu + exit 0 ;; + mips:Linux:*:*) + eval $set_cc_for_build + sed 's/^ //' << EOF >$dummy.c + #undef CPU + #undef mips + #undef mipsel + #if defined(__MIPSEL__) || defined(__MIPSEL) || defined(_MIPSEL) || defined(MIPSEL) + CPU=mipsel + #else + #if defined(__MIPSEB__) || defined(__MIPSEB) || defined(_MIPSEB) || defined(MIPSEB) + CPU=mips + #else + CPU= + #endif + #endif +EOF + eval `$CC_FOR_BUILD -E $dummy.c 2>/dev/null | grep ^CPU=` + rm -f $dummy.c + test x"${CPU}" != x && echo "${CPU}-pc-linux-gnu" && exit 0 + ;; + ppc:Linux:*:*) + echo powerpc-unknown-linux-gnu + exit 0 ;; + ppc64:Linux:*:*) + echo powerpc64-unknown-linux-gnu + exit 0 ;; + alpha:Linux:*:*) + case `sed -n '/^cpu model/s/^.*: \(.*\)/\1/p' < /proc/cpuinfo` in + EV5) UNAME_MACHINE=alphaev5 ;; + EV56) UNAME_MACHINE=alphaev56 ;; + PCA56) UNAME_MACHINE=alphapca56 ;; + PCA57) UNAME_MACHINE=alphapca56 ;; + EV6) UNAME_MACHINE=alphaev6 ;; + EV67) UNAME_MACHINE=alphaev67 ;; + EV68*) UNAME_MACHINE=alphaev68 ;; + esac + objdump --private-headers /bin/sh | grep ld.so.1 >/dev/null + if test "$?" = 0 ; then LIBC="libc1" ; else LIBC="" ; fi + echo ${UNAME_MACHINE}-unknown-linux-gnu${LIBC} + exit 0 ;; + parisc:Linux:*:* | hppa:Linux:*:*) + # Look for CPU level + case `grep '^cpu[^a-z]*:' /proc/cpuinfo 2>/dev/null | cut -d' ' -f2` in + PA7*) echo hppa1.1-unknown-linux-gnu ;; + PA8*) echo hppa2.0-unknown-linux-gnu ;; + *) echo hppa-unknown-linux-gnu ;; + esac + exit 0 ;; + parisc64:Linux:*:* | hppa64:Linux:*:*) + echo hppa64-unknown-linux-gnu + exit 0 ;; + s390:Linux:*:* | s390x:Linux:*:*) + echo ${UNAME_MACHINE}-ibm-linux + exit 0 ;; + sh*:Linux:*:*) + echo ${UNAME_MACHINE}-unknown-linux-gnu + exit 0 ;; + sparc:Linux:*:* | sparc64:Linux:*:*) + echo ${UNAME_MACHINE}-unknown-linux-gnu + exit 0 ;; + x86_64:Linux:*:*) + echo x86_64-unknown-linux-gnu + exit 0 ;; + i*86:Linux:*:*) + # The BFD linker knows what the default object file format is, so + # first see if it will tell us. cd to the root directory to prevent + # problems with other programs or directories called `ld' in the path. + # Set LC_ALL=C to ensure ld outputs messages in English. + ld_supported_targets=`cd /; LC_ALL=C ld --help 2>&1 \ + | sed -ne '/supported targets:/!d + s/[ ][ ]*/ /g + s/.*supported targets: *// + s/ .*// + p'` + case "$ld_supported_targets" in + elf32-i386) + TENTATIVE="${UNAME_MACHINE}-pc-linux-gnu" + ;; + a.out-i386-linux) + echo "${UNAME_MACHINE}-pc-linux-gnuaout" + exit 0 ;; + coff-i386) + echo "${UNAME_MACHINE}-pc-linux-gnucoff" + exit 0 ;; + "") + # Either a pre-BFD a.out linker (linux-gnuoldld) or + # one that does not give us useful --help. + echo "${UNAME_MACHINE}-pc-linux-gnuoldld" + exit 0 ;; + esac + # Determine whether the default compiler is a.out or elf + eval $set_cc_for_build + sed 's/^ //' << EOF >$dummy.c + #include + #ifdef __ELF__ + # ifdef __GLIBC__ + # if __GLIBC__ >= 2 + LIBC=gnu + # else + LIBC=gnulibc1 + # endif + # else + LIBC=gnulibc1 + # endif + #else + #ifdef __INTEL_COMPILER + LIBC=gnu + #else + LIBC=gnuaout + #endif + #endif +EOF + eval `$CC_FOR_BUILD -E $dummy.c 2>/dev/null | grep ^LIBC=` + rm -f $dummy.c + test x"${LIBC}" != x && echo "${UNAME_MACHINE}-pc-linux-${LIBC}" && exit 0 + test x"${TENTATIVE}" != x && echo "${TENTATIVE}" && exit 0 + ;; + i*86:DYNIX/ptx:4*:*) + # ptx 4.0 does uname -s correctly, with DYNIX/ptx in there. + # earlier versions are messed up and put the nodename in both + # sysname and nodename. + echo i386-sequent-sysv4 + exit 0 ;; + i*86:UNIX_SV:4.2MP:2.*) + # Unixware is an offshoot of SVR4, but it has its own version + # number series starting with 2... + # I am not positive that other SVR4 systems won't match this, + # I just have to hope. -- rms. + # Use sysv4.2uw... so that sysv4* matches it. + echo ${UNAME_MACHINE}-pc-sysv4.2uw${UNAME_VERSION} + exit 0 ;; + i*86:*:4.*:* | i*86:SYSTEM_V:4.*:*) + UNAME_REL=`echo ${UNAME_RELEASE} | sed 's/\/MP$//'` + if grep Novell /usr/include/link.h >/dev/null 2>/dev/null; then + echo ${UNAME_MACHINE}-univel-sysv${UNAME_REL} + else + echo ${UNAME_MACHINE}-pc-sysv${UNAME_REL} + fi + exit 0 ;; + i*86:*:5:[78]*) + case `/bin/uname -X | grep "^Machine"` in + *486*) UNAME_MACHINE=i486 ;; + *Pentium) UNAME_MACHINE=i586 ;; + *Pent*|*Celeron) UNAME_MACHINE=i686 ;; + esac + echo ${UNAME_MACHINE}-unknown-sysv${UNAME_RELEASE}${UNAME_SYSTEM}${UNAME_VERSION} + exit 0 ;; + i*86:*:3.2:*) + if test -f /usr/options/cb.name; then + UNAME_REL=`sed -n 's/.*Version //p' /dev/null >/dev/null ; then + UNAME_REL=`(/bin/uname -X|grep Release|sed -e 's/.*= //')` + (/bin/uname -X|grep i80486 >/dev/null) && UNAME_MACHINE=i486 + (/bin/uname -X|grep '^Machine.*Pentium' >/dev/null) \ + && UNAME_MACHINE=i586 + (/bin/uname -X|grep '^Machine.*Pent *II' >/dev/null) \ + && UNAME_MACHINE=i686 + (/bin/uname -X|grep '^Machine.*Pentium Pro' >/dev/null) \ + && UNAME_MACHINE=i686 + echo ${UNAME_MACHINE}-pc-sco$UNAME_REL + else + echo ${UNAME_MACHINE}-pc-sysv32 + fi + exit 0 ;; + i*86:*DOS:*:*) + echo ${UNAME_MACHINE}-pc-msdosdjgpp + exit 0 ;; + pc:*:*:*) + # Left here for compatibility: + # uname -m prints for DJGPP always 'pc', but it prints nothing about + # the processor, so we play safe by assuming i386. + echo i386-pc-msdosdjgpp + exit 0 ;; + Intel:Mach:3*:*) + echo i386-pc-mach3 + exit 0 ;; + paragon:*:*:*) + echo i860-intel-osf1 + exit 0 ;; + i860:*:4.*:*) # i860-SVR4 + if grep Stardent /usr/include/sys/uadmin.h >/dev/null 2>&1 ; then + echo i860-stardent-sysv${UNAME_RELEASE} # Stardent Vistra i860-SVR4 + else # Add other i860-SVR4 vendors below as they are discovered. + echo i860-unknown-sysv${UNAME_RELEASE} # Unknown i860-SVR4 + fi + exit 0 ;; + mini*:CTIX:SYS*5:*) + # "miniframe" + echo m68010-convergent-sysv + exit 0 ;; + M68*:*:R3V[567]*:*) + test -r /sysV68 && echo 'm68k-motorola-sysv' && exit 0 ;; + 3[34]??:*:4.0:3.0 | 3[34]??A:*:4.0:3.0 | 3[34]??,*:*:4.0:3.0 | 3[34]??/*:*:4.0:3.0 | 4400:*:4.0:3.0 | 4850:*:4.0:3.0 | SKA40:*:4.0:3.0) + OS_REL='' + test -r /etc/.relid \ + && OS_REL=.`sed -n 's/[^ ]* [^ ]* \([0-9][0-9]\).*/\1/p' < /etc/.relid` + /bin/uname -p 2>/dev/null | grep 86 >/dev/null \ + && echo i486-ncr-sysv4.3${OS_REL} && exit 0 + /bin/uname -p 2>/dev/null | /bin/grep entium >/dev/null \ + && echo i586-ncr-sysv4.3${OS_REL} && exit 0 ;; + 3[34]??:*:4.0:* | 3[34]??,*:*:4.0:*) + /bin/uname -p 2>/dev/null | grep 86 >/dev/null \ + && echo i486-ncr-sysv4 && exit 0 ;; + m68*:LynxOS:2.*:* | m68*:LynxOS:3.0*:*) + echo m68k-unknown-lynxos${UNAME_RELEASE} + exit 0 ;; + mc68030:UNIX_System_V:4.*:*) + echo m68k-atari-sysv4 + exit 0 ;; + i*86:LynxOS:2.*:* | i*86:LynxOS:3.[01]*:* | i*86:LynxOS:4.0*:*) + echo i386-unknown-lynxos${UNAME_RELEASE} + exit 0 ;; + TSUNAMI:LynxOS:2.*:*) + echo sparc-unknown-lynxos${UNAME_RELEASE} + exit 0 ;; + rs6000:LynxOS:2.*:*) + echo rs6000-unknown-lynxos${UNAME_RELEASE} + exit 0 ;; + PowerPC:LynxOS:2.*:* | PowerPC:LynxOS:3.[01]*:* | PowerPC:LynxOS:4.0*:*) + echo powerpc-unknown-lynxos${UNAME_RELEASE} + exit 0 ;; + SM[BE]S:UNIX_SV:*:*) + echo mips-dde-sysv${UNAME_RELEASE} + exit 0 ;; + RM*:ReliantUNIX-*:*:*) + echo mips-sni-sysv4 + exit 0 ;; + RM*:SINIX-*:*:*) + echo mips-sni-sysv4 + exit 0 ;; + *:SINIX-*:*:*) + if uname -p 2>/dev/null >/dev/null ; then + UNAME_MACHINE=`(uname -p) 2>/dev/null` + echo ${UNAME_MACHINE}-sni-sysv4 + else + echo ns32k-sni-sysv + fi + exit 0 ;; + PENTIUM:*:4.0*:*) # Unisys `ClearPath HMP IX 4000' SVR4/MP effort + # says + echo i586-unisys-sysv4 + exit 0 ;; + *:UNIX_System_V:4*:FTX*) + # From Gerald Hewes . + # How about differentiating between stratus architectures? -djm + echo hppa1.1-stratus-sysv4 + exit 0 ;; + *:*:*:FTX*) + # From seanf@swdc.stratus.com. + echo i860-stratus-sysv4 + exit 0 ;; + *:VOS:*:*) + # From Paul.Green@stratus.com. + echo hppa1.1-stratus-vos + exit 0 ;; + mc68*:A/UX:*:*) + echo m68k-apple-aux${UNAME_RELEASE} + exit 0 ;; + news*:NEWS-OS:6*:*) + echo mips-sony-newsos6 + exit 0 ;; + R[34]000:*System_V*:*:* | R4000:UNIX_SYSV:*:* | R*000:UNIX_SV:*:*) + if [ -d /usr/nec ]; then + echo mips-nec-sysv${UNAME_RELEASE} + else + echo mips-unknown-sysv${UNAME_RELEASE} + fi + exit 0 ;; + BeBox:BeOS:*:*) # BeOS running on hardware made by Be, PPC only. + echo powerpc-be-beos + exit 0 ;; + BeMac:BeOS:*:*) # BeOS running on Mac or Mac clone, PPC only. + echo powerpc-apple-beos + exit 0 ;; + BePC:BeOS:*:*) # BeOS running on Intel PC compatible. + echo i586-pc-beos + exit 0 ;; + SX-4:SUPER-UX:*:*) + echo sx4-nec-superux${UNAME_RELEASE} + exit 0 ;; + SX-5:SUPER-UX:*:*) + echo sx5-nec-superux${UNAME_RELEASE} + exit 0 ;; + Power*:Rhapsody:*:*) + echo powerpc-apple-rhapsody${UNAME_RELEASE} + exit 0 ;; + *:Rhapsody:*:*) + echo ${UNAME_MACHINE}-apple-rhapsody${UNAME_RELEASE} + exit 0 ;; + *:Darwin:*:*) + echo `uname -p`-apple-darwin${UNAME_RELEASE} + exit 0 ;; + *:procnto*:*:* | *:QNX:[0123456789]*:*) + UNAME_PROCESSOR=`uname -p` + if test "$UNAME_PROCESSOR" = "x86"; then + UNAME_PROCESSOR=i386 + UNAME_MACHINE=pc + fi + echo ${UNAME_PROCESSOR}-${UNAME_MACHINE}-nto-qnx${UNAME_RELEASE} + exit 0 ;; + *:QNX:*:4*) + echo i386-pc-qnx + exit 0 ;; + NSR-[GKLNPTVW]:NONSTOP_KERNEL:*:*) + echo nsr-tandem-nsk${UNAME_RELEASE} + exit 0 ;; + *:NonStop-UX:*:*) + echo mips-compaq-nonstopux + exit 0 ;; + BS2000:POSIX*:*:*) + echo bs2000-siemens-sysv + exit 0 ;; + DS/*:UNIX_System_V:*:*) + echo ${UNAME_MACHINE}-${UNAME_SYSTEM}-${UNAME_RELEASE} + exit 0 ;; + *:Plan9:*:*) + # "uname -m" is not consistent, so use $cputype instead. 386 + # is converted to i386 for consistency with other x86 + # operating systems. + if test "$cputype" = "386"; then + UNAME_MACHINE=i386 + else + UNAME_MACHINE="$cputype" + fi + echo ${UNAME_MACHINE}-unknown-plan9 + exit 0 ;; + i*86:OS/2:*:*) + # If we were able to find `uname', then EMX Unix compatibility + # is probably installed. + echo ${UNAME_MACHINE}-pc-os2-emx + exit 0 ;; + *:TOPS-10:*:*) + echo pdp10-unknown-tops10 + exit 0 ;; + *:TENEX:*:*) + echo pdp10-unknown-tenex + exit 0 ;; + KS10:TOPS-20:*:* | KL10:TOPS-20:*:* | TYPE4:TOPS-20:*:*) + echo pdp10-dec-tops20 + exit 0 ;; + XKL-1:TOPS-20:*:* | TYPE5:TOPS-20:*:*) + echo pdp10-xkl-tops20 + exit 0 ;; + *:TOPS-20:*:*) + echo pdp10-unknown-tops20 + exit 0 ;; + *:ITS:*:*) + echo pdp10-unknown-its + exit 0 ;; + i*86:XTS-300:*:STOP) + echo ${UNAME_MACHINE}-unknown-stop + exit 0 ;; + i*86:atheos:*:*) + echo ${UNAME_MACHINE}-unknown-atheos + exit 0 ;; +esac + +#echo '(No uname command or uname output not recognized.)' 1>&2 +#echo "${UNAME_MACHINE}:${UNAME_SYSTEM}:${UNAME_RELEASE}:${UNAME_VERSION}" 1>&2 + +eval $set_cc_for_build +cat >$dummy.c < +# include +#endif +main () +{ +#if defined (sony) +#if defined (MIPSEB) + /* BFD wants "bsd" instead of "newsos". Perhaps BFD should be changed, + I don't know.... */ + printf ("mips-sony-bsd\n"); exit (0); +#else +#include + printf ("m68k-sony-newsos%s\n", +#ifdef NEWSOS4 + "4" +#else + "" +#endif + ); exit (0); +#endif +#endif + +#if defined (__arm) && defined (__acorn) && defined (__unix) + printf ("arm-acorn-riscix"); exit (0); +#endif + +#if defined (hp300) && !defined (hpux) + printf ("m68k-hp-bsd\n"); exit (0); +#endif + +#if defined (NeXT) +#if !defined (__ARCHITECTURE__) +#define __ARCHITECTURE__ "m68k" +#endif + int version; + version=`(hostinfo | sed -n 's/.*NeXT Mach \([0-9]*\).*/\1/p') 2>/dev/null`; + if (version < 4) + printf ("%s-next-nextstep%d\n", __ARCHITECTURE__, version); + else + printf ("%s-next-openstep%d\n", __ARCHITECTURE__, version); + exit (0); +#endif + +#if defined (MULTIMAX) || defined (n16) +#if defined (UMAXV) + printf ("ns32k-encore-sysv\n"); exit (0); +#else +#if defined (CMU) + printf ("ns32k-encore-mach\n"); exit (0); +#else + printf ("ns32k-encore-bsd\n"); exit (0); +#endif +#endif +#endif + +#if defined (__386BSD__) + printf ("i386-pc-bsd\n"); exit (0); +#endif + +#if defined (sequent) +#if defined (i386) + printf ("i386-sequent-dynix\n"); exit (0); +#endif +#if defined (ns32000) + printf ("ns32k-sequent-dynix\n"); exit (0); +#endif +#endif + +#if defined (_SEQUENT_) + struct utsname un; + + uname(&un); + + if (strncmp(un.version, "V2", 2) == 0) { + printf ("i386-sequent-ptx2\n"); exit (0); + } + if (strncmp(un.version, "V1", 2) == 0) { /* XXX is V1 correct? */ + printf ("i386-sequent-ptx1\n"); exit (0); + } + printf ("i386-sequent-ptx\n"); exit (0); + +#endif + +#if defined (vax) +# if !defined (ultrix) +# include +# if defined (BSD) +# if BSD == 43 + printf ("vax-dec-bsd4.3\n"); exit (0); +# else +# if BSD == 199006 + printf ("vax-dec-bsd4.3reno\n"); exit (0); +# else + printf ("vax-dec-bsd\n"); exit (0); +# endif +# endif +# else + printf ("vax-dec-bsd\n"); exit (0); +# endif +# else + printf ("vax-dec-ultrix\n"); exit (0); +# endif +#endif + +#if defined (alliant) && defined (i860) + printf ("i860-alliant-bsd\n"); exit (0); +#endif + + exit (1); +} +EOF + +$CC_FOR_BUILD $dummy.c -o $dummy 2>/dev/null && ./$dummy && rm -f $dummy.c $dummy && exit 0 +rm -f $dummy.c $dummy + +# Apollos put the system type in the environment. + +test -d /usr/apollo && { echo ${ISP}-apollo-${SYSTYPE}; exit 0; } + +# Convex versions that predate uname can use getsysinfo(1) + +if [ -x /usr/convex/getsysinfo ] +then + case `getsysinfo -f cpu_type` in + c1*) + echo c1-convex-bsd + exit 0 ;; + c2*) + if getsysinfo -f scalar_acc + then echo c32-convex-bsd + else echo c2-convex-bsd + fi + exit 0 ;; + c34*) + echo c34-convex-bsd + exit 0 ;; + c38*) + echo c38-convex-bsd + exit 0 ;; + c4*) + echo c4-convex-bsd + exit 0 ;; + esac +fi + +cat >&2 < in order to provide the needed +information to handle your system. + +config.guess timestamp = $timestamp + +uname -m = `(uname -m) 2>/dev/null || echo unknown` +uname -r = `(uname -r) 2>/dev/null || echo unknown` +uname -s = `(uname -s) 2>/dev/null || echo unknown` +uname -v = `(uname -v) 2>/dev/null || echo unknown` + +/usr/bin/uname -p = `(/usr/bin/uname -p) 2>/dev/null` +/bin/uname -X = `(/bin/uname -X) 2>/dev/null` + +hostinfo = `(hostinfo) 2>/dev/null` +/bin/universe = `(/bin/universe) 2>/dev/null` +/usr/bin/arch -k = `(/usr/bin/arch -k) 2>/dev/null` +/bin/arch = `(/bin/arch) 2>/dev/null` +/usr/bin/oslevel = `(/usr/bin/oslevel) 2>/dev/null` +/usr/convex/getsysinfo = `(/usr/convex/getsysinfo) 2>/dev/null` + +UNAME_MACHINE = ${UNAME_MACHINE} +UNAME_RELEASE = ${UNAME_RELEASE} +UNAME_SYSTEM = ${UNAME_SYSTEM} +UNAME_VERSION = ${UNAME_VERSION} +EOF + +exit 1 + +# Local variables: +# eval: (add-hook 'write-file-hooks 'time-stamp) +# time-stamp-start: "timestamp='" +# time-stamp-format: "%:y-%02m-%02d" +# time-stamp-end: "'" +# End: diff --git a/libconfig-1.4.9/aux-build/config.sub b/libconfig-1.4.9/aux-build/config.sub new file mode 100755 index 0000000000000000000000000000000000000000..7f614e1c434ee22e853ad8c2b56f83b77c474c36 --- /dev/null +++ b/libconfig-1.4.9/aux-build/config.sub @@ -0,0 +1,1443 @@ +#! /bin/sh +# Configuration validation subroutine script. +# Copyright (C) 1992, 1993, 1994, 1995, 1996, 1997, 1998, 1999, +# 2000, 2001, 2002 Free Software Foundation, Inc. + +timestamp='2002-05-28' + +# This file is (in principle) common to ALL GNU software. +# The presence of a machine in this file suggests that SOME GNU software +# can handle that machine. It does not imply ALL GNU software can. +# +# This file is free software; you can redistribute it and/or modify +# it under the terms of the GNU General Public License as published by +# the Free Software Foundation; either version 2 of the License, or +# (at your option) any later version. +# +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY; without even the implied warranty of +# MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +# GNU General Public License for more details. +# +# You should have received a copy of the GNU General Public License +# along with this program; if not, write to the Free Software +# Foundation, Inc., 59 Temple Place - Suite 330, +# Boston, MA 02111-1307, USA. + +# As a special exception to the GNU General Public License, if you +# distribute this file as part of a program that contains a +# configuration script generated by Autoconf, you may include it under +# the same distribution terms that you use for the rest of that program. + +# Please send patches to . Submit a context +# diff and a properly formatted ChangeLog entry. +# +# Configuration subroutine to validate and canonicalize a configuration type. +# Supply the specified configuration type as an argument. +# If it is invalid, we print an error message on stderr and exit with code 1. +# Otherwise, we print the canonical config type on stdout and succeed. + +# This file is supposed to be the same for all GNU packages +# and recognize all the CPU types, system types and aliases +# that are meaningful with *any* GNU software. +# Each package is responsible for reporting which valid configurations +# it does not support. The user should be able to distinguish +# a failure to support a valid configuration from a meaningless +# configuration. + +# The goal of this file is to map all the various variations of a given +# machine specification into a single specification in the form: +# CPU_TYPE-MANUFACTURER-OPERATING_SYSTEM +# or in some cases, the newer four-part form: +# CPU_TYPE-MANUFACTURER-KERNEL-OPERATING_SYSTEM +# It is wrong to echo any other type of specification. + +me=`echo "$0" | sed -e 's,.*/,,'` + +usage="\ +Usage: $0 [OPTION] CPU-MFR-OPSYS + $0 [OPTION] ALIAS + +Canonicalize a configuration name. + +Operation modes: + -h, --help print this help, then exit + -t, --time-stamp print date of last modification, then exit + -v, --version print version number, then exit + +Report bugs and patches to ." + +version="\ +GNU config.sub ($timestamp) + +Copyright (C) 1992, 1993, 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001 +Free Software Foundation, Inc. + +This is free software; see the source for copying conditions. There is NO +warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE." + +help=" +Try \`$me --help' for more information." + +# Parse command line +while test $# -gt 0 ; do + case $1 in + --time-stamp | --time* | -t ) + echo "$timestamp" ; exit 0 ;; + --version | -v ) + echo "$version" ; exit 0 ;; + --help | --h* | -h ) + echo "$usage"; exit 0 ;; + -- ) # Stop option processing + shift; break ;; + - ) # Use stdin as input. + break ;; + -* ) + echo "$me: invalid option $1$help" + exit 1 ;; + + *local*) + # First pass through any local machine types. + echo $1 + exit 0;; + + * ) + break ;; + esac +done + +case $# in + 0) echo "$me: missing argument$help" >&2 + exit 1;; + 1) ;; + *) echo "$me: too many arguments$help" >&2 + exit 1;; +esac + +# Separate what the user gave into CPU-COMPANY and OS or KERNEL-OS (if any). +# Here we must recognize all the valid KERNEL-OS combinations. +maybe_os=`echo $1 | sed 's/^\(.*\)-\([^-]*-[^-]*\)$/\2/'` +case $maybe_os in + nto-qnx* | linux-gnu* | storm-chaos* | os2-emx* | windows32-* | rtmk-nova*) + os=-$maybe_os + basic_machine=`echo $1 | sed 's/^\(.*\)-\([^-]*-[^-]*\)$/\1/'` + ;; + *) + basic_machine=`echo $1 | sed 's/-[^-]*$//'` + if [ $basic_machine != $1 ] + then os=`echo $1 | sed 's/.*-/-/'` + else os=; fi + ;; +esac + +### Let's recognize common machines as not being operating systems so +### that things like config.sub decstation-3100 work. We also +### recognize some manufacturers as not being operating systems, so we +### can provide default operating systems below. +case $os in + -sun*os*) + # Prevent following clause from handling this invalid input. + ;; + -dec* | -mips* | -sequent* | -encore* | -pc532* | -sgi* | -sony* | \ + -att* | -7300* | -3300* | -delta* | -motorola* | -sun[234]* | \ + -unicom* | -ibm* | -next | -hp | -isi* | -apollo | -altos* | \ + -convergent* | -ncr* | -news | -32* | -3600* | -3100* | -hitachi* |\ + -c[123]* | -convex* | -sun | -crds | -omron* | -dg | -ultra | -tti* | \ + -harris | -dolphin | -highlevel | -gould | -cbm | -ns | -masscomp | \ + -apple | -axis) + os= + basic_machine=$1 + ;; + -sim | -cisco | -oki | -wec | -winbond) + os= + basic_machine=$1 + ;; + -scout) + ;; + -wrs) + os=-vxworks + basic_machine=$1 + ;; + -chorusos*) + os=-chorusos + basic_machine=$1 + ;; + -chorusrdb) + os=-chorusrdb + basic_machine=$1 + ;; + -hiux*) + os=-hiuxwe2 + ;; + -sco5) + os=-sco3.2v5 + basic_machine=`echo $1 | sed -e 's/86-.*/86-pc/'` + ;; + -sco4) + os=-sco3.2v4 + basic_machine=`echo $1 | sed -e 's/86-.*/86-pc/'` + ;; + -sco3.2.[4-9]*) + os=`echo $os | sed -e 's/sco3.2./sco3.2v/'` + basic_machine=`echo $1 | sed -e 's/86-.*/86-pc/'` + ;; + -sco3.2v[4-9]*) + # Don't forget version if it is 3.2v4 or newer. + basic_machine=`echo $1 | sed -e 's/86-.*/86-pc/'` + ;; + -sco*) + os=-sco3.2v2 + basic_machine=`echo $1 | sed -e 's/86-.*/86-pc/'` + ;; + -udk*) + basic_machine=`echo $1 | sed -e 's/86-.*/86-pc/'` + ;; + -isc) + os=-isc2.2 + basic_machine=`echo $1 | sed -e 's/86-.*/86-pc/'` + ;; + -clix*) + basic_machine=clipper-intergraph + ;; + -isc*) + basic_machine=`echo $1 | sed -e 's/86-.*/86-pc/'` + ;; + -lynx*) + os=-lynxos + ;; + -ptx*) + basic_machine=`echo $1 | sed -e 's/86-.*/86-sequent/'` + ;; + -windowsnt*) + os=`echo $os | sed -e 's/windowsnt/winnt/'` + ;; + -psos*) + os=-psos + ;; + -mint | -mint[0-9]*) + basic_machine=m68k-atari + os=-mint + ;; +esac + +# Decode aliases for certain CPU-COMPANY combinations. +case $basic_machine in + # Recognize the basic CPU types without company name. + # Some are omitted here because they have special meanings below. + 1750a | 580 \ + | a29k \ + | alpha | alphaev[4-8] | alphaev56 | alphaev6[78] | alphapca5[67] \ + | alpha64 | alpha64ev[4-8] | alpha64ev56 | alpha64ev6[78] | alpha64pca5[67] \ + | arc | arm | arm[bl]e | arme[lb] | armv[2345] | armv[345][lb] | avr \ + | c4x | clipper \ + | d10v | d30v | dlx | dsp16xx \ + | fr30 \ + | h8300 | h8500 | hppa | hppa1.[01] | hppa2.0 | hppa2.0[nw] | hppa64 \ + | i370 | i860 | i960 | ia64 \ + | m32r | m68000 | m68k | m88k | mcore \ + | mips | mips16 | mips64 | mips64el | mips64orion | mips64orionel \ + | mips64vr4100 | mips64vr4100el | mips64vr4300 \ + | mips64vr4300el | mips64vr5000 | mips64vr5000el \ + | mipsbe | mipseb | mipsel | mipsle | mipstx39 | mipstx39el \ + | mipsisa32 | mipsisa64 \ + | mn10200 | mn10300 \ + | ns16k | ns32k \ + | openrisc | or32 \ + | pdp10 | pdp11 | pj | pjl \ + | powerpc | powerpc64 | powerpc64le | powerpcle | ppcbe \ + | pyramid \ + | sh | sh[34] | sh[34]eb | shbe | shle | sh64 \ + | sparc | sparc64 | sparc86x | sparclet | sparclite | sparcv9 | sparcv9b \ + | strongarm \ + | tahoe | thumb | tic80 | tron \ + | v850 | v850e \ + | we32k \ + | x86 | xscale | xstormy16 | xtensa \ + | z8k) + basic_machine=$basic_machine-unknown + ;; + m6811 | m68hc11 | m6812 | m68hc12) + # Motorola 68HC11/12. + basic_machine=$basic_machine-unknown + os=-none + ;; + m88110 | m680[12346]0 | m683?2 | m68360 | m5200 | v70 | w65 | z8k) + ;; + + # We use `pc' rather than `unknown' + # because (1) that's what they normally are, and + # (2) the word "unknown" tends to confuse beginning users. + i*86 | x86_64) + basic_machine=$basic_machine-pc + ;; + # Object if more than one company name word. + *-*-*) + echo Invalid configuration \`$1\': machine \`$basic_machine\' not recognized 1>&2 + exit 1 + ;; + # Recognize the basic CPU types with company name. + 580-* \ + | a29k-* \ + | alpha-* | alphaev[4-8]-* | alphaev56-* | alphaev6[78]-* \ + | alpha64-* | alpha64ev[4-8]-* | alpha64ev56-* | alpha64ev6[78]-* \ + | alphapca5[67]-* | alpha64pca5[67]-* | arc-* \ + | arm-* | armbe-* | armle-* | armeb-* | armv*-* \ + | avr-* \ + | bs2000-* \ + | c[123]* | c30-* | [cjt]90-* | c54x-* \ + | clipper-* | cydra-* \ + | d10v-* | d30v-* | dlx-* \ + | elxsi-* \ + | f30[01]-* | f700-* | fr30-* | fx80-* \ + | h8300-* | h8500-* \ + | hppa-* | hppa1.[01]-* | hppa2.0-* | hppa2.0[nw]-* | hppa64-* \ + | i*86-* | i860-* | i960-* | ia64-* \ + | m32r-* \ + | m68000-* | m680[012346]0-* | m68360-* | m683?2-* | m68k-* \ + | m88110-* | m88k-* | mcore-* \ + | mips-* | mips16-* | mips64-* | mips64el-* | mips64orion-* \ + | mips64orionel-* | mips64vr4100-* | mips64vr4100el-* \ + | mips64vr4300-* | mips64vr4300el-* | mipsbe-* | mipseb-* \ + | mipsle-* | mipsel-* | mipstx39-* | mipstx39el-* \ + | none-* | np1-* | ns16k-* | ns32k-* \ + | orion-* \ + | pdp10-* | pdp11-* | pj-* | pjl-* | pn-* | power-* \ + | powerpc-* | powerpc64-* | powerpc64le-* | powerpcle-* | ppcbe-* \ + | pyramid-* \ + | romp-* | rs6000-* \ + | sh-* | sh[34]-* | sh[34]eb-* | shbe-* | shle-* | sh64-* \ + | sparc-* | sparc64-* | sparc86x-* | sparclet-* | sparclite-* \ + | sparcv9-* | sparcv9b-* | strongarm-* | sv1-* | sx?-* \ + | tahoe-* | thumb-* | tic30-* | tic54x-* | tic80-* | tron-* \ + | v850-* | v850e-* | vax-* \ + | we32k-* \ + | x86-* | x86_64-* | xps100-* | xscale-* | xstormy16-* \ + | xtensa-* \ + | ymp-* \ + | z8k-*) + ;; + # Recognize the various machine names and aliases which stand + # for a CPU type and a company and sometimes even an OS. + 386bsd) + basic_machine=i386-unknown + os=-bsd + ;; + 3b1 | 7300 | 7300-att | att-7300 | pc7300 | safari | unixpc) + basic_machine=m68000-att + ;; + 3b*) + basic_machine=we32k-att + ;; + a29khif) + basic_machine=a29k-amd + os=-udi + ;; + adobe68k) + basic_machine=m68010-adobe + os=-scout + ;; + alliant | fx80) + basic_machine=fx80-alliant + ;; + altos | altos3068) + basic_machine=m68k-altos + ;; + am29k) + basic_machine=a29k-none + os=-bsd + ;; + amdahl) + basic_machine=580-amdahl + os=-sysv + ;; + amiga | amiga-*) + basic_machine=m68k-unknown + ;; + amigaos | amigados) + basic_machine=m68k-unknown + os=-amigaos + ;; + amigaunix | amix) + basic_machine=m68k-unknown + os=-sysv4 + ;; + apollo68) + basic_machine=m68k-apollo + os=-sysv + ;; + apollo68bsd) + basic_machine=m68k-apollo + os=-bsd + ;; + aux) + basic_machine=m68k-apple + os=-aux + ;; + balance) + basic_machine=ns32k-sequent + os=-dynix + ;; + c90) + basic_machine=c90-cray + os=-unicos + ;; + convex-c1) + basic_machine=c1-convex + os=-bsd + ;; + convex-c2) + basic_machine=c2-convex + os=-bsd + ;; + convex-c32) + basic_machine=c32-convex + os=-bsd + ;; + convex-c34) + basic_machine=c34-convex + os=-bsd + ;; + convex-c38) + basic_machine=c38-convex + os=-bsd + ;; + cray | j90) + basic_machine=j90-cray + os=-unicos + ;; + crds | unos) + basic_machine=m68k-crds + ;; + cris | cris-* | etrax*) + basic_machine=cris-axis + ;; + da30 | da30-*) + basic_machine=m68k-da30 + ;; + decstation | decstation-3100 | pmax | pmax-* | pmin | dec3100 | decstatn) + basic_machine=mips-dec + ;; + decsystem10* | dec10*) + basic_machine=pdp10-dec + os=-tops10 + ;; + decsystem20* | dec20*) + basic_machine=pdp10-dec + os=-tops20 + ;; + delta | 3300 | motorola-3300 | motorola-delta \ + | 3300-motorola | delta-motorola) + basic_machine=m68k-motorola + ;; + delta88) + basic_machine=m88k-motorola + os=-sysv3 + ;; + dpx20 | dpx20-*) + basic_machine=rs6000-bull + os=-bosx + ;; + dpx2* | dpx2*-bull) + basic_machine=m68k-bull + os=-sysv3 + ;; + ebmon29k) + basic_machine=a29k-amd + os=-ebmon + ;; + elxsi) + basic_machine=elxsi-elxsi + os=-bsd + ;; + encore | umax | mmax) + basic_machine=ns32k-encore + ;; + es1800 | OSE68k | ose68k | ose | OSE) + basic_machine=m68k-ericsson + os=-ose + ;; + fx2800) + basic_machine=i860-alliant + ;; + genix) + basic_machine=ns32k-ns + ;; + gmicro) + basic_machine=tron-gmicro + os=-sysv + ;; + go32) + basic_machine=i386-pc + os=-go32 + ;; + h3050r* | hiux*) + basic_machine=hppa1.1-hitachi + os=-hiuxwe2 + ;; + h8300hms) + basic_machine=h8300-hitachi + os=-hms + ;; + h8300xray) + basic_machine=h8300-hitachi + os=-xray + ;; + h8500hms) + basic_machine=h8500-hitachi + os=-hms + ;; + harris) + basic_machine=m88k-harris + os=-sysv3 + ;; + hp300-*) + basic_machine=m68k-hp + ;; + hp300bsd) + basic_machine=m68k-hp + os=-bsd + ;; + hp300hpux) + basic_machine=m68k-hp + os=-hpux + ;; + hp3k9[0-9][0-9] | hp9[0-9][0-9]) + basic_machine=hppa1.0-hp + ;; + hp9k2[0-9][0-9] | hp9k31[0-9]) + basic_machine=m68000-hp + ;; + hp9k3[2-9][0-9]) + basic_machine=m68k-hp + ;; + hp9k6[0-9][0-9] | hp6[0-9][0-9]) + basic_machine=hppa1.0-hp + ;; + hp9k7[0-79][0-9] | hp7[0-79][0-9]) + basic_machine=hppa1.1-hp + ;; + hp9k78[0-9] | hp78[0-9]) + # FIXME: really hppa2.0-hp + basic_machine=hppa1.1-hp + ;; + hp9k8[67]1 | hp8[67]1 | hp9k80[24] | hp80[24] | hp9k8[78]9 | hp8[78]9 | hp9k893 | hp893) + # FIXME: really hppa2.0-hp + basic_machine=hppa1.1-hp + ;; + hp9k8[0-9][13679] | hp8[0-9][13679]) + basic_machine=hppa1.1-hp + ;; + hp9k8[0-9][0-9] | hp8[0-9][0-9]) + basic_machine=hppa1.0-hp + ;; + hppa-next) + os=-nextstep3 + ;; + hppaosf) + basic_machine=hppa1.1-hp + os=-osf + ;; + hppro) + basic_machine=hppa1.1-hp + os=-proelf + ;; + i370-ibm* | ibm*) + basic_machine=i370-ibm + ;; +# I'm not sure what "Sysv32" means. Should this be sysv3.2? + i*86v32) + basic_machine=`echo $1 | sed -e 's/86.*/86-pc/'` + os=-sysv32 + ;; + i*86v4*) + basic_machine=`echo $1 | sed -e 's/86.*/86-pc/'` + os=-sysv4 + ;; + i*86v) + basic_machine=`echo $1 | sed -e 's/86.*/86-pc/'` + os=-sysv + ;; + i*86sol2) + basic_machine=`echo $1 | sed -e 's/86.*/86-pc/'` + os=-solaris2 + ;; + i386mach) + basic_machine=i386-mach + os=-mach + ;; + i386-vsta | vsta) + basic_machine=i386-unknown + os=-vsta + ;; + iris | iris4d) + basic_machine=mips-sgi + case $os in + -irix*) + ;; + *) + os=-irix4 + ;; + esac + ;; + isi68 | isi) + basic_machine=m68k-isi + os=-sysv + ;; + m88k-omron*) + basic_machine=m88k-omron + ;; + magnum | m3230) + basic_machine=mips-mips + os=-sysv + ;; + merlin) + basic_machine=ns32k-utek + os=-sysv + ;; + mingw32) + basic_machine=i386-pc + os=-mingw32 + ;; + miniframe) + basic_machine=m68000-convergent + ;; + *mint | -mint[0-9]* | *MiNT | *MiNT[0-9]*) + basic_machine=m68k-atari + os=-mint + ;; + mips3*-*) + basic_machine=`echo $basic_machine | sed -e 's/mips3/mips64/'` + ;; + mips3*) + basic_machine=`echo $basic_machine | sed -e 's/mips3/mips64/'`-unknown + ;; + mmix*) + basic_machine=mmix-knuth + os=-mmixware + ;; + monitor) + basic_machine=m68k-rom68k + os=-coff + ;; + morphos) + basic_machine=powerpc-unknown + os=-morphos + ;; + msdos) + basic_machine=i386-pc + os=-msdos + ;; + mvs) + basic_machine=i370-ibm + os=-mvs + ;; + ncr3000) + basic_machine=i486-ncr + os=-sysv4 + ;; + netbsd386) + basic_machine=i386-unknown + os=-netbsd + ;; + netwinder) + basic_machine=armv4l-rebel + os=-linux + ;; + news | news700 | news800 | news900) + basic_machine=m68k-sony + os=-newsos + ;; + news1000) + basic_machine=m68030-sony + os=-newsos + ;; + news-3600 | risc-news) + basic_machine=mips-sony + os=-newsos + ;; + necv70) + basic_machine=v70-nec + os=-sysv + ;; + next | m*-next ) + basic_machine=m68k-next + case $os in + -nextstep* ) + ;; + -ns2*) + os=-nextstep2 + ;; + *) + os=-nextstep3 + ;; + esac + ;; + nh3000) + basic_machine=m68k-harris + os=-cxux + ;; + nh[45]000) + basic_machine=m88k-harris + os=-cxux + ;; + nindy960) + basic_machine=i960-intel + os=-nindy + ;; + mon960) + basic_machine=i960-intel + os=-mon960 + ;; + nonstopux) + basic_machine=mips-compaq + os=-nonstopux + ;; + np1) + basic_machine=np1-gould + ;; + nsr-tandem) + basic_machine=nsr-tandem + ;; + op50n-* | op60c-*) + basic_machine=hppa1.1-oki + os=-proelf + ;; + or32 | or32-*) + basic_machine=or32-unknown + os=-coff + ;; + OSE68000 | ose68000) + basic_machine=m68000-ericsson + os=-ose + ;; + os68k) + basic_machine=m68k-none + os=-os68k + ;; + pa-hitachi) + basic_machine=hppa1.1-hitachi + os=-hiuxwe2 + ;; + paragon) + basic_machine=i860-intel + os=-osf + ;; + pbd) + basic_machine=sparc-tti + ;; + pbb) + basic_machine=m68k-tti + ;; + pc532 | pc532-*) + basic_machine=ns32k-pc532 + ;; + pentium | p5 | k5 | k6 | nexgen | viac3) + basic_machine=i586-pc + ;; + pentiumpro | p6 | 6x86 | athlon) + basic_machine=i686-pc + ;; + pentiumii | pentium2) + basic_machine=i686-pc + ;; + pentium-* | p5-* | k5-* | k6-* | nexgen-* | viac3-*) + basic_machine=i586-`echo $basic_machine | sed 's/^[^-]*-//'` + ;; + pentiumpro-* | p6-* | 6x86-* | athlon-*) + basic_machine=i686-`echo $basic_machine | sed 's/^[^-]*-//'` + ;; + pentiumii-* | pentium2-*) + basic_machine=i686-`echo $basic_machine | sed 's/^[^-]*-//'` + ;; + pn) + basic_machine=pn-gould + ;; + power) basic_machine=power-ibm + ;; + ppc) basic_machine=powerpc-unknown + ;; + ppc-*) basic_machine=powerpc-`echo $basic_machine | sed 's/^[^-]*-//'` + ;; + ppcle | powerpclittle | ppc-le | powerpc-little) + basic_machine=powerpcle-unknown + ;; + ppcle-* | powerpclittle-*) + basic_machine=powerpcle-`echo $basic_machine | sed 's/^[^-]*-//'` + ;; + ppc64) basic_machine=powerpc64-unknown + ;; + ppc64-*) basic_machine=powerpc64-`echo $basic_machine | sed 's/^[^-]*-//'` + ;; + ppc64le | powerpc64little | ppc64-le | powerpc64-little) + basic_machine=powerpc64le-unknown + ;; + ppc64le-* | powerpc64little-*) + basic_machine=powerpc64le-`echo $basic_machine | sed 's/^[^-]*-//'` + ;; + ps2) + basic_machine=i386-ibm + ;; + pw32) + basic_machine=i586-unknown + os=-pw32 + ;; + rom68k) + basic_machine=m68k-rom68k + os=-coff + ;; + rm[46]00) + basic_machine=mips-siemens + ;; + rtpc | rtpc-*) + basic_machine=romp-ibm + ;; + s390 | s390-*) + basic_machine=s390-ibm + ;; + s390x | s390x-*) + basic_machine=s390x-ibm + ;; + sa29200) + basic_machine=a29k-amd + os=-udi + ;; + sequent) + basic_machine=i386-sequent + ;; + sh) + basic_machine=sh-hitachi + os=-hms + ;; + sparclite-wrs | simso-wrs) + basic_machine=sparclite-wrs + os=-vxworks + ;; + sps7) + basic_machine=m68k-bull + os=-sysv2 + ;; + spur) + basic_machine=spur-unknown + ;; + st2000) + basic_machine=m68k-tandem + ;; + stratus) + basic_machine=i860-stratus + os=-sysv4 + ;; + sun2) + basic_machine=m68000-sun + ;; + sun2os3) + basic_machine=m68000-sun + os=-sunos3 + ;; + sun2os4) + basic_machine=m68000-sun + os=-sunos4 + ;; + sun3os3) + basic_machine=m68k-sun + os=-sunos3 + ;; + sun3os4) + basic_machine=m68k-sun + os=-sunos4 + ;; + sun4os3) + basic_machine=sparc-sun + os=-sunos3 + ;; + sun4os4) + basic_machine=sparc-sun + os=-sunos4 + ;; + sun4sol2) + basic_machine=sparc-sun + os=-solaris2 + ;; + sun3 | sun3-*) + basic_machine=m68k-sun + ;; + sun4) + basic_machine=sparc-sun + ;; + sun386 | sun386i | roadrunner) + basic_machine=i386-sun + ;; + sv1) + basic_machine=sv1-cray + os=-unicos + ;; + symmetry) + basic_machine=i386-sequent + os=-dynix + ;; + t3d) + basic_machine=alpha-cray + os=-unicos + ;; + t3e) + basic_machine=alphaev5-cray + os=-unicos + ;; + t90) + basic_machine=t90-cray + os=-unicos + ;; + tic54x | c54x*) + basic_machine=tic54x-unknown + os=-coff + ;; + tx39) + basic_machine=mipstx39-unknown + ;; + tx39el) + basic_machine=mipstx39el-unknown + ;; + toad1) + basic_machine=pdp10-xkl + os=-tops20 + ;; + tower | tower-32) + basic_machine=m68k-ncr + ;; + udi29k) + basic_machine=a29k-amd + os=-udi + ;; + ultra3) + basic_machine=a29k-nyu + os=-sym1 + ;; + v810 | necv810) + basic_machine=v810-nec + os=-none + ;; + vaxv) + basic_machine=vax-dec + os=-sysv + ;; + vms) + basic_machine=vax-dec + os=-vms + ;; + vpp*|vx|vx-*) + basic_machine=f301-fujitsu + ;; + vxworks960) + basic_machine=i960-wrs + os=-vxworks + ;; + vxworks68) + basic_machine=m68k-wrs + os=-vxworks + ;; + vxworks29k) + basic_machine=a29k-wrs + os=-vxworks + ;; + w65*) + basic_machine=w65-wdc + os=-none + ;; + w89k-*) + basic_machine=hppa1.1-winbond + os=-proelf + ;; + windows32) + basic_machine=i386-pc + os=-windows32-msvcrt + ;; + xps | xps100) + basic_machine=xps100-honeywell + ;; + ymp) + basic_machine=ymp-cray + os=-unicos + ;; + z8k-*-coff) + basic_machine=z8k-unknown + os=-sim + ;; + none) + basic_machine=none-none + os=-none + ;; + +# Here we handle the default manufacturer of certain CPU types. It is in +# some cases the only manufacturer, in others, it is the most popular. + w89k) + basic_machine=hppa1.1-winbond + ;; + op50n) + basic_machine=hppa1.1-oki + ;; + op60c) + basic_machine=hppa1.1-oki + ;; + romp) + basic_machine=romp-ibm + ;; + rs6000) + basic_machine=rs6000-ibm + ;; + vax) + basic_machine=vax-dec + ;; + pdp10) + # there are many clones, so DEC is not a safe bet + basic_machine=pdp10-unknown + ;; + pdp11) + basic_machine=pdp11-dec + ;; + we32k) + basic_machine=we32k-att + ;; + sh3 | sh4 | sh3eb | sh4eb) + basic_machine=sh-unknown + ;; + sh64) + basic_machine=sh64-unknown + ;; + sparc | sparcv9 | sparcv9b) + basic_machine=sparc-sun + ;; + cydra) + basic_machine=cydra-cydrome + ;; + orion) + basic_machine=orion-highlevel + ;; + orion105) + basic_machine=clipper-highlevel + ;; + mac | mpw | mac-mpw) + basic_machine=m68k-apple + ;; + pmac | pmac-mpw) + basic_machine=powerpc-apple + ;; + c4x*) + basic_machine=c4x-none + os=-coff + ;; + *-unknown) + # Make sure to match an already-canonicalized machine name. + ;; + *) + echo Invalid configuration \`$1\': machine \`$basic_machine\' not recognized 1>&2 + exit 1 + ;; +esac + +# Here we canonicalize certain aliases for manufacturers. +case $basic_machine in + *-digital*) + basic_machine=`echo $basic_machine | sed 's/digital.*/dec/'` + ;; + *-commodore*) + basic_machine=`echo $basic_machine | sed 's/commodore.*/cbm/'` + ;; + *) + ;; +esac + +# Decode manufacturer-specific aliases for certain operating systems. + +if [ x"$os" != x"" ] +then +case $os in + # First match some system type aliases + # that might get confused with valid system types. + # -solaris* is a basic system type, with this one exception. + -solaris1 | -solaris1.*) + os=`echo $os | sed -e 's|solaris1|sunos4|'` + ;; + -solaris) + os=-solaris2 + ;; + -svr4*) + os=-sysv4 + ;; + -unixware*) + os=-sysv4.2uw + ;; + -gnu/linux*) + os=`echo $os | sed -e 's|gnu/linux|linux-gnu|'` + ;; + # First accept the basic system types. + # The portable systems comes first. + # Each alternative MUST END IN A *, to match a version number. + # -sysv* is not here because it comes later, after sysvr4. + -gnu* | -bsd* | -mach* | -minix* | -genix* | -ultrix* | -irix* \ + | -*vms* | -sco* | -esix* | -isc* | -aix* | -sunos | -sunos[34]*\ + | -hpux* | -unos* | -osf* | -luna* | -dgux* | -solaris* | -sym* \ + | -amigaos* | -amigados* | -msdos* | -newsos* | -unicos* | -aof* \ + | -aos* \ + | -nindy* | -vxsim* | -vxworks* | -ebmon* | -hms* | -mvs* \ + | -clix* | -riscos* | -uniplus* | -iris* | -rtu* | -xenix* \ + | -hiux* | -386bsd* | -netbsd* | -openbsd* | -freebsd* | -riscix* \ + | -lynxos* | -bosx* | -nextstep* | -cxux* | -aout* | -elf* | -oabi* \ + | -ptx* | -coff* | -ecoff* | -winnt* | -domain* | -vsta* \ + | -udi* | -eabi* | -lites* | -ieee* | -go32* | -aux* \ + | -chorusos* | -chorusrdb* \ + | -cygwin* | -pe* | -psos* | -moss* | -proelf* | -rtems* \ + | -mingw32* | -linux-gnu* | -uxpv* | -beos* | -mpeix* | -udk* \ + | -interix* | -uwin* | -rhapsody* | -darwin* | -opened* \ + | -openstep* | -oskit* | -conix* | -pw32* | -nonstopux* \ + | -storm-chaos* | -tops10* | -tenex* | -tops20* | -its* \ + | -os2* | -vos* | -palmos* | -uclinux* | -nucleus* \ + | -morphos* | -superux* | -rtmk* | -rtmk-nova* | -windiss* | -powermax*) + # Remember, each alternative MUST END IN *, to match a version number. + ;; + -qnx*) + case $basic_machine in + x86-* | i*86-*) + ;; + *) + os=-nto$os + ;; + esac + ;; + -nto*) + os=-nto-qnx + ;; + -sim | -es1800* | -hms* | -xray | -os68k* | -none* | -v88r* \ + | -windows* | -osx | -abug | -netware* | -os9* | -beos* \ + | -macos* | -mpw* | -magic* | -mmixware* | -mon960* | -lnews*) + ;; + -mac*) + os=`echo $os | sed -e 's|mac|macos|'` + ;; + -linux*) + os=`echo $os | sed -e 's|linux|linux-gnu|'` + ;; + -sunos5*) + os=`echo $os | sed -e 's|sunos5|solaris2|'` + ;; + -sunos6*) + os=`echo $os | sed -e 's|sunos6|solaris3|'` + ;; + -opened*) + os=-openedition + ;; + -wince*) + os=-wince + ;; + -osfrose*) + os=-osfrose + ;; + -osf*) + os=-osf + ;; + -utek*) + os=-bsd + ;; + -dynix*) + os=-bsd + ;; + -acis*) + os=-aos + ;; + -atheos*) + os=-atheos + ;; + -386bsd) + os=-bsd + ;; + -ctix* | -uts*) + os=-sysv + ;; + -nova*) + os=-rtmk-nova + ;; + -ns2 ) + os=-nextstep2 + ;; + -nsk*) + os=-nsk + ;; + # Preserve the version number of sinix5. + -sinix5.*) + os=`echo $os | sed -e 's|sinix|sysv|'` + ;; + -sinix*) + os=-sysv4 + ;; + -triton*) + os=-sysv3 + ;; + -oss*) + os=-sysv3 + ;; + -svr4) + os=-sysv4 + ;; + -svr3) + os=-sysv3 + ;; + -sysvr4) + os=-sysv4 + ;; + # This must come after -sysvr4. + -sysv*) + ;; + -ose*) + os=-ose + ;; + -es1800*) + os=-ose + ;; + -xenix) + os=-xenix + ;; + -*mint | -mint[0-9]* | -*MiNT | -MiNT[0-9]*) + os=-mint + ;; + -none) + ;; + *) + # Get rid of the `-' at the beginning of $os. + os=`echo $os | sed 's/[^-]*-//'` + echo Invalid configuration \`$1\': system \`$os\' not recognized 1>&2 + exit 1 + ;; +esac +else + +# Here we handle the default operating systems that come with various machines. +# The value should be what the vendor currently ships out the door with their +# machine or put another way, the most popular os provided with the machine. + +# Note that if you're going to try to match "-MANUFACTURER" here (say, +# "-sun"), then you have to tell the case statement up towards the top +# that MANUFACTURER isn't an operating system. Otherwise, code above +# will signal an error saying that MANUFACTURER isn't an operating +# system, and we'll never get to this point. + +case $basic_machine in + *-acorn) + os=-riscix1.2 + ;; + arm*-rebel) + os=-linux + ;; + arm*-semi) + os=-aout + ;; + # This must come before the *-dec entry. + pdp10-*) + os=-tops20 + ;; + pdp11-*) + os=-none + ;; + *-dec | vax-*) + os=-ultrix4.2 + ;; + m68*-apollo) + os=-domain + ;; + i386-sun) + os=-sunos4.0.2 + ;; + m68000-sun) + os=-sunos3 + # This also exists in the configure program, but was not the + # default. + # os=-sunos4 + ;; + m68*-cisco) + os=-aout + ;; + mips*-cisco) + os=-elf + ;; + mips*-*) + os=-elf + ;; + or32-*) + os=-coff + ;; + *-tti) # must be before sparc entry or we get the wrong os. + os=-sysv3 + ;; + sparc-* | *-sun) + os=-sunos4.1.1 + ;; + *-be) + os=-beos + ;; + *-ibm) + os=-aix + ;; + *-wec) + os=-proelf + ;; + *-winbond) + os=-proelf + ;; + *-oki) + os=-proelf + ;; + *-hp) + os=-hpux + ;; + *-hitachi) + os=-hiux + ;; + i860-* | *-att | *-ncr | *-altos | *-motorola | *-convergent) + os=-sysv + ;; + *-cbm) + os=-amigaos + ;; + *-dg) + os=-dgux + ;; + *-dolphin) + os=-sysv3 + ;; + m68k-ccur) + os=-rtu + ;; + m88k-omron*) + os=-luna + ;; + *-next ) + os=-nextstep + ;; + *-sequent) + os=-ptx + ;; + *-crds) + os=-unos + ;; + *-ns) + os=-genix + ;; + i370-*) + os=-mvs + ;; + *-next) + os=-nextstep3 + ;; + *-gould) + os=-sysv + ;; + *-highlevel) + os=-bsd + ;; + *-encore) + os=-bsd + ;; + *-sgi) + os=-irix + ;; + *-siemens) + os=-sysv4 + ;; + *-masscomp) + os=-rtu + ;; + f30[01]-fujitsu | f700-fujitsu) + os=-uxpv + ;; + *-rom68k) + os=-coff + ;; + *-*bug) + os=-coff + ;; + *-apple) + os=-macos + ;; + *-atari*) + os=-mint + ;; + *) + os=-none + ;; +esac +fi + +# Here we handle the case where we know the os, and the CPU type, but not the +# manufacturer. We pick the logical manufacturer. +vendor=unknown +case $basic_machine in + *-unknown) + case $os in + -riscix*) + vendor=acorn + ;; + -sunos*) + vendor=sun + ;; + -aix*) + vendor=ibm + ;; + -beos*) + vendor=be + ;; + -hpux*) + vendor=hp + ;; + -mpeix*) + vendor=hp + ;; + -hiux*) + vendor=hitachi + ;; + -unos*) + vendor=crds + ;; + -dgux*) + vendor=dg + ;; + -luna*) + vendor=omron + ;; + -genix*) + vendor=ns + ;; + -mvs* | -opened*) + vendor=ibm + ;; + -ptx*) + vendor=sequent + ;; + -vxsim* | -vxworks* | -windiss*) + vendor=wrs + ;; + -aux*) + vendor=apple + ;; + -hms*) + vendor=hitachi + ;; + -mpw* | -macos*) + vendor=apple + ;; + -*mint | -mint[0-9]* | -*MiNT | -MiNT[0-9]*) + vendor=atari + ;; + -vos*) + vendor=stratus + ;; + esac + basic_machine=`echo $basic_machine | sed "s/unknown/$vendor/"` + ;; +esac + +echo $basic_machine$os +exit 0 + +# Local variables: +# eval: (add-hook 'write-file-hooks 'time-stamp) +# time-stamp-start: "timestamp='" +# time-stamp-format: "%:y-%02m-%02d" +# time-stamp-end: "'" +# End: diff --git a/libconfig-1.4.9/aux-build/depcomp b/libconfig-1.4.9/aux-build/depcomp new file mode 100755 index 0000000000000000000000000000000000000000..df8eea7e4ce8862105fcd7929b20bdb45488048b --- /dev/null +++ b/libconfig-1.4.9/aux-build/depcomp @@ -0,0 +1,630 @@ +#! /bin/sh +# depcomp - compile a program generating dependencies as side-effects + +scriptversion=2009-04-28.21; # UTC + +# Copyright (C) 1999, 2000, 2003, 2004, 2005, 2006, 2007, 2009 Free +# Software Foundation, Inc. + +# This program is free software; you can redistribute it and/or modify +# it under the terms of the GNU General Public License as published by +# the Free Software Foundation; either version 2, or (at your option) +# any later version. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY; without even the implied warranty of +# MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +# GNU General Public License for more details. + +# You should have received a copy of the GNU General Public License +# along with this program. If not, see . + +# As a special exception to the GNU General Public License, if you +# distribute this file as part of a program that contains a +# configuration script generated by Autoconf, you may include it under +# the same distribution terms that you use for the rest of that program. + +# Originally written by Alexandre Oliva . + +case $1 in + '') + echo "$0: No command. Try \`$0 --help' for more information." 1>&2 + exit 1; + ;; + -h | --h*) + cat <<\EOF +Usage: depcomp [--help] [--version] PROGRAM [ARGS] + +Run PROGRAMS ARGS to compile a file, generating dependencies +as side-effects. + +Environment variables: + depmode Dependency tracking mode. + source Source file read by `PROGRAMS ARGS'. + object Object file output by `PROGRAMS ARGS'. + DEPDIR directory where to store dependencies. + depfile Dependency file to output. + tmpdepfile Temporary file to use when outputing dependencies. + libtool Whether libtool is used (yes/no). + +Report bugs to . +EOF + exit $? + ;; + -v | --v*) + echo "depcomp $scriptversion" + exit $? + ;; +esac + +if test -z "$depmode" || test -z "$source" || test -z "$object"; then + echo "depcomp: Variables source, object and depmode must be set" 1>&2 + exit 1 +fi + +# Dependencies for sub/bar.o or sub/bar.obj go into sub/.deps/bar.Po. +depfile=${depfile-`echo "$object" | + sed 's|[^\\/]*$|'${DEPDIR-.deps}'/&|;s|\.\([^.]*\)$|.P\1|;s|Pobj$|Po|'`} +tmpdepfile=${tmpdepfile-`echo "$depfile" | sed 's/\.\([^.]*\)$/.T\1/'`} + +rm -f "$tmpdepfile" + +# Some modes work just like other modes, but use different flags. We +# parameterize here, but still list the modes in the big case below, +# to make depend.m4 easier to write. Note that we *cannot* use a case +# here, because this file can only contain one case statement. +if test "$depmode" = hp; then + # HP compiler uses -M and no extra arg. + gccflag=-M + depmode=gcc +fi + +if test "$depmode" = dashXmstdout; then + # This is just like dashmstdout with a different argument. + dashmflag=-xM + depmode=dashmstdout +fi + +cygpath_u="cygpath -u -f -" +if test "$depmode" = msvcmsys; then + # This is just like msvisualcpp but w/o cygpath translation. + # Just convert the backslash-escaped backslashes to single forward + # slashes to satisfy depend.m4 + cygpath_u="sed s,\\\\\\\\,/,g" + depmode=msvisualcpp +fi + +case "$depmode" in +gcc3) +## gcc 3 implements dependency tracking that does exactly what +## we want. Yay! Note: for some reason libtool 1.4 doesn't like +## it if -MD -MP comes after the -MF stuff. Hmm. +## Unfortunately, FreeBSD c89 acceptance of flags depends upon +## the command line argument order; so add the flags where they +## appear in depend2.am. Note that the slowdown incurred here +## affects only configure: in makefiles, %FASTDEP% shortcuts this. + for arg + do + case $arg in + -c) set fnord "$@" -MT "$object" -MD -MP -MF "$tmpdepfile" "$arg" ;; + *) set fnord "$@" "$arg" ;; + esac + shift # fnord + shift # $arg + done + "$@" + stat=$? + if test $stat -eq 0; then : + else + rm -f "$tmpdepfile" + exit $stat + fi + mv "$tmpdepfile" "$depfile" + ;; + +gcc) +## There are various ways to get dependency output from gcc. Here's +## why we pick this rather obscure method: +## - Don't want to use -MD because we'd like the dependencies to end +## up in a subdir. Having to rename by hand is ugly. +## (We might end up doing this anyway to support other compilers.) +## - The DEPENDENCIES_OUTPUT environment variable makes gcc act like +## -MM, not -M (despite what the docs say). +## - Using -M directly means running the compiler twice (even worse +## than renaming). + if test -z "$gccflag"; then + gccflag=-MD, + fi + "$@" -Wp,"$gccflag$tmpdepfile" + stat=$? + if test $stat -eq 0; then : + else + rm -f "$tmpdepfile" + exit $stat + fi + rm -f "$depfile" + echo "$object : \\" > "$depfile" + alpha=ABCDEFGHIJKLMNOPQRSTUVWXYZabcdefghijklmnopqrstuvwxyz +## The second -e expression handles DOS-style file names with drive letters. + sed -e 's/^[^:]*: / /' \ + -e 's/^['$alpha']:\/[^:]*: / /' < "$tmpdepfile" >> "$depfile" +## This next piece of magic avoids the `deleted header file' problem. +## The problem is that when a header file which appears in a .P file +## is deleted, the dependency causes make to die (because there is +## typically no way to rebuild the header). We avoid this by adding +## dummy dependencies for each header file. Too bad gcc doesn't do +## this for us directly. + tr ' ' ' +' < "$tmpdepfile" | +## Some versions of gcc put a space before the `:'. On the theory +## that the space means something, we add a space to the output as +## well. +## Some versions of the HPUX 10.20 sed can't process this invocation +## correctly. Breaking it into two sed invocations is a workaround. + sed -e 's/^\\$//' -e '/^$/d' -e '/:$/d' | sed -e 's/$/ :/' >> "$depfile" + rm -f "$tmpdepfile" + ;; + +hp) + # This case exists only to let depend.m4 do its work. It works by + # looking at the text of this script. This case will never be run, + # since it is checked for above. + exit 1 + ;; + +sgi) + if test "$libtool" = yes; then + "$@" "-Wp,-MDupdate,$tmpdepfile" + else + "$@" -MDupdate "$tmpdepfile" + fi + stat=$? + if test $stat -eq 0; then : + else + rm -f "$tmpdepfile" + exit $stat + fi + rm -f "$depfile" + + if test -f "$tmpdepfile"; then # yes, the sourcefile depend on other files + echo "$object : \\" > "$depfile" + + # Clip off the initial element (the dependent). Don't try to be + # clever and replace this with sed code, as IRIX sed won't handle + # lines with more than a fixed number of characters (4096 in + # IRIX 6.2 sed, 8192 in IRIX 6.5). We also remove comment lines; + # the IRIX cc adds comments like `#:fec' to the end of the + # dependency line. + tr ' ' ' +' < "$tmpdepfile" \ + | sed -e 's/^.*\.o://' -e 's/#.*$//' -e '/^$/ d' | \ + tr ' +' ' ' >> "$depfile" + echo >> "$depfile" + + # The second pass generates a dummy entry for each header file. + tr ' ' ' +' < "$tmpdepfile" \ + | sed -e 's/^.*\.o://' -e 's/#.*$//' -e '/^$/ d' -e 's/$/:/' \ + >> "$depfile" + else + # The sourcefile does not contain any dependencies, so just + # store a dummy comment line, to avoid errors with the Makefile + # "include basename.Plo" scheme. + echo "#dummy" > "$depfile" + fi + rm -f "$tmpdepfile" + ;; + +aix) + # The C for AIX Compiler uses -M and outputs the dependencies + # in a .u file. In older versions, this file always lives in the + # current directory. Also, the AIX compiler puts `$object:' at the + # start of each line; $object doesn't have directory information. + # Version 6 uses the directory in both cases. + dir=`echo "$object" | sed -e 's|/[^/]*$|/|'` + test "x$dir" = "x$object" && dir= + base=`echo "$object" | sed -e 's|^.*/||' -e 's/\.o$//' -e 's/\.lo$//'` + if test "$libtool" = yes; then + tmpdepfile1=$dir$base.u + tmpdepfile2=$base.u + tmpdepfile3=$dir.libs/$base.u + "$@" -Wc,-M + else + tmpdepfile1=$dir$base.u + tmpdepfile2=$dir$base.u + tmpdepfile3=$dir$base.u + "$@" -M + fi + stat=$? + + if test $stat -eq 0; then : + else + rm -f "$tmpdepfile1" "$tmpdepfile2" "$tmpdepfile3" + exit $stat + fi + + for tmpdepfile in "$tmpdepfile1" "$tmpdepfile2" "$tmpdepfile3" + do + test -f "$tmpdepfile" && break + done + if test -f "$tmpdepfile"; then + # Each line is of the form `foo.o: dependent.h'. + # Do two passes, one to just change these to + # `$object: dependent.h' and one to simply `dependent.h:'. + sed -e "s,^.*\.[a-z]*:,$object:," < "$tmpdepfile" > "$depfile" + # That's a tab and a space in the []. + sed -e 's,^.*\.[a-z]*:[ ]*,,' -e 's,$,:,' < "$tmpdepfile" >> "$depfile" + else + # The sourcefile does not contain any dependencies, so just + # store a dummy comment line, to avoid errors with the Makefile + # "include basename.Plo" scheme. + echo "#dummy" > "$depfile" + fi + rm -f "$tmpdepfile" + ;; + +icc) + # Intel's C compiler understands `-MD -MF file'. However on + # icc -MD -MF foo.d -c -o sub/foo.o sub/foo.c + # ICC 7.0 will fill foo.d with something like + # foo.o: sub/foo.c + # foo.o: sub/foo.h + # which is wrong. We want: + # sub/foo.o: sub/foo.c + # sub/foo.o: sub/foo.h + # sub/foo.c: + # sub/foo.h: + # ICC 7.1 will output + # foo.o: sub/foo.c sub/foo.h + # and will wrap long lines using \ : + # foo.o: sub/foo.c ... \ + # sub/foo.h ... \ + # ... + + "$@" -MD -MF "$tmpdepfile" + stat=$? + if test $stat -eq 0; then : + else + rm -f "$tmpdepfile" + exit $stat + fi + rm -f "$depfile" + # Each line is of the form `foo.o: dependent.h', + # or `foo.o: dep1.h dep2.h \', or ` dep3.h dep4.h \'. + # Do two passes, one to just change these to + # `$object: dependent.h' and one to simply `dependent.h:'. + sed "s,^[^:]*:,$object :," < "$tmpdepfile" > "$depfile" + # Some versions of the HPUX 10.20 sed can't process this invocation + # correctly. Breaking it into two sed invocations is a workaround. + sed 's,^[^:]*: \(.*\)$,\1,;s/^\\$//;/^$/d;/:$/d' < "$tmpdepfile" | + sed -e 's/$/ :/' >> "$depfile" + rm -f "$tmpdepfile" + ;; + +hp2) + # The "hp" stanza above does not work with aCC (C++) and HP's ia64 + # compilers, which have integrated preprocessors. The correct option + # to use with these is +Maked; it writes dependencies to a file named + # 'foo.d', which lands next to the object file, wherever that + # happens to be. + # Much of this is similar to the tru64 case; see comments there. + dir=`echo "$object" | sed -e 's|/[^/]*$|/|'` + test "x$dir" = "x$object" && dir= + base=`echo "$object" | sed -e 's|^.*/||' -e 's/\.o$//' -e 's/\.lo$//'` + if test "$libtool" = yes; then + tmpdepfile1=$dir$base.d + tmpdepfile2=$dir.libs/$base.d + "$@" -Wc,+Maked + else + tmpdepfile1=$dir$base.d + tmpdepfile2=$dir$base.d + "$@" +Maked + fi + stat=$? + if test $stat -eq 0; then : + else + rm -f "$tmpdepfile1" "$tmpdepfile2" + exit $stat + fi + + for tmpdepfile in "$tmpdepfile1" "$tmpdepfile2" + do + test -f "$tmpdepfile" && break + done + if test -f "$tmpdepfile"; then + sed -e "s,^.*\.[a-z]*:,$object:," "$tmpdepfile" > "$depfile" + # Add `dependent.h:' lines. + sed -ne '2,${ + s/^ *// + s/ \\*$// + s/$/:/ + p + }' "$tmpdepfile" >> "$depfile" + else + echo "#dummy" > "$depfile" + fi + rm -f "$tmpdepfile" "$tmpdepfile2" + ;; + +tru64) + # The Tru64 compiler uses -MD to generate dependencies as a side + # effect. `cc -MD -o foo.o ...' puts the dependencies into `foo.o.d'. + # At least on Alpha/Redhat 6.1, Compaq CCC V6.2-504 seems to put + # dependencies in `foo.d' instead, so we check for that too. + # Subdirectories are respected. + dir=`echo "$object" | sed -e 's|/[^/]*$|/|'` + test "x$dir" = "x$object" && dir= + base=`echo "$object" | sed -e 's|^.*/||' -e 's/\.o$//' -e 's/\.lo$//'` + + if test "$libtool" = yes; then + # With Tru64 cc, shared objects can also be used to make a + # static library. This mechanism is used in libtool 1.4 series to + # handle both shared and static libraries in a single compilation. + # With libtool 1.4, dependencies were output in $dir.libs/$base.lo.d. + # + # With libtool 1.5 this exception was removed, and libtool now + # generates 2 separate objects for the 2 libraries. These two + # compilations output dependencies in $dir.libs/$base.o.d and + # in $dir$base.o.d. We have to check for both files, because + # one of the two compilations can be disabled. We should prefer + # $dir$base.o.d over $dir.libs/$base.o.d because the latter is + # automatically cleaned when .libs/ is deleted, while ignoring + # the former would cause a distcleancheck panic. + tmpdepfile1=$dir.libs/$base.lo.d # libtool 1.4 + tmpdepfile2=$dir$base.o.d # libtool 1.5 + tmpdepfile3=$dir.libs/$base.o.d # libtool 1.5 + tmpdepfile4=$dir.libs/$base.d # Compaq CCC V6.2-504 + "$@" -Wc,-MD + else + tmpdepfile1=$dir$base.o.d + tmpdepfile2=$dir$base.d + tmpdepfile3=$dir$base.d + tmpdepfile4=$dir$base.d + "$@" -MD + fi + + stat=$? + if test $stat -eq 0; then : + else + rm -f "$tmpdepfile1" "$tmpdepfile2" "$tmpdepfile3" "$tmpdepfile4" + exit $stat + fi + + for tmpdepfile in "$tmpdepfile1" "$tmpdepfile2" "$tmpdepfile3" "$tmpdepfile4" + do + test -f "$tmpdepfile" && break + done + if test -f "$tmpdepfile"; then + sed -e "s,^.*\.[a-z]*:,$object:," < "$tmpdepfile" > "$depfile" + # That's a tab and a space in the []. + sed -e 's,^.*\.[a-z]*:[ ]*,,' -e 's,$,:,' < "$tmpdepfile" >> "$depfile" + else + echo "#dummy" > "$depfile" + fi + rm -f "$tmpdepfile" + ;; + +#nosideeffect) + # This comment above is used by automake to tell side-effect + # dependency tracking mechanisms from slower ones. + +dashmstdout) + # Important note: in order to support this mode, a compiler *must* + # always write the preprocessed file to stdout, regardless of -o. + "$@" || exit $? + + # Remove the call to Libtool. + if test "$libtool" = yes; then + while test "X$1" != 'X--mode=compile'; do + shift + done + shift + fi + + # Remove `-o $object'. + IFS=" " + for arg + do + case $arg in + -o) + shift + ;; + $object) + shift + ;; + *) + set fnord "$@" "$arg" + shift # fnord + shift # $arg + ;; + esac + done + + test -z "$dashmflag" && dashmflag=-M + # Require at least two characters before searching for `:' + # in the target name. This is to cope with DOS-style filenames: + # a dependency such as `c:/foo/bar' could be seen as target `c' otherwise. + "$@" $dashmflag | + sed 's:^[ ]*[^: ][^:][^:]*\:[ ]*:'"$object"'\: :' > "$tmpdepfile" + rm -f "$depfile" + cat < "$tmpdepfile" > "$depfile" + tr ' ' ' +' < "$tmpdepfile" | \ +## Some versions of the HPUX 10.20 sed can't process this invocation +## correctly. Breaking it into two sed invocations is a workaround. + sed -e 's/^\\$//' -e '/^$/d' -e '/:$/d' | sed -e 's/$/ :/' >> "$depfile" + rm -f "$tmpdepfile" + ;; + +dashXmstdout) + # This case only exists to satisfy depend.m4. It is never actually + # run, as this mode is specially recognized in the preamble. + exit 1 + ;; + +makedepend) + "$@" || exit $? + # Remove any Libtool call + if test "$libtool" = yes; then + while test "X$1" != 'X--mode=compile'; do + shift + done + shift + fi + # X makedepend + shift + cleared=no eat=no + for arg + do + case $cleared in + no) + set ""; shift + cleared=yes ;; + esac + if test $eat = yes; then + eat=no + continue + fi + case "$arg" in + -D*|-I*) + set fnord "$@" "$arg"; shift ;; + # Strip any option that makedepend may not understand. Remove + # the object too, otherwise makedepend will parse it as a source file. + -arch) + eat=yes ;; + -*|$object) + ;; + *) + set fnord "$@" "$arg"; shift ;; + esac + done + obj_suffix=`echo "$object" | sed 's/^.*\././'` + touch "$tmpdepfile" + ${MAKEDEPEND-makedepend} -o"$obj_suffix" -f"$tmpdepfile" "$@" + rm -f "$depfile" + cat < "$tmpdepfile" > "$depfile" + sed '1,2d' "$tmpdepfile" | tr ' ' ' +' | \ +## Some versions of the HPUX 10.20 sed can't process this invocation +## correctly. Breaking it into two sed invocations is a workaround. + sed -e 's/^\\$//' -e '/^$/d' -e '/:$/d' | sed -e 's/$/ :/' >> "$depfile" + rm -f "$tmpdepfile" "$tmpdepfile".bak + ;; + +cpp) + # Important note: in order to support this mode, a compiler *must* + # always write the preprocessed file to stdout. + "$@" || exit $? + + # Remove the call to Libtool. + if test "$libtool" = yes; then + while test "X$1" != 'X--mode=compile'; do + shift + done + shift + fi + + # Remove `-o $object'. + IFS=" " + for arg + do + case $arg in + -o) + shift + ;; + $object) + shift + ;; + *) + set fnord "$@" "$arg" + shift # fnord + shift # $arg + ;; + esac + done + + "$@" -E | + sed -n -e '/^# [0-9][0-9]* "\([^"]*\)".*/ s:: \1 \\:p' \ + -e '/^#line [0-9][0-9]* "\([^"]*\)".*/ s:: \1 \\:p' | + sed '$ s: \\$::' > "$tmpdepfile" + rm -f "$depfile" + echo "$object : \\" > "$depfile" + cat < "$tmpdepfile" >> "$depfile" + sed < "$tmpdepfile" '/^$/d;s/^ //;s/ \\$//;s/$/ :/' >> "$depfile" + rm -f "$tmpdepfile" + ;; + +msvisualcpp) + # Important note: in order to support this mode, a compiler *must* + # always write the preprocessed file to stdout. + "$@" || exit $? + + # Remove the call to Libtool. + if test "$libtool" = yes; then + while test "X$1" != 'X--mode=compile'; do + shift + done + shift + fi + + IFS=" " + for arg + do + case "$arg" in + -o) + shift + ;; + $object) + shift + ;; + "-Gm"|"/Gm"|"-Gi"|"/Gi"|"-ZI"|"/ZI") + set fnord "$@" + shift + shift + ;; + *) + set fnord "$@" "$arg" + shift + shift + ;; + esac + done + "$@" -E 2>/dev/null | + sed -n '/^#line [0-9][0-9]* "\([^"]*\)"/ s::\1:p' | $cygpath_u | sort -u > "$tmpdepfile" + rm -f "$depfile" + echo "$object : \\" > "$depfile" + sed < "$tmpdepfile" -n -e 's% %\\ %g' -e '/^\(.*\)$/ s:: \1 \\:p' >> "$depfile" + echo " " >> "$depfile" + sed < "$tmpdepfile" -n -e 's% %\\ %g' -e '/^\(.*\)$/ s::\1\::p' >> "$depfile" + rm -f "$tmpdepfile" + ;; + +msvcmsys) + # This case exists only to let depend.m4 do its work. It works by + # looking at the text of this script. This case will never be run, + # since it is checked for above. + exit 1 + ;; + +none) + exec "$@" + ;; + +*) + echo "Unknown depmode $depmode" 1>&2 + exit 1 + ;; +esac + +exit 0 + +# Local Variables: +# mode: shell-script +# sh-indentation: 2 +# eval: (add-hook 'write-file-hooks 'time-stamp) +# time-stamp-start: "scriptversion=" +# time-stamp-format: "%:y-%02m-%02d.%02H" +# time-stamp-time-zone: "UTC" +# time-stamp-end: "; # UTC" +# End: diff --git a/libconfig-1.4.9/aux-build/install-sh b/libconfig-1.4.9/aux-build/install-sh new file mode 100755 index 0000000000000000000000000000000000000000..6781b987bdbcbc23efe6bbe1654a1e3637b9af07 --- /dev/null +++ b/libconfig-1.4.9/aux-build/install-sh @@ -0,0 +1,520 @@ +#!/bin/sh +# install - install a program, script, or datafile + +scriptversion=2009-04-28.21; # UTC + +# This originates from X11R5 (mit/util/scripts/install.sh), which was +# later released in X11R6 (xc/config/util/install.sh) with the +# following copyright and license. +# +# Copyright (C) 1994 X Consortium +# +# Permission is hereby granted, free of charge, to any person obtaining a copy +# of this software and associated documentation files (the "Software"), to +# deal in the Software without restriction, including without limitation the +# rights to use, copy, modify, merge, publish, distribute, sublicense, and/or +# sell copies of the Software, and to permit persons to whom the Software is +# furnished to do so, subject to the following conditions: +# +# The above copyright notice and this permission notice shall be included in +# all copies or substantial portions of the Software. +# +# THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR +# IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY, +# FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE +# X CONSORTIUM BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER LIABILITY, WHETHER IN +# AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM, OUT OF OR IN CONNEC- +# TION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE SOFTWARE. +# +# Except as contained in this notice, the name of the X Consortium shall not +# be used in advertising or otherwise to promote the sale, use or other deal- +# ings in this Software without prior written authorization from the X Consor- +# tium. +# +# +# FSF changes to this file are in the public domain. +# +# Calling this script install-sh is preferred over install.sh, to prevent +# `make' implicit rules from creating a file called install from it +# when there is no Makefile. +# +# This script is compatible with the BSD install script, but was written +# from scratch. + +nl=' +' +IFS=" "" $nl" + +# set DOITPROG to echo to test this script + +# Don't use :- since 4.3BSD and earlier shells don't like it. +doit=${DOITPROG-} +if test -z "$doit"; then + doit_exec=exec +else + doit_exec=$doit +fi + +# Put in absolute file names if you don't have them in your path; +# or use environment vars. + +chgrpprog=${CHGRPPROG-chgrp} +chmodprog=${CHMODPROG-chmod} +chownprog=${CHOWNPROG-chown} +cmpprog=${CMPPROG-cmp} +cpprog=${CPPROG-cp} +mkdirprog=${MKDIRPROG-mkdir} +mvprog=${MVPROG-mv} +rmprog=${RMPROG-rm} +stripprog=${STRIPPROG-strip} + +posix_glob='?' +initialize_posix_glob=' + test "$posix_glob" != "?" || { + if (set -f) 2>/dev/null; then + posix_glob= + else + posix_glob=: + fi + } +' + +posix_mkdir= + +# Desired mode of installed file. +mode=0755 + +chgrpcmd= +chmodcmd=$chmodprog +chowncmd= +mvcmd=$mvprog +rmcmd="$rmprog -f" +stripcmd= + +src= +dst= +dir_arg= +dst_arg= + +copy_on_change=false +no_target_directory= + +usage="\ +Usage: $0 [OPTION]... [-T] SRCFILE DSTFILE + or: $0 [OPTION]... SRCFILES... DIRECTORY + or: $0 [OPTION]... -t DIRECTORY SRCFILES... + or: $0 [OPTION]... -d DIRECTORIES... + +In the 1st form, copy SRCFILE to DSTFILE. +In the 2nd and 3rd, copy all SRCFILES to DIRECTORY. +In the 4th, create DIRECTORIES. + +Options: + --help display this help and exit. + --version display version info and exit. + + -c (ignored) + -C install only if different (preserve the last data modification time) + -d create directories instead of installing files. + -g GROUP $chgrpprog installed files to GROUP. + -m MODE $chmodprog installed files to MODE. + -o USER $chownprog installed files to USER. + -s $stripprog installed files. + -t DIRECTORY install into DIRECTORY. + -T report an error if DSTFILE is a directory. + +Environment variables override the default commands: + CHGRPPROG CHMODPROG CHOWNPROG CMPPROG CPPROG MKDIRPROG MVPROG + RMPROG STRIPPROG +" + +while test $# -ne 0; do + case $1 in + -c) ;; + + -C) copy_on_change=true;; + + -d) dir_arg=true;; + + -g) chgrpcmd="$chgrpprog $2" + shift;; + + --help) echo "$usage"; exit $?;; + + -m) mode=$2 + case $mode in + *' '* | *' '* | *' +'* | *'*'* | *'?'* | *'['*) + echo "$0: invalid mode: $mode" >&2 + exit 1;; + esac + shift;; + + -o) chowncmd="$chownprog $2" + shift;; + + -s) stripcmd=$stripprog;; + + -t) dst_arg=$2 + shift;; + + -T) no_target_directory=true;; + + --version) echo "$0 $scriptversion"; exit $?;; + + --) shift + break;; + + -*) echo "$0: invalid option: $1" >&2 + exit 1;; + + *) break;; + esac + shift +done + +if test $# -ne 0 && test -z "$dir_arg$dst_arg"; then + # When -d is used, all remaining arguments are directories to create. + # When -t is used, the destination is already specified. + # Otherwise, the last argument is the destination. Remove it from $@. + for arg + do + if test -n "$dst_arg"; then + # $@ is not empty: it contains at least $arg. + set fnord "$@" "$dst_arg" + shift # fnord + fi + shift # arg + dst_arg=$arg + done +fi + +if test $# -eq 0; then + if test -z "$dir_arg"; then + echo "$0: no input file specified." >&2 + exit 1 + fi + # It's OK to call `install-sh -d' without argument. + # This can happen when creating conditional directories. + exit 0 +fi + +if test -z "$dir_arg"; then + trap '(exit $?); exit' 1 2 13 15 + + # Set umask so as not to create temps with too-generous modes. + # However, 'strip' requires both read and write access to temps. + case $mode in + # Optimize common cases. + *644) cp_umask=133;; + *755) cp_umask=22;; + + *[0-7]) + if test -z "$stripcmd"; then + u_plus_rw= + else + u_plus_rw='% 200' + fi + cp_umask=`expr '(' 777 - $mode % 1000 ')' $u_plus_rw`;; + *) + if test -z "$stripcmd"; then + u_plus_rw= + else + u_plus_rw=,u+rw + fi + cp_umask=$mode$u_plus_rw;; + esac +fi + +for src +do + # Protect names starting with `-'. + case $src in + -*) src=./$src;; + esac + + if test -n "$dir_arg"; then + dst=$src + dstdir=$dst + test -d "$dstdir" + dstdir_status=$? + else + + # Waiting for this to be detected by the "$cpprog $src $dsttmp" command + # might cause directories to be created, which would be especially bad + # if $src (and thus $dsttmp) contains '*'. + if test ! -f "$src" && test ! -d "$src"; then + echo "$0: $src does not exist." >&2 + exit 1 + fi + + if test -z "$dst_arg"; then + echo "$0: no destination specified." >&2 + exit 1 + fi + + dst=$dst_arg + # Protect names starting with `-'. + case $dst in + -*) dst=./$dst;; + esac + + # If destination is a directory, append the input filename; won't work + # if double slashes aren't ignored. + if test -d "$dst"; then + if test -n "$no_target_directory"; then + echo "$0: $dst_arg: Is a directory" >&2 + exit 1 + fi + dstdir=$dst + dst=$dstdir/`basename "$src"` + dstdir_status=0 + else + # Prefer dirname, but fall back on a substitute if dirname fails. + dstdir=` + (dirname "$dst") 2>/dev/null || + expr X"$dst" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ + X"$dst" : 'X\(//\)[^/]' \| \ + X"$dst" : 'X\(//\)$' \| \ + X"$dst" : 'X\(/\)' \| . 2>/dev/null || + echo X"$dst" | + sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ + s//\1/ + q + } + /^X\(\/\/\)[^/].*/{ + s//\1/ + q + } + /^X\(\/\/\)$/{ + s//\1/ + q + } + /^X\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q' + ` + + test -d "$dstdir" + dstdir_status=$? + fi + fi + + obsolete_mkdir_used=false + + if test $dstdir_status != 0; then + case $posix_mkdir in + '') + # Create intermediate dirs using mode 755 as modified by the umask. + # This is like FreeBSD 'install' as of 1997-10-28. + umask=`umask` + case $stripcmd.$umask in + # Optimize common cases. + *[2367][2367]) mkdir_umask=$umask;; + .*0[02][02] | .[02][02] | .[02]) mkdir_umask=22;; + + *[0-7]) + mkdir_umask=`expr $umask + 22 \ + - $umask % 100 % 40 + $umask % 20 \ + - $umask % 10 % 4 + $umask % 2 + `;; + *) mkdir_umask=$umask,go-w;; + esac + + # With -d, create the new directory with the user-specified mode. + # Otherwise, rely on $mkdir_umask. + if test -n "$dir_arg"; then + mkdir_mode=-m$mode + else + mkdir_mode= + fi + + posix_mkdir=false + case $umask in + *[123567][0-7][0-7]) + # POSIX mkdir -p sets u+wx bits regardless of umask, which + # is incompatible with FreeBSD 'install' when (umask & 300) != 0. + ;; + *) + tmpdir=${TMPDIR-/tmp}/ins$RANDOM-$$ + trap 'ret=$?; rmdir "$tmpdir/d" "$tmpdir" 2>/dev/null; exit $ret' 0 + + if (umask $mkdir_umask && + exec $mkdirprog $mkdir_mode -p -- "$tmpdir/d") >/dev/null 2>&1 + then + if test -z "$dir_arg" || { + # Check for POSIX incompatibilities with -m. + # HP-UX 11.23 and IRIX 6.5 mkdir -m -p sets group- or + # other-writeable bit of parent directory when it shouldn't. + # FreeBSD 6.1 mkdir -m -p sets mode of existing directory. + ls_ld_tmpdir=`ls -ld "$tmpdir"` + case $ls_ld_tmpdir in + d????-?r-*) different_mode=700;; + d????-?--*) different_mode=755;; + *) false;; + esac && + $mkdirprog -m$different_mode -p -- "$tmpdir" && { + ls_ld_tmpdir_1=`ls -ld "$tmpdir"` + test "$ls_ld_tmpdir" = "$ls_ld_tmpdir_1" + } + } + then posix_mkdir=: + fi + rmdir "$tmpdir/d" "$tmpdir" + else + # Remove any dirs left behind by ancient mkdir implementations. + rmdir ./$mkdir_mode ./-p ./-- 2>/dev/null + fi + trap '' 0;; + esac;; + esac + + if + $posix_mkdir && ( + umask $mkdir_umask && + $doit_exec $mkdirprog $mkdir_mode -p -- "$dstdir" + ) + then : + else + + # The umask is ridiculous, or mkdir does not conform to POSIX, + # or it failed possibly due to a race condition. Create the + # directory the slow way, step by step, checking for races as we go. + + case $dstdir in + /*) prefix='/';; + -*) prefix='./';; + *) prefix='';; + esac + + eval "$initialize_posix_glob" + + oIFS=$IFS + IFS=/ + $posix_glob set -f + set fnord $dstdir + shift + $posix_glob set +f + IFS=$oIFS + + prefixes= + + for d + do + test -z "$d" && continue + + prefix=$prefix$d + if test -d "$prefix"; then + prefixes= + else + if $posix_mkdir; then + (umask=$mkdir_umask && + $doit_exec $mkdirprog $mkdir_mode -p -- "$dstdir") && break + # Don't fail if two instances are running concurrently. + test -d "$prefix" || exit 1 + else + case $prefix in + *\'*) qprefix=`echo "$prefix" | sed "s/'/'\\\\\\\\''/g"`;; + *) qprefix=$prefix;; + esac + prefixes="$prefixes '$qprefix'" + fi + fi + prefix=$prefix/ + done + + if test -n "$prefixes"; then + # Don't fail if two instances are running concurrently. + (umask $mkdir_umask && + eval "\$doit_exec \$mkdirprog $prefixes") || + test -d "$dstdir" || exit 1 + obsolete_mkdir_used=true + fi + fi + fi + + if test -n "$dir_arg"; then + { test -z "$chowncmd" || $doit $chowncmd "$dst"; } && + { test -z "$chgrpcmd" || $doit $chgrpcmd "$dst"; } && + { test "$obsolete_mkdir_used$chowncmd$chgrpcmd" = false || + test -z "$chmodcmd" || $doit $chmodcmd $mode "$dst"; } || exit 1 + else + + # Make a couple of temp file names in the proper directory. + dsttmp=$dstdir/_inst.$$_ + rmtmp=$dstdir/_rm.$$_ + + # Trap to clean up those temp files at exit. + trap 'ret=$?; rm -f "$dsttmp" "$rmtmp" && exit $ret' 0 + + # Copy the file name to the temp name. + (umask $cp_umask && $doit_exec $cpprog "$src" "$dsttmp") && + + # and set any options; do chmod last to preserve setuid bits. + # + # If any of these fail, we abort the whole thing. If we want to + # ignore errors from any of these, just make sure not to ignore + # errors from the above "$doit $cpprog $src $dsttmp" command. + # + { test -z "$chowncmd" || $doit $chowncmd "$dsttmp"; } && + { test -z "$chgrpcmd" || $doit $chgrpcmd "$dsttmp"; } && + { test -z "$stripcmd" || $doit $stripcmd "$dsttmp"; } && + { test -z "$chmodcmd" || $doit $chmodcmd $mode "$dsttmp"; } && + + # If -C, don't bother to copy if it wouldn't change the file. + if $copy_on_change && + old=`LC_ALL=C ls -dlL "$dst" 2>/dev/null` && + new=`LC_ALL=C ls -dlL "$dsttmp" 2>/dev/null` && + + eval "$initialize_posix_glob" && + $posix_glob set -f && + set X $old && old=:$2:$4:$5:$6 && + set X $new && new=:$2:$4:$5:$6 && + $posix_glob set +f && + + test "$old" = "$new" && + $cmpprog "$dst" "$dsttmp" >/dev/null 2>&1 + then + rm -f "$dsttmp" + else + # Rename the file to the real destination. + $doit $mvcmd -f "$dsttmp" "$dst" 2>/dev/null || + + # The rename failed, perhaps because mv can't rename something else + # to itself, or perhaps because mv is so ancient that it does not + # support -f. + { + # Now remove or move aside any old file at destination location. + # We try this two ways since rm can't unlink itself on some + # systems and the destination file might be busy for other + # reasons. In this case, the final cleanup might fail but the new + # file should still install successfully. + { + test ! -f "$dst" || + $doit $rmcmd -f "$dst" 2>/dev/null || + { $doit $mvcmd -f "$dst" "$rmtmp" 2>/dev/null && + { $doit $rmcmd -f "$rmtmp" 2>/dev/null; :; } + } || + { echo "$0: cannot unlink or rename $dst" >&2 + (exit 1); exit 1 + } + } && + + # Now rename the file to the real destination. + $doit $mvcmd "$dsttmp" "$dst" + } + fi || exit 1 + + trap '' 0 + fi +done + +# Local variables: +# eval: (add-hook 'write-file-hooks 'time-stamp) +# time-stamp-start: "scriptversion=" +# time-stamp-format: "%:y-%02m-%02d.%02H" +# time-stamp-time-zone: "UTC" +# time-stamp-end: "; # UTC" +# End: diff --git a/libconfig-1.4.9/aux-build/ltmain.sh b/libconfig-1.4.9/aux-build/ltmain.sh new file mode 100644 index 0000000000000000000000000000000000000000..63ae69dc6fecaf83c52fba2ad334f4b1369fb1cd --- /dev/null +++ b/libconfig-1.4.9/aux-build/ltmain.sh @@ -0,0 +1,9655 @@ + +# libtool (GNU libtool) 2.4.2 +# Written by Gordon Matzigkeit , 1996 + +# Copyright (C) 1996, 1997, 1998, 1999, 2000, 2001, 2003, 2004, 2005, 2006, +# 2007, 2008, 2009, 2010, 2011 Free Software Foundation, Inc. +# This is free software; see the source for copying conditions. There is NO +# warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. + +# GNU Libtool is free software; you can redistribute it and/or modify +# it under the terms of the GNU General Public License as published by +# the Free Software Foundation; either version 2 of the License, or +# (at your option) any later version. +# +# As a special exception to the GNU General Public License, +# if you distribute this file as part of a program or library that +# is built using GNU Libtool, you may include this file under the +# same distribution terms that you use for the rest of that program. +# +# GNU Libtool is distributed in the hope that it will be useful, but +# WITHOUT ANY WARRANTY; without even the implied warranty of +# MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU +# General Public License for more details. +# +# You should have received a copy of the GNU General Public License +# along with GNU Libtool; see the file COPYING. If not, a copy +# can be downloaded from http://www.gnu.org/licenses/gpl.html, +# or obtained by writing to the Free Software Foundation, Inc., +# 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301, USA. + +# Usage: $progname [OPTION]... [MODE-ARG]... +# +# Provide generalized library-building support services. +# +# --config show all configuration variables +# --debug enable verbose shell tracing +# -n, --dry-run display commands without modifying any files +# --features display basic configuration information and exit +# --mode=MODE use operation mode MODE +# --preserve-dup-deps don't remove duplicate dependency libraries +# --quiet, --silent don't print informational messages +# --no-quiet, --no-silent +# print informational messages (default) +# --no-warn don't display warning messages +# --tag=TAG use configuration variables from tag TAG +# -v, --verbose print more informational messages than default +# --no-verbose don't print the extra informational messages +# --version print version information +# -h, --help, --help-all print short, long, or detailed help message +# +# MODE must be one of the following: +# +# clean remove files from the build directory +# compile compile a source file into a libtool object +# execute automatically set library path, then run a program +# finish complete the installation of libtool libraries +# install install libraries or executables +# link create a library or an executable +# uninstall remove libraries from an installed directory +# +# MODE-ARGS vary depending on the MODE. When passed as first option, +# `--mode=MODE' may be abbreviated as `MODE' or a unique abbreviation of that. +# Try `$progname --help --mode=MODE' for a more detailed description of MODE. +# +# When reporting a bug, please describe a test case to reproduce it and +# include the following information: +# +# host-triplet: $host +# shell: $SHELL +# compiler: $LTCC +# compiler flags: $LTCFLAGS +# linker: $LD (gnu? $with_gnu_ld) +# $progname: (GNU libtool) 2.4.2 +# automake: $automake_version +# autoconf: $autoconf_version +# +# Report bugs to . +# GNU libtool home page: . +# General help using GNU software: . + +PROGRAM=libtool +PACKAGE=libtool +VERSION=2.4.2 +TIMESTAMP="" +package_revision=1.3337 + +# Be Bourne compatible +if test -n "${ZSH_VERSION+set}" && (emulate sh) >/dev/null 2>&1; then + emulate sh + NULLCMD=: + # Zsh 3.x and 4.x performs word splitting on ${1+"$@"}, which + # is contrary to our usage. Disable this feature. + alias -g '${1+"$@"}'='"$@"' + setopt NO_GLOB_SUBST +else + case `(set -o) 2>/dev/null` in *posix*) set -o posix;; esac +fi +BIN_SH=xpg4; export BIN_SH # for Tru64 +DUALCASE=1; export DUALCASE # for MKS sh + +# A function that is used when there is no print builtin or printf. +func_fallback_echo () +{ + eval 'cat <<_LTECHO_EOF +$1 +_LTECHO_EOF' +} + +# NLS nuisances: We save the old values to restore during execute mode. +lt_user_locale= +lt_safe_locale= +for lt_var in LANG LANGUAGE LC_ALL LC_CTYPE LC_COLLATE LC_MESSAGES +do + eval "if test \"\${$lt_var+set}\" = set; then + save_$lt_var=\$$lt_var + $lt_var=C + export $lt_var + lt_user_locale=\"$lt_var=\\\$save_\$lt_var; \$lt_user_locale\" + lt_safe_locale=\"$lt_var=C; \$lt_safe_locale\" + fi" +done +LC_ALL=C +LANGUAGE=C +export LANGUAGE LC_ALL + +$lt_unset CDPATH + + +# Work around backward compatibility issue on IRIX 6.5. On IRIX 6.4+, sh +# is ksh but when the shell is invoked as "sh" and the current value of +# the _XPG environment variable is not equal to 1 (one), the special +# positional parameter $0, within a function call, is the name of the +# function. +progpath="$0" + + + +: ${CP="cp -f"} +test "${ECHO+set}" = set || ECHO=${as_echo-'printf %s\n'} +: ${MAKE="make"} +: ${MKDIR="mkdir"} +: ${MV="mv -f"} +: ${RM="rm -f"} +: ${SHELL="${CONFIG_SHELL-/bin/sh}"} +: ${Xsed="$SED -e 1s/^X//"} + +# Global variables: +EXIT_SUCCESS=0 +EXIT_FAILURE=1 +EXIT_MISMATCH=63 # $? = 63 is used to indicate version mismatch to missing. +EXIT_SKIP=77 # $? = 77 is used to indicate a skipped test to automake. + +exit_status=$EXIT_SUCCESS + +# Make sure IFS has a sensible default +lt_nl=' +' +IFS=" $lt_nl" + +dirname="s,/[^/]*$,," +basename="s,^.*/,," + +# func_dirname file append nondir_replacement +# Compute the dirname of FILE. If nonempty, add APPEND to the result, +# otherwise set result to NONDIR_REPLACEMENT. +func_dirname () +{ + func_dirname_result=`$ECHO "${1}" | $SED "$dirname"` + if test "X$func_dirname_result" = "X${1}"; then + func_dirname_result="${3}" + else + func_dirname_result="$func_dirname_result${2}" + fi +} # func_dirname may be replaced by extended shell implementation + + +# func_basename file +func_basename () +{ + func_basename_result=`$ECHO "${1}" | $SED "$basename"` +} # func_basename may be replaced by extended shell implementation + + +# func_dirname_and_basename file append nondir_replacement +# perform func_basename and func_dirname in a single function +# call: +# dirname: Compute the dirname of FILE. If nonempty, +# add APPEND to the result, otherwise set result +# to NONDIR_REPLACEMENT. +# value returned in "$func_dirname_result" +# basename: Compute filename of FILE. +# value retuned in "$func_basename_result" +# Implementation must be kept synchronized with func_dirname +# and func_basename. For efficiency, we do not delegate to +# those functions but instead duplicate the functionality here. +func_dirname_and_basename () +{ + # Extract subdirectory from the argument. + func_dirname_result=`$ECHO "${1}" | $SED -e "$dirname"` + if test "X$func_dirname_result" = "X${1}"; then + func_dirname_result="${3}" + else + func_dirname_result="$func_dirname_result${2}" + fi + func_basename_result=`$ECHO "${1}" | $SED -e "$basename"` +} # func_dirname_and_basename may be replaced by extended shell implementation + + +# func_stripname prefix suffix name +# strip PREFIX and SUFFIX off of NAME. +# PREFIX and SUFFIX must not contain globbing or regex special +# characters, hashes, percent signs, but SUFFIX may contain a leading +# dot (in which case that matches only a dot). +# func_strip_suffix prefix name +func_stripname () +{ + case ${2} in + .*) func_stripname_result=`$ECHO "${3}" | $SED "s%^${1}%%; s%\\\\${2}\$%%"`;; + *) func_stripname_result=`$ECHO "${3}" | $SED "s%^${1}%%; s%${2}\$%%"`;; + esac +} # func_stripname may be replaced by extended shell implementation + + +# These SED scripts presuppose an absolute path with a trailing slash. +pathcar='s,^/\([^/]*\).*$,\1,' +pathcdr='s,^/[^/]*,,' +removedotparts=':dotsl + s@/\./@/@g + t dotsl + s,/\.$,/,' +collapseslashes='s@/\{1,\}@/@g' +finalslash='s,/*$,/,' + +# func_normal_abspath PATH +# Remove doubled-up and trailing slashes, "." path components, +# and cancel out any ".." path components in PATH after making +# it an absolute path. +# value returned in "$func_normal_abspath_result" +func_normal_abspath () +{ + # Start from root dir and reassemble the path. + func_normal_abspath_result= + func_normal_abspath_tpath=$1 + func_normal_abspath_altnamespace= + case $func_normal_abspath_tpath in + "") + # Empty path, that just means $cwd. + func_stripname '' '/' "`pwd`" + func_normal_abspath_result=$func_stripname_result + return + ;; + # The next three entries are used to spot a run of precisely + # two leading slashes without using negated character classes; + # we take advantage of case's first-match behaviour. + ///*) + # Unusual form of absolute path, do nothing. + ;; + //*) + # Not necessarily an ordinary path; POSIX reserves leading '//' + # and for example Cygwin uses it to access remote file shares + # over CIFS/SMB, so we conserve a leading double slash if found. + func_normal_abspath_altnamespace=/ + ;; + /*) + # Absolute path, do nothing. + ;; + *) + # Relative path, prepend $cwd. + func_normal_abspath_tpath=`pwd`/$func_normal_abspath_tpath + ;; + esac + # Cancel out all the simple stuff to save iterations. We also want + # the path to end with a slash for ease of parsing, so make sure + # there is one (and only one) here. + func_normal_abspath_tpath=`$ECHO "$func_normal_abspath_tpath" | $SED \ + -e "$removedotparts" -e "$collapseslashes" -e "$finalslash"` + while :; do + # Processed it all yet? + if test "$func_normal_abspath_tpath" = / ; then + # If we ascended to the root using ".." the result may be empty now. + if test -z "$func_normal_abspath_result" ; then + func_normal_abspath_result=/ + fi + break + fi + func_normal_abspath_tcomponent=`$ECHO "$func_normal_abspath_tpath" | $SED \ + -e "$pathcar"` + func_normal_abspath_tpath=`$ECHO "$func_normal_abspath_tpath" | $SED \ + -e "$pathcdr"` + # Figure out what to do with it + case $func_normal_abspath_tcomponent in + "") + # Trailing empty path component, ignore it. + ;; + ..) + # Parent dir; strip last assembled component from result. + func_dirname "$func_normal_abspath_result" + func_normal_abspath_result=$func_dirname_result + ;; + *) + # Actual path component, append it. + func_normal_abspath_result=$func_normal_abspath_result/$func_normal_abspath_tcomponent + ;; + esac + done + # Restore leading double-slash if one was found on entry. + func_normal_abspath_result=$func_normal_abspath_altnamespace$func_normal_abspath_result +} + +# func_relative_path SRCDIR DSTDIR +# generates a relative path from SRCDIR to DSTDIR, with a trailing +# slash if non-empty, suitable for immediately appending a filename +# without needing to append a separator. +# value returned in "$func_relative_path_result" +func_relative_path () +{ + func_relative_path_result= + func_normal_abspath "$1" + func_relative_path_tlibdir=$func_normal_abspath_result + func_normal_abspath "$2" + func_relative_path_tbindir=$func_normal_abspath_result + + # Ascend the tree starting from libdir + while :; do + # check if we have found a prefix of bindir + case $func_relative_path_tbindir in + $func_relative_path_tlibdir) + # found an exact match + func_relative_path_tcancelled= + break + ;; + $func_relative_path_tlibdir*) + # found a matching prefix + func_stripname "$func_relative_path_tlibdir" '' "$func_relative_path_tbindir" + func_relative_path_tcancelled=$func_stripname_result + if test -z "$func_relative_path_result"; then + func_relative_path_result=. + fi + break + ;; + *) + func_dirname $func_relative_path_tlibdir + func_relative_path_tlibdir=${func_dirname_result} + if test "x$func_relative_path_tlibdir" = x ; then + # Have to descend all the way to the root! + func_relative_path_result=../$func_relative_path_result + func_relative_path_tcancelled=$func_relative_path_tbindir + break + fi + func_relative_path_result=../$func_relative_path_result + ;; + esac + done + + # Now calculate path; take care to avoid doubling-up slashes. + func_stripname '' '/' "$func_relative_path_result" + func_relative_path_result=$func_stripname_result + func_stripname '/' '/' "$func_relative_path_tcancelled" + if test "x$func_stripname_result" != x ; then + func_relative_path_result=${func_relative_path_result}/${func_stripname_result} + fi + + # Normalisation. If bindir is libdir, return empty string, + # else relative path ending with a slash; either way, target + # file name can be directly appended. + if test ! -z "$func_relative_path_result"; then + func_stripname './' '' "$func_relative_path_result/" + func_relative_path_result=$func_stripname_result + fi +} + +# The name of this program: +func_dirname_and_basename "$progpath" +progname=$func_basename_result + +# Make sure we have an absolute path for reexecution: +case $progpath in + [\\/]*|[A-Za-z]:\\*) ;; + *[\\/]*) + progdir=$func_dirname_result + progdir=`cd "$progdir" && pwd` + progpath="$progdir/$progname" + ;; + *) + save_IFS="$IFS" + IFS=${PATH_SEPARATOR-:} + for progdir in $PATH; do + IFS="$save_IFS" + test -x "$progdir/$progname" && break + done + IFS="$save_IFS" + test -n "$progdir" || progdir=`pwd` + progpath="$progdir/$progname" + ;; +esac + +# Sed substitution that helps us do robust quoting. It backslashifies +# metacharacters that are still active within double-quoted strings. +Xsed="${SED}"' -e 1s/^X//' +sed_quote_subst='s/\([`"$\\]\)/\\\1/g' + +# Same as above, but do not quote variable references. +double_quote_subst='s/\(["`\\]\)/\\\1/g' + +# Sed substitution that turns a string into a regex matching for the +# string literally. +sed_make_literal_regex='s,[].[^$\\*\/],\\&,g' + +# Sed substitution that converts a w32 file name or path +# which contains forward slashes, into one that contains +# (escaped) backslashes. A very naive implementation. +lt_sed_naive_backslashify='s|\\\\*|\\|g;s|/|\\|g;s|\\|\\\\|g' + +# Re-`\' parameter expansions in output of double_quote_subst that were +# `\'-ed in input to the same. If an odd number of `\' preceded a '$' +# in input to double_quote_subst, that '$' was protected from expansion. +# Since each input `\' is now two `\'s, look for any number of runs of +# four `\'s followed by two `\'s and then a '$'. `\' that '$'. +bs='\\' +bs2='\\\\' +bs4='\\\\\\\\' +dollar='\$' +sed_double_backslash="\ + s/$bs4/&\\ +/g + s/^$bs2$dollar/$bs&/ + s/\\([^$bs]\\)$bs2$dollar/\\1$bs2$bs$dollar/g + s/\n//g" + +# Standard options: +opt_dry_run=false +opt_help=false +opt_quiet=false +opt_verbose=false +opt_warning=: + +# func_echo arg... +# Echo program name prefixed message, along with the current mode +# name if it has been set yet. +func_echo () +{ + $ECHO "$progname: ${opt_mode+$opt_mode: }$*" +} + +# func_verbose arg... +# Echo program name prefixed message in verbose mode only. +func_verbose () +{ + $opt_verbose && func_echo ${1+"$@"} + + # A bug in bash halts the script if the last line of a function + # fails when set -e is in force, so we need another command to + # work around that: + : +} + +# func_echo_all arg... +# Invoke $ECHO with all args, space-separated. +func_echo_all () +{ + $ECHO "$*" +} + +# func_error arg... +# Echo program name prefixed message to standard error. +func_error () +{ + $ECHO "$progname: ${opt_mode+$opt_mode: }"${1+"$@"} 1>&2 +} + +# func_warning arg... +# Echo program name prefixed warning message to standard error. +func_warning () +{ + $opt_warning && $ECHO "$progname: ${opt_mode+$opt_mode: }warning: "${1+"$@"} 1>&2 + + # bash bug again: + : +} + +# func_fatal_error arg... +# Echo program name prefixed message to standard error, and exit. +func_fatal_error () +{ + func_error ${1+"$@"} + exit $EXIT_FAILURE +} + +# func_fatal_help arg... +# Echo program name prefixed message to standard error, followed by +# a help hint, and exit. +func_fatal_help () +{ + func_error ${1+"$@"} + func_fatal_error "$help" +} +help="Try \`$progname --help' for more information." ## default + + +# func_grep expression filename +# Check whether EXPRESSION matches any line of FILENAME, without output. +func_grep () +{ + $GREP "$1" "$2" >/dev/null 2>&1 +} + + +# func_mkdir_p directory-path +# Make sure the entire path to DIRECTORY-PATH is available. +func_mkdir_p () +{ + my_directory_path="$1" + my_dir_list= + + if test -n "$my_directory_path" && test "$opt_dry_run" != ":"; then + + # Protect directory names starting with `-' + case $my_directory_path in + -*) my_directory_path="./$my_directory_path" ;; + esac + + # While some portion of DIR does not yet exist... + while test ! -d "$my_directory_path"; do + # ...make a list in topmost first order. Use a colon delimited + # list incase some portion of path contains whitespace. + my_dir_list="$my_directory_path:$my_dir_list" + + # If the last portion added has no slash in it, the list is done + case $my_directory_path in */*) ;; *) break ;; esac + + # ...otherwise throw away the child directory and loop + my_directory_path=`$ECHO "$my_directory_path" | $SED -e "$dirname"` + done + my_dir_list=`$ECHO "$my_dir_list" | $SED 's,:*$,,'` + + save_mkdir_p_IFS="$IFS"; IFS=':' + for my_dir in $my_dir_list; do + IFS="$save_mkdir_p_IFS" + # mkdir can fail with a `File exist' error if two processes + # try to create one of the directories concurrently. Don't + # stop in that case! + $MKDIR "$my_dir" 2>/dev/null || : + done + IFS="$save_mkdir_p_IFS" + + # Bail out if we (or some other process) failed to create a directory. + test -d "$my_directory_path" || \ + func_fatal_error "Failed to create \`$1'" + fi +} + + +# func_mktempdir [string] +# Make a temporary directory that won't clash with other running +# libtool processes, and avoids race conditions if possible. If +# given, STRING is the basename for that directory. +func_mktempdir () +{ + my_template="${TMPDIR-/tmp}/${1-$progname}" + + if test "$opt_dry_run" = ":"; then + # Return a directory name, but don't create it in dry-run mode + my_tmpdir="${my_template}-$$" + else + + # If mktemp works, use that first and foremost + my_tmpdir=`mktemp -d "${my_template}-XXXXXXXX" 2>/dev/null` + + if test ! -d "$my_tmpdir"; then + # Failing that, at least try and use $RANDOM to avoid a race + my_tmpdir="${my_template}-${RANDOM-0}$$" + + save_mktempdir_umask=`umask` + umask 0077 + $MKDIR "$my_tmpdir" + umask $save_mktempdir_umask + fi + + # If we're not in dry-run mode, bomb out on failure + test -d "$my_tmpdir" || \ + func_fatal_error "cannot create temporary directory \`$my_tmpdir'" + fi + + $ECHO "$my_tmpdir" +} + + +# func_quote_for_eval arg +# Aesthetically quote ARG to be evaled later. +# This function returns two values: FUNC_QUOTE_FOR_EVAL_RESULT +# is double-quoted, suitable for a subsequent eval, whereas +# FUNC_QUOTE_FOR_EVAL_UNQUOTED_RESULT has merely all characters +# which are still active within double quotes backslashified. +func_quote_for_eval () +{ + case $1 in + *[\\\`\"\$]*) + func_quote_for_eval_unquoted_result=`$ECHO "$1" | $SED "$sed_quote_subst"` ;; + *) + func_quote_for_eval_unquoted_result="$1" ;; + esac + + case $func_quote_for_eval_unquoted_result in + # Double-quote args containing shell metacharacters to delay + # word splitting, command substitution and and variable + # expansion for a subsequent eval. + # Many Bourne shells cannot handle close brackets correctly + # in scan sets, so we specify it separately. + *[\[\~\#\^\&\*\(\)\{\}\|\;\<\>\?\'\ \ ]*|*]*|"") + func_quote_for_eval_result="\"$func_quote_for_eval_unquoted_result\"" + ;; + *) + func_quote_for_eval_result="$func_quote_for_eval_unquoted_result" + esac +} + + +# func_quote_for_expand arg +# Aesthetically quote ARG to be evaled later; same as above, +# but do not quote variable references. +func_quote_for_expand () +{ + case $1 in + *[\\\`\"]*) + my_arg=`$ECHO "$1" | $SED \ + -e "$double_quote_subst" -e "$sed_double_backslash"` ;; + *) + my_arg="$1" ;; + esac + + case $my_arg in + # Double-quote args containing shell metacharacters to delay + # word splitting and command substitution for a subsequent eval. + # Many Bourne shells cannot handle close brackets correctly + # in scan sets, so we specify it separately. + *[\[\~\#\^\&\*\(\)\{\}\|\;\<\>\?\'\ \ ]*|*]*|"") + my_arg="\"$my_arg\"" + ;; + esac + + func_quote_for_expand_result="$my_arg" +} + + +# func_show_eval cmd [fail_exp] +# Unless opt_silent is true, then output CMD. Then, if opt_dryrun is +# not true, evaluate CMD. If the evaluation of CMD fails, and FAIL_EXP +# is given, then evaluate it. +func_show_eval () +{ + my_cmd="$1" + my_fail_exp="${2-:}" + + ${opt_silent-false} || { + func_quote_for_expand "$my_cmd" + eval "func_echo $func_quote_for_expand_result" + } + + if ${opt_dry_run-false}; then :; else + eval "$my_cmd" + my_status=$? + if test "$my_status" -eq 0; then :; else + eval "(exit $my_status); $my_fail_exp" + fi + fi +} + + +# func_show_eval_locale cmd [fail_exp] +# Unless opt_silent is true, then output CMD. Then, if opt_dryrun is +# not true, evaluate CMD. If the evaluation of CMD fails, and FAIL_EXP +# is given, then evaluate it. Use the saved locale for evaluation. +func_show_eval_locale () +{ + my_cmd="$1" + my_fail_exp="${2-:}" + + ${opt_silent-false} || { + func_quote_for_expand "$my_cmd" + eval "func_echo $func_quote_for_expand_result" + } + + if ${opt_dry_run-false}; then :; else + eval "$lt_user_locale + $my_cmd" + my_status=$? + eval "$lt_safe_locale" + if test "$my_status" -eq 0; then :; else + eval "(exit $my_status); $my_fail_exp" + fi + fi +} + +# func_tr_sh +# Turn $1 into a string suitable for a shell variable name. +# Result is stored in $func_tr_sh_result. All characters +# not in the set a-zA-Z0-9_ are replaced with '_'. Further, +# if $1 begins with a digit, a '_' is prepended as well. +func_tr_sh () +{ + case $1 in + [0-9]* | *[!a-zA-Z0-9_]*) + func_tr_sh_result=`$ECHO "$1" | $SED 's/^\([0-9]\)/_\1/; s/[^a-zA-Z0-9_]/_/g'` + ;; + * ) + func_tr_sh_result=$1 + ;; + esac +} + + +# func_version +# Echo version message to standard output and exit. +func_version () +{ + $opt_debug + + $SED -n '/(C)/!b go + :more + /\./!{ + N + s/\n# / / + b more + } + :go + /^# '$PROGRAM' (GNU /,/# warranty; / { + s/^# // + s/^# *$// + s/\((C)\)[ 0-9,-]*\( [1-9][0-9]*\)/\1\2/ + p + }' < "$progpath" + exit $? +} + +# func_usage +# Echo short help message to standard output and exit. +func_usage () +{ + $opt_debug + + $SED -n '/^# Usage:/,/^# *.*--help/ { + s/^# // + s/^# *$// + s/\$progname/'$progname'/ + p + }' < "$progpath" + echo + $ECHO "run \`$progname --help | more' for full usage" + exit $? +} + +# func_help [NOEXIT] +# Echo long help message to standard output and exit, +# unless 'noexit' is passed as argument. +func_help () +{ + $opt_debug + + $SED -n '/^# Usage:/,/# Report bugs to/ { + :print + s/^# // + s/^# *$// + s*\$progname*'$progname'* + s*\$host*'"$host"'* + s*\$SHELL*'"$SHELL"'* + s*\$LTCC*'"$LTCC"'* + s*\$LTCFLAGS*'"$LTCFLAGS"'* + s*\$LD*'"$LD"'* + s/\$with_gnu_ld/'"$with_gnu_ld"'/ + s/\$automake_version/'"`(${AUTOMAKE-automake} --version) 2>/dev/null |$SED 1q`"'/ + s/\$autoconf_version/'"`(${AUTOCONF-autoconf} --version) 2>/dev/null |$SED 1q`"'/ + p + d + } + /^# .* home page:/b print + /^# General help using/b print + ' < "$progpath" + ret=$? + if test -z "$1"; then + exit $ret + fi +} + +# func_missing_arg argname +# Echo program name prefixed message to standard error and set global +# exit_cmd. +func_missing_arg () +{ + $opt_debug + + func_error "missing argument for $1." + exit_cmd=exit +} + + +# func_split_short_opt shortopt +# Set func_split_short_opt_name and func_split_short_opt_arg shell +# variables after splitting SHORTOPT after the 2nd character. +func_split_short_opt () +{ + my_sed_short_opt='1s/^\(..\).*$/\1/;q' + my_sed_short_rest='1s/^..\(.*\)$/\1/;q' + + func_split_short_opt_name=`$ECHO "$1" | $SED "$my_sed_short_opt"` + func_split_short_opt_arg=`$ECHO "$1" | $SED "$my_sed_short_rest"` +} # func_split_short_opt may be replaced by extended shell implementation + + +# func_split_long_opt longopt +# Set func_split_long_opt_name and func_split_long_opt_arg shell +# variables after splitting LONGOPT at the `=' sign. +func_split_long_opt () +{ + my_sed_long_opt='1s/^\(--[^=]*\)=.*/\1/;q' + my_sed_long_arg='1s/^--[^=]*=//' + + func_split_long_opt_name=`$ECHO "$1" | $SED "$my_sed_long_opt"` + func_split_long_opt_arg=`$ECHO "$1" | $SED "$my_sed_long_arg"` +} # func_split_long_opt may be replaced by extended shell implementation + +exit_cmd=: + + + + + +magic="%%%MAGIC variable%%%" +magic_exe="%%%MAGIC EXE variable%%%" + +# Global variables. +nonopt= +preserve_args= +lo2o="s/\\.lo\$/.${objext}/" +o2lo="s/\\.${objext}\$/.lo/" +extracted_archives= +extracted_serial=0 + +# If this variable is set in any of the actions, the command in it +# will be execed at the end. This prevents here-documents from being +# left over by shells. +exec_cmd= + +# func_append var value +# Append VALUE to the end of shell variable VAR. +func_append () +{ + eval "${1}=\$${1}\${2}" +} # func_append may be replaced by extended shell implementation + +# func_append_quoted var value +# Quote VALUE and append to the end of shell variable VAR, separated +# by a space. +func_append_quoted () +{ + func_quote_for_eval "${2}" + eval "${1}=\$${1}\\ \$func_quote_for_eval_result" +} # func_append_quoted may be replaced by extended shell implementation + + +# func_arith arithmetic-term... +func_arith () +{ + func_arith_result=`expr "${@}"` +} # func_arith may be replaced by extended shell implementation + + +# func_len string +# STRING may not start with a hyphen. +func_len () +{ + func_len_result=`expr "${1}" : ".*" 2>/dev/null || echo $max_cmd_len` +} # func_len may be replaced by extended shell implementation + + +# func_lo2o object +func_lo2o () +{ + func_lo2o_result=`$ECHO "${1}" | $SED "$lo2o"` +} # func_lo2o may be replaced by extended shell implementation + + +# func_xform libobj-or-source +func_xform () +{ + func_xform_result=`$ECHO "${1}" | $SED 's/\.[^.]*$/.lo/'` +} # func_xform may be replaced by extended shell implementation + + +# func_fatal_configuration arg... +# Echo program name prefixed message to standard error, followed by +# a configuration failure hint, and exit. +func_fatal_configuration () +{ + func_error ${1+"$@"} + func_error "See the $PACKAGE documentation for more information." + func_fatal_error "Fatal configuration error." +} + + +# func_config +# Display the configuration for all the tags in this script. +func_config () +{ + re_begincf='^# ### BEGIN LIBTOOL' + re_endcf='^# ### END LIBTOOL' + + # Default configuration. + $SED "1,/$re_begincf CONFIG/d;/$re_endcf CONFIG/,\$d" < "$progpath" + + # Now print the configurations for the tags. + for tagname in $taglist; do + $SED -n "/$re_begincf TAG CONFIG: $tagname\$/,/$re_endcf TAG CONFIG: $tagname\$/p" < "$progpath" + done + + exit $? +} + +# func_features +# Display the features supported by this script. +func_features () +{ + echo "host: $host" + if test "$build_libtool_libs" = yes; then + echo "enable shared libraries" + else + echo "disable shared libraries" + fi + if test "$build_old_libs" = yes; then + echo "enable static libraries" + else + echo "disable static libraries" + fi + + exit $? +} + +# func_enable_tag tagname +# Verify that TAGNAME is valid, and either flag an error and exit, or +# enable the TAGNAME tag. We also add TAGNAME to the global $taglist +# variable here. +func_enable_tag () +{ + # Global variable: + tagname="$1" + + re_begincf="^# ### BEGIN LIBTOOL TAG CONFIG: $tagname\$" + re_endcf="^# ### END LIBTOOL TAG CONFIG: $tagname\$" + sed_extractcf="/$re_begincf/,/$re_endcf/p" + + # Validate tagname. + case $tagname in + *[!-_A-Za-z0-9,/]*) + func_fatal_error "invalid tag name: $tagname" + ;; + esac + + # Don't test for the "default" C tag, as we know it's + # there but not specially marked. + case $tagname in + CC) ;; + *) + if $GREP "$re_begincf" "$progpath" >/dev/null 2>&1; then + taglist="$taglist $tagname" + + # Evaluate the configuration. Be careful to quote the path + # and the sed script, to avoid splitting on whitespace, but + # also don't use non-portable quotes within backquotes within + # quotes we have to do it in 2 steps: + extractedcf=`$SED -n -e "$sed_extractcf" < "$progpath"` + eval "$extractedcf" + else + func_error "ignoring unknown tag $tagname" + fi + ;; + esac +} + +# func_check_version_match +# Ensure that we are using m4 macros, and libtool script from the same +# release of libtool. +func_check_version_match () +{ + if test "$package_revision" != "$macro_revision"; then + if test "$VERSION" != "$macro_version"; then + if test -z "$macro_version"; then + cat >&2 <<_LT_EOF +$progname: Version mismatch error. This is $PACKAGE $VERSION, but the +$progname: definition of this LT_INIT comes from an older release. +$progname: You should recreate aclocal.m4 with macros from $PACKAGE $VERSION +$progname: and run autoconf again. +_LT_EOF + else + cat >&2 <<_LT_EOF +$progname: Version mismatch error. This is $PACKAGE $VERSION, but the +$progname: definition of this LT_INIT comes from $PACKAGE $macro_version. +$progname: You should recreate aclocal.m4 with macros from $PACKAGE $VERSION +$progname: and run autoconf again. +_LT_EOF + fi + else + cat >&2 <<_LT_EOF +$progname: Version mismatch error. This is $PACKAGE $VERSION, revision $package_revision, +$progname: but the definition of this LT_INIT comes from revision $macro_revision. +$progname: You should recreate aclocal.m4 with macros from revision $package_revision +$progname: of $PACKAGE $VERSION and run autoconf again. +_LT_EOF + fi + + exit $EXIT_MISMATCH + fi +} + + +# Shorthand for --mode=foo, only valid as the first argument +case $1 in +clean|clea|cle|cl) + shift; set dummy --mode clean ${1+"$@"}; shift + ;; +compile|compil|compi|comp|com|co|c) + shift; set dummy --mode compile ${1+"$@"}; shift + ;; +execute|execut|execu|exec|exe|ex|e) + shift; set dummy --mode execute ${1+"$@"}; shift + ;; +finish|finis|fini|fin|fi|f) + shift; set dummy --mode finish ${1+"$@"}; shift + ;; +install|instal|insta|inst|ins|in|i) + shift; set dummy --mode install ${1+"$@"}; shift + ;; +link|lin|li|l) + shift; set dummy --mode link ${1+"$@"}; shift + ;; +uninstall|uninstal|uninsta|uninst|unins|unin|uni|un|u) + shift; set dummy --mode uninstall ${1+"$@"}; shift + ;; +esac + + + +# Option defaults: +opt_debug=: +opt_dry_run=false +opt_config=false +opt_preserve_dup_deps=false +opt_features=false +opt_finish=false +opt_help=false +opt_help_all=false +opt_silent=: +opt_warning=: +opt_verbose=: +opt_silent=false +opt_verbose=false + + +# Parse options once, thoroughly. This comes as soon as possible in the +# script to make things like `--version' happen as quickly as we can. +{ + # this just eases exit handling + while test $# -gt 0; do + opt="$1" + shift + case $opt in + --debug|-x) opt_debug='set -x' + func_echo "enabling shell trace mode" + $opt_debug + ;; + --dry-run|--dryrun|-n) + opt_dry_run=: + ;; + --config) + opt_config=: +func_config + ;; + --dlopen|-dlopen) + optarg="$1" + opt_dlopen="${opt_dlopen+$opt_dlopen +}$optarg" + shift + ;; + --preserve-dup-deps) + opt_preserve_dup_deps=: + ;; + --features) + opt_features=: +func_features + ;; + --finish) + opt_finish=: +set dummy --mode finish ${1+"$@"}; shift + ;; + --help) + opt_help=: + ;; + --help-all) + opt_help_all=: +opt_help=': help-all' + ;; + --mode) + test $# = 0 && func_missing_arg $opt && break + optarg="$1" + opt_mode="$optarg" +case $optarg in + # Valid mode arguments: + clean|compile|execute|finish|install|link|relink|uninstall) ;; + + # Catch anything else as an error + *) func_error "invalid argument for $opt" + exit_cmd=exit + break + ;; +esac + shift + ;; + --no-silent|--no-quiet) + opt_silent=false +func_append preserve_args " $opt" + ;; + --no-warning|--no-warn) + opt_warning=false +func_append preserve_args " $opt" + ;; + --no-verbose) + opt_verbose=false +func_append preserve_args " $opt" + ;; + --silent|--quiet) + opt_silent=: +func_append preserve_args " $opt" + opt_verbose=false + ;; + --verbose|-v) + opt_verbose=: +func_append preserve_args " $opt" +opt_silent=false + ;; + --tag) + test $# = 0 && func_missing_arg $opt && break + optarg="$1" + opt_tag="$optarg" +func_append preserve_args " $opt $optarg" +func_enable_tag "$optarg" + shift + ;; + + -\?|-h) func_usage ;; + --help) func_help ;; + --version) func_version ;; + + # Separate optargs to long options: + --*=*) + func_split_long_opt "$opt" + set dummy "$func_split_long_opt_name" "$func_split_long_opt_arg" ${1+"$@"} + shift + ;; + + # Separate non-argument short options: + -\?*|-h*|-n*|-v*) + func_split_short_opt "$opt" + set dummy "$func_split_short_opt_name" "-$func_split_short_opt_arg" ${1+"$@"} + shift + ;; + + --) break ;; + -*) func_fatal_help "unrecognized option \`$opt'" ;; + *) set dummy "$opt" ${1+"$@"}; shift; break ;; + esac + done + + # Validate options: + + # save first non-option argument + if test "$#" -gt 0; then + nonopt="$opt" + shift + fi + + # preserve --debug + test "$opt_debug" = : || func_append preserve_args " --debug" + + case $host in + *cygwin* | *mingw* | *pw32* | *cegcc*) + # don't eliminate duplications in $postdeps and $predeps + opt_duplicate_compiler_generated_deps=: + ;; + *) + opt_duplicate_compiler_generated_deps=$opt_preserve_dup_deps + ;; + esac + + $opt_help || { + # Sanity checks first: + func_check_version_match + + if test "$build_libtool_libs" != yes && test "$build_old_libs" != yes; then + func_fatal_configuration "not configured to build any kind of library" + fi + + # Darwin sucks + eval std_shrext=\"$shrext_cmds\" + + # Only execute mode is allowed to have -dlopen flags. + if test -n "$opt_dlopen" && test "$opt_mode" != execute; then + func_error "unrecognized option \`-dlopen'" + $ECHO "$help" 1>&2 + exit $EXIT_FAILURE + fi + + # Change the help message to a mode-specific one. + generic_help="$help" + help="Try \`$progname --help --mode=$opt_mode' for more information." + } + + + # Bail if the options were screwed + $exit_cmd $EXIT_FAILURE +} + + + + +## ----------- ## +## Main. ## +## ----------- ## + +# func_lalib_p file +# True iff FILE is a libtool `.la' library or `.lo' object file. +# This function is only a basic sanity check; it will hardly flush out +# determined imposters. +func_lalib_p () +{ + test -f "$1" && + $SED -e 4q "$1" 2>/dev/null \ + | $GREP "^# Generated by .*$PACKAGE" > /dev/null 2>&1 +} + +# func_lalib_unsafe_p file +# True iff FILE is a libtool `.la' library or `.lo' object file. +# This function implements the same check as func_lalib_p without +# resorting to external programs. To this end, it redirects stdin and +# closes it afterwards, without saving the original file descriptor. +# As a safety measure, use it only where a negative result would be +# fatal anyway. Works if `file' does not exist. +func_lalib_unsafe_p () +{ + lalib_p=no + if test -f "$1" && test -r "$1" && exec 5<&0 <"$1"; then + for lalib_p_l in 1 2 3 4 + do + read lalib_p_line + case "$lalib_p_line" in + \#\ Generated\ by\ *$PACKAGE* ) lalib_p=yes; break;; + esac + done + exec 0<&5 5<&- + fi + test "$lalib_p" = yes +} + +# func_ltwrapper_script_p file +# True iff FILE is a libtool wrapper script +# This function is only a basic sanity check; it will hardly flush out +# determined imposters. +func_ltwrapper_script_p () +{ + func_lalib_p "$1" +} + +# func_ltwrapper_executable_p file +# True iff FILE is a libtool wrapper executable +# This function is only a basic sanity check; it will hardly flush out +# determined imposters. +func_ltwrapper_executable_p () +{ + func_ltwrapper_exec_suffix= + case $1 in + *.exe) ;; + *) func_ltwrapper_exec_suffix=.exe ;; + esac + $GREP "$magic_exe" "$1$func_ltwrapper_exec_suffix" >/dev/null 2>&1 +} + +# func_ltwrapper_scriptname file +# Assumes file is an ltwrapper_executable +# uses $file to determine the appropriate filename for a +# temporary ltwrapper_script. +func_ltwrapper_scriptname () +{ + func_dirname_and_basename "$1" "" "." + func_stripname '' '.exe' "$func_basename_result" + func_ltwrapper_scriptname_result="$func_dirname_result/$objdir/${func_stripname_result}_ltshwrapper" +} + +# func_ltwrapper_p file +# True iff FILE is a libtool wrapper script or wrapper executable +# This function is only a basic sanity check; it will hardly flush out +# determined imposters. +func_ltwrapper_p () +{ + func_ltwrapper_script_p "$1" || func_ltwrapper_executable_p "$1" +} + + +# func_execute_cmds commands fail_cmd +# Execute tilde-delimited COMMANDS. +# If FAIL_CMD is given, eval that upon failure. +# FAIL_CMD may read-access the current command in variable CMD! +func_execute_cmds () +{ + $opt_debug + save_ifs=$IFS; IFS='~' + for cmd in $1; do + IFS=$save_ifs + eval cmd=\"$cmd\" + func_show_eval "$cmd" "${2-:}" + done + IFS=$save_ifs +} + + +# func_source file +# Source FILE, adding directory component if necessary. +# Note that it is not necessary on cygwin/mingw to append a dot to +# FILE even if both FILE and FILE.exe exist: automatic-append-.exe +# behavior happens only for exec(3), not for open(2)! Also, sourcing +# `FILE.' does not work on cygwin managed mounts. +func_source () +{ + $opt_debug + case $1 in + */* | *\\*) . "$1" ;; + *) . "./$1" ;; + esac +} + + +# func_resolve_sysroot PATH +# Replace a leading = in PATH with a sysroot. Store the result into +# func_resolve_sysroot_result +func_resolve_sysroot () +{ + func_resolve_sysroot_result=$1 + case $func_resolve_sysroot_result in + =*) + func_stripname '=' '' "$func_resolve_sysroot_result" + func_resolve_sysroot_result=$lt_sysroot$func_stripname_result + ;; + esac +} + +# func_replace_sysroot PATH +# If PATH begins with the sysroot, replace it with = and +# store the result into func_replace_sysroot_result. +func_replace_sysroot () +{ + case "$lt_sysroot:$1" in + ?*:"$lt_sysroot"*) + func_stripname "$lt_sysroot" '' "$1" + func_replace_sysroot_result="=$func_stripname_result" + ;; + *) + # Including no sysroot. + func_replace_sysroot_result=$1 + ;; + esac +} + +# func_infer_tag arg +# Infer tagged configuration to use if any are available and +# if one wasn't chosen via the "--tag" command line option. +# Only attempt this if the compiler in the base compile +# command doesn't match the default compiler. +# arg is usually of the form 'gcc ...' +func_infer_tag () +{ + $opt_debug + if test -n "$available_tags" && test -z "$tagname"; then + CC_quoted= + for arg in $CC; do + func_append_quoted CC_quoted "$arg" + done + CC_expanded=`func_echo_all $CC` + CC_quoted_expanded=`func_echo_all $CC_quoted` + case $@ in + # Blanks in the command may have been stripped by the calling shell, + # but not from the CC environment variable when configure was run. + " $CC "* | "$CC "* | " $CC_expanded "* | "$CC_expanded "* | \ + " $CC_quoted"* | "$CC_quoted "* | " $CC_quoted_expanded "* | "$CC_quoted_expanded "*) ;; + # Blanks at the start of $base_compile will cause this to fail + # if we don't check for them as well. + *) + for z in $available_tags; do + if $GREP "^# ### BEGIN LIBTOOL TAG CONFIG: $z$" < "$progpath" > /dev/null; then + # Evaluate the configuration. + eval "`${SED} -n -e '/^# ### BEGIN LIBTOOL TAG CONFIG: '$z'$/,/^# ### END LIBTOOL TAG CONFIG: '$z'$/p' < $progpath`" + CC_quoted= + for arg in $CC; do + # Double-quote args containing other shell metacharacters. + func_append_quoted CC_quoted "$arg" + done + CC_expanded=`func_echo_all $CC` + CC_quoted_expanded=`func_echo_all $CC_quoted` + case "$@ " in + " $CC "* | "$CC "* | " $CC_expanded "* | "$CC_expanded "* | \ + " $CC_quoted"* | "$CC_quoted "* | " $CC_quoted_expanded "* | "$CC_quoted_expanded "*) + # The compiler in the base compile command matches + # the one in the tagged configuration. + # Assume this is the tagged configuration we want. + tagname=$z + break + ;; + esac + fi + done + # If $tagname still isn't set, then no tagged configuration + # was found and let the user know that the "--tag" command + # line option must be used. + if test -z "$tagname"; then + func_echo "unable to infer tagged configuration" + func_fatal_error "specify a tag with \`--tag'" +# else +# func_verbose "using $tagname tagged configuration" + fi + ;; + esac + fi +} + + + +# func_write_libtool_object output_name pic_name nonpic_name +# Create a libtool object file (analogous to a ".la" file), +# but don't create it if we're doing a dry run. +func_write_libtool_object () +{ + write_libobj=${1} + if test "$build_libtool_libs" = yes; then + write_lobj=\'${2}\' + else + write_lobj=none + fi + + if test "$build_old_libs" = yes; then + write_oldobj=\'${3}\' + else + write_oldobj=none + fi + + $opt_dry_run || { + cat >${write_libobj}T </dev/null` + if test "$?" -eq 0 && test -n "${func_convert_core_file_wine_to_w32_tmp}"; then + func_convert_core_file_wine_to_w32_result=`$ECHO "$func_convert_core_file_wine_to_w32_tmp" | + $SED -e "$lt_sed_naive_backslashify"` + else + func_convert_core_file_wine_to_w32_result= + fi + fi +} +# end: func_convert_core_file_wine_to_w32 + + +# func_convert_core_path_wine_to_w32 ARG +# Helper function used by path conversion functions when $build is *nix, and +# $host is mingw, cygwin, or some other w32 environment. Relies on a correctly +# configured wine environment available, with the winepath program in $build's +# $PATH. Assumes ARG has no leading or trailing path separator characters. +# +# ARG is path to be converted from $build format to win32. +# Result is available in $func_convert_core_path_wine_to_w32_result. +# Unconvertible file (directory) names in ARG are skipped; if no directory names +# are convertible, then the result may be empty. +func_convert_core_path_wine_to_w32 () +{ + $opt_debug + # unfortunately, winepath doesn't convert paths, only file names + func_convert_core_path_wine_to_w32_result="" + if test -n "$1"; then + oldIFS=$IFS + IFS=: + for func_convert_core_path_wine_to_w32_f in $1; do + IFS=$oldIFS + func_convert_core_file_wine_to_w32 "$func_convert_core_path_wine_to_w32_f" + if test -n "$func_convert_core_file_wine_to_w32_result" ; then + if test -z "$func_convert_core_path_wine_to_w32_result"; then + func_convert_core_path_wine_to_w32_result="$func_convert_core_file_wine_to_w32_result" + else + func_append func_convert_core_path_wine_to_w32_result ";$func_convert_core_file_wine_to_w32_result" + fi + fi + done + IFS=$oldIFS + fi +} +# end: func_convert_core_path_wine_to_w32 + + +# func_cygpath ARGS... +# Wrapper around calling the cygpath program via LT_CYGPATH. This is used when +# when (1) $build is *nix and Cygwin is hosted via a wine environment; or (2) +# $build is MSYS and $host is Cygwin, or (3) $build is Cygwin. In case (1) or +# (2), returns the Cygwin file name or path in func_cygpath_result (input +# file name or path is assumed to be in w32 format, as previously converted +# from $build's *nix or MSYS format). In case (3), returns the w32 file name +# or path in func_cygpath_result (input file name or path is assumed to be in +# Cygwin format). Returns an empty string on error. +# +# ARGS are passed to cygpath, with the last one being the file name or path to +# be converted. +# +# Specify the absolute *nix (or w32) name to cygpath in the LT_CYGPATH +# environment variable; do not put it in $PATH. +func_cygpath () +{ + $opt_debug + if test -n "$LT_CYGPATH" && test -f "$LT_CYGPATH"; then + func_cygpath_result=`$LT_CYGPATH "$@" 2>/dev/null` + if test "$?" -ne 0; then + # on failure, ensure result is empty + func_cygpath_result= + fi + else + func_cygpath_result= + func_error "LT_CYGPATH is empty or specifies non-existent file: \`$LT_CYGPATH'" + fi +} +#end: func_cygpath + + +# func_convert_core_msys_to_w32 ARG +# Convert file name or path ARG from MSYS format to w32 format. Return +# result in func_convert_core_msys_to_w32_result. +func_convert_core_msys_to_w32 () +{ + $opt_debug + # awkward: cmd appends spaces to result + func_convert_core_msys_to_w32_result=`( cmd //c echo "$1" ) 2>/dev/null | + $SED -e 's/[ ]*$//' -e "$lt_sed_naive_backslashify"` +} +#end: func_convert_core_msys_to_w32 + + +# func_convert_file_check ARG1 ARG2 +# Verify that ARG1 (a file name in $build format) was converted to $host +# format in ARG2. Otherwise, emit an error message, but continue (resetting +# func_to_host_file_result to ARG1). +func_convert_file_check () +{ + $opt_debug + if test -z "$2" && test -n "$1" ; then + func_error "Could not determine host file name corresponding to" + func_error " \`$1'" + func_error "Continuing, but uninstalled executables may not work." + # Fallback: + func_to_host_file_result="$1" + fi +} +# end func_convert_file_check + + +# func_convert_path_check FROM_PATHSEP TO_PATHSEP FROM_PATH TO_PATH +# Verify that FROM_PATH (a path in $build format) was converted to $host +# format in TO_PATH. Otherwise, emit an error message, but continue, resetting +# func_to_host_file_result to a simplistic fallback value (see below). +func_convert_path_check () +{ + $opt_debug + if test -z "$4" && test -n "$3"; then + func_error "Could not determine the host path corresponding to" + func_error " \`$3'" + func_error "Continuing, but uninstalled executables may not work." + # Fallback. This is a deliberately simplistic "conversion" and + # should not be "improved". See libtool.info. + if test "x$1" != "x$2"; then + lt_replace_pathsep_chars="s|$1|$2|g" + func_to_host_path_result=`echo "$3" | + $SED -e "$lt_replace_pathsep_chars"` + else + func_to_host_path_result="$3" + fi + fi +} +# end func_convert_path_check + + +# func_convert_path_front_back_pathsep FRONTPAT BACKPAT REPL ORIG +# Modifies func_to_host_path_result by prepending REPL if ORIG matches FRONTPAT +# and appending REPL if ORIG matches BACKPAT. +func_convert_path_front_back_pathsep () +{ + $opt_debug + case $4 in + $1 ) func_to_host_path_result="$3$func_to_host_path_result" + ;; + esac + case $4 in + $2 ) func_append func_to_host_path_result "$3" + ;; + esac +} +# end func_convert_path_front_back_pathsep + + +################################################## +# $build to $host FILE NAME CONVERSION FUNCTIONS # +################################################## +# invoked via `$to_host_file_cmd ARG' +# +# In each case, ARG is the path to be converted from $build to $host format. +# Result will be available in $func_to_host_file_result. + + +# func_to_host_file ARG +# Converts the file name ARG from $build format to $host format. Return result +# in func_to_host_file_result. +func_to_host_file () +{ + $opt_debug + $to_host_file_cmd "$1" +} +# end func_to_host_file + + +# func_to_tool_file ARG LAZY +# converts the file name ARG from $build format to toolchain format. Return +# result in func_to_tool_file_result. If the conversion in use is listed +# in (the comma separated) LAZY, no conversion takes place. +func_to_tool_file () +{ + $opt_debug + case ,$2, in + *,"$to_tool_file_cmd",*) + func_to_tool_file_result=$1 + ;; + *) + $to_tool_file_cmd "$1" + func_to_tool_file_result=$func_to_host_file_result + ;; + esac +} +# end func_to_tool_file + + +# func_convert_file_noop ARG +# Copy ARG to func_to_host_file_result. +func_convert_file_noop () +{ + func_to_host_file_result="$1" +} +# end func_convert_file_noop + + +# func_convert_file_msys_to_w32 ARG +# Convert file name ARG from (mingw) MSYS to (mingw) w32 format; automatic +# conversion to w32 is not available inside the cwrapper. Returns result in +# func_to_host_file_result. +func_convert_file_msys_to_w32 () +{ + $opt_debug + func_to_host_file_result="$1" + if test -n "$1"; then + func_convert_core_msys_to_w32 "$1" + func_to_host_file_result="$func_convert_core_msys_to_w32_result" + fi + func_convert_file_check "$1" "$func_to_host_file_result" +} +# end func_convert_file_msys_to_w32 + + +# func_convert_file_cygwin_to_w32 ARG +# Convert file name ARG from Cygwin to w32 format. Returns result in +# func_to_host_file_result. +func_convert_file_cygwin_to_w32 () +{ + $opt_debug + func_to_host_file_result="$1" + if test -n "$1"; then + # because $build is cygwin, we call "the" cygpath in $PATH; no need to use + # LT_CYGPATH in this case. + func_to_host_file_result=`cygpath -m "$1"` + fi + func_convert_file_check "$1" "$func_to_host_file_result" +} +# end func_convert_file_cygwin_to_w32 + + +# func_convert_file_nix_to_w32 ARG +# Convert file name ARG from *nix to w32 format. Requires a wine environment +# and a working winepath. Returns result in func_to_host_file_result. +func_convert_file_nix_to_w32 () +{ + $opt_debug + func_to_host_file_result="$1" + if test -n "$1"; then + func_convert_core_file_wine_to_w32 "$1" + func_to_host_file_result="$func_convert_core_file_wine_to_w32_result" + fi + func_convert_file_check "$1" "$func_to_host_file_result" +} +# end func_convert_file_nix_to_w32 + + +# func_convert_file_msys_to_cygwin ARG +# Convert file name ARG from MSYS to Cygwin format. Requires LT_CYGPATH set. +# Returns result in func_to_host_file_result. +func_convert_file_msys_to_cygwin () +{ + $opt_debug + func_to_host_file_result="$1" + if test -n "$1"; then + func_convert_core_msys_to_w32 "$1" + func_cygpath -u "$func_convert_core_msys_to_w32_result" + func_to_host_file_result="$func_cygpath_result" + fi + func_convert_file_check "$1" "$func_to_host_file_result" +} +# end func_convert_file_msys_to_cygwin + + +# func_convert_file_nix_to_cygwin ARG +# Convert file name ARG from *nix to Cygwin format. Requires Cygwin installed +# in a wine environment, working winepath, and LT_CYGPATH set. Returns result +# in func_to_host_file_result. +func_convert_file_nix_to_cygwin () +{ + $opt_debug + func_to_host_file_result="$1" + if test -n "$1"; then + # convert from *nix to w32, then use cygpath to convert from w32 to cygwin. + func_convert_core_file_wine_to_w32 "$1" + func_cygpath -u "$func_convert_core_file_wine_to_w32_result" + func_to_host_file_result="$func_cygpath_result" + fi + func_convert_file_check "$1" "$func_to_host_file_result" +} +# end func_convert_file_nix_to_cygwin + + +############################################# +# $build to $host PATH CONVERSION FUNCTIONS # +############################################# +# invoked via `$to_host_path_cmd ARG' +# +# In each case, ARG is the path to be converted from $build to $host format. +# The result will be available in $func_to_host_path_result. +# +# Path separators are also converted from $build format to $host format. If +# ARG begins or ends with a path separator character, it is preserved (but +# converted to $host format) on output. +# +# All path conversion functions are named using the following convention: +# file name conversion function : func_convert_file_X_to_Y () +# path conversion function : func_convert_path_X_to_Y () +# where, for any given $build/$host combination the 'X_to_Y' value is the +# same. If conversion functions are added for new $build/$host combinations, +# the two new functions must follow this pattern, or func_init_to_host_path_cmd +# will break. + + +# func_init_to_host_path_cmd +# Ensures that function "pointer" variable $to_host_path_cmd is set to the +# appropriate value, based on the value of $to_host_file_cmd. +to_host_path_cmd= +func_init_to_host_path_cmd () +{ + $opt_debug + if test -z "$to_host_path_cmd"; then + func_stripname 'func_convert_file_' '' "$to_host_file_cmd" + to_host_path_cmd="func_convert_path_${func_stripname_result}" + fi +} + + +# func_to_host_path ARG +# Converts the path ARG from $build format to $host format. Return result +# in func_to_host_path_result. +func_to_host_path () +{ + $opt_debug + func_init_to_host_path_cmd + $to_host_path_cmd "$1" +} +# end func_to_host_path + + +# func_convert_path_noop ARG +# Copy ARG to func_to_host_path_result. +func_convert_path_noop () +{ + func_to_host_path_result="$1" +} +# end func_convert_path_noop + + +# func_convert_path_msys_to_w32 ARG +# Convert path ARG from (mingw) MSYS to (mingw) w32 format; automatic +# conversion to w32 is not available inside the cwrapper. Returns result in +# func_to_host_path_result. +func_convert_path_msys_to_w32 () +{ + $opt_debug + func_to_host_path_result="$1" + if test -n "$1"; then + # Remove leading and trailing path separator characters from ARG. MSYS + # behavior is inconsistent here; cygpath turns them into '.;' and ';.'; + # and winepath ignores them completely. + func_stripname : : "$1" + func_to_host_path_tmp1=$func_stripname_result + func_convert_core_msys_to_w32 "$func_to_host_path_tmp1" + func_to_host_path_result="$func_convert_core_msys_to_w32_result" + func_convert_path_check : ";" \ + "$func_to_host_path_tmp1" "$func_to_host_path_result" + func_convert_path_front_back_pathsep ":*" "*:" ";" "$1" + fi +} +# end func_convert_path_msys_to_w32 + + +# func_convert_path_cygwin_to_w32 ARG +# Convert path ARG from Cygwin to w32 format. Returns result in +# func_to_host_file_result. +func_convert_path_cygwin_to_w32 () +{ + $opt_debug + func_to_host_path_result="$1" + if test -n "$1"; then + # See func_convert_path_msys_to_w32: + func_stripname : : "$1" + func_to_host_path_tmp1=$func_stripname_result + func_to_host_path_result=`cygpath -m -p "$func_to_host_path_tmp1"` + func_convert_path_check : ";" \ + "$func_to_host_path_tmp1" "$func_to_host_path_result" + func_convert_path_front_back_pathsep ":*" "*:" ";" "$1" + fi +} +# end func_convert_path_cygwin_to_w32 + + +# func_convert_path_nix_to_w32 ARG +# Convert path ARG from *nix to w32 format. Requires a wine environment and +# a working winepath. Returns result in func_to_host_file_result. +func_convert_path_nix_to_w32 () +{ + $opt_debug + func_to_host_path_result="$1" + if test -n "$1"; then + # See func_convert_path_msys_to_w32: + func_stripname : : "$1" + func_to_host_path_tmp1=$func_stripname_result + func_convert_core_path_wine_to_w32 "$func_to_host_path_tmp1" + func_to_host_path_result="$func_convert_core_path_wine_to_w32_result" + func_convert_path_check : ";" \ + "$func_to_host_path_tmp1" "$func_to_host_path_result" + func_convert_path_front_back_pathsep ":*" "*:" ";" "$1" + fi +} +# end func_convert_path_nix_to_w32 + + +# func_convert_path_msys_to_cygwin ARG +# Convert path ARG from MSYS to Cygwin format. Requires LT_CYGPATH set. +# Returns result in func_to_host_file_result. +func_convert_path_msys_to_cygwin () +{ + $opt_debug + func_to_host_path_result="$1" + if test -n "$1"; then + # See func_convert_path_msys_to_w32: + func_stripname : : "$1" + func_to_host_path_tmp1=$func_stripname_result + func_convert_core_msys_to_w32 "$func_to_host_path_tmp1" + func_cygpath -u -p "$func_convert_core_msys_to_w32_result" + func_to_host_path_result="$func_cygpath_result" + func_convert_path_check : : \ + "$func_to_host_path_tmp1" "$func_to_host_path_result" + func_convert_path_front_back_pathsep ":*" "*:" : "$1" + fi +} +# end func_convert_path_msys_to_cygwin + + +# func_convert_path_nix_to_cygwin ARG +# Convert path ARG from *nix to Cygwin format. Requires Cygwin installed in a +# a wine environment, working winepath, and LT_CYGPATH set. Returns result in +# func_to_host_file_result. +func_convert_path_nix_to_cygwin () +{ + $opt_debug + func_to_host_path_result="$1" + if test -n "$1"; then + # Remove leading and trailing path separator characters from + # ARG. msys behavior is inconsistent here, cygpath turns them + # into '.;' and ';.', and winepath ignores them completely. + func_stripname : : "$1" + func_to_host_path_tmp1=$func_stripname_result + func_convert_core_path_wine_to_w32 "$func_to_host_path_tmp1" + func_cygpath -u -p "$func_convert_core_path_wine_to_w32_result" + func_to_host_path_result="$func_cygpath_result" + func_convert_path_check : : \ + "$func_to_host_path_tmp1" "$func_to_host_path_result" + func_convert_path_front_back_pathsep ":*" "*:" : "$1" + fi +} +# end func_convert_path_nix_to_cygwin + + +# func_mode_compile arg... +func_mode_compile () +{ + $opt_debug + # Get the compilation command and the source file. + base_compile= + srcfile="$nonopt" # always keep a non-empty value in "srcfile" + suppress_opt=yes + suppress_output= + arg_mode=normal + libobj= + later= + pie_flag= + + for arg + do + case $arg_mode in + arg ) + # do not "continue". Instead, add this to base_compile + lastarg="$arg" + arg_mode=normal + ;; + + target ) + libobj="$arg" + arg_mode=normal + continue + ;; + + normal ) + # Accept any command-line options. + case $arg in + -o) + test -n "$libobj" && \ + func_fatal_error "you cannot specify \`-o' more than once" + arg_mode=target + continue + ;; + + -pie | -fpie | -fPIE) + func_append pie_flag " $arg" + continue + ;; + + -shared | -static | -prefer-pic | -prefer-non-pic) + func_append later " $arg" + continue + ;; + + -no-suppress) + suppress_opt=no + continue + ;; + + -Xcompiler) + arg_mode=arg # the next one goes into the "base_compile" arg list + continue # The current "srcfile" will either be retained or + ;; # replaced later. I would guess that would be a bug. + + -Wc,*) + func_stripname '-Wc,' '' "$arg" + args=$func_stripname_result + lastarg= + save_ifs="$IFS"; IFS=',' + for arg in $args; do + IFS="$save_ifs" + func_append_quoted lastarg "$arg" + done + IFS="$save_ifs" + func_stripname ' ' '' "$lastarg" + lastarg=$func_stripname_result + + # Add the arguments to base_compile. + func_append base_compile " $lastarg" + continue + ;; + + *) + # Accept the current argument as the source file. + # The previous "srcfile" becomes the current argument. + # + lastarg="$srcfile" + srcfile="$arg" + ;; + esac # case $arg + ;; + esac # case $arg_mode + + # Aesthetically quote the previous argument. + func_append_quoted base_compile "$lastarg" + done # for arg + + case $arg_mode in + arg) + func_fatal_error "you must specify an argument for -Xcompile" + ;; + target) + func_fatal_error "you must specify a target with \`-o'" + ;; + *) + # Get the name of the library object. + test -z "$libobj" && { + func_basename "$srcfile" + libobj="$func_basename_result" + } + ;; + esac + + # Recognize several different file suffixes. + # If the user specifies -o file.o, it is replaced with file.lo + case $libobj in + *.[cCFSifmso] | \ + *.ada | *.adb | *.ads | *.asm | \ + *.c++ | *.cc | *.ii | *.class | *.cpp | *.cxx | \ + *.[fF][09]? | *.for | *.java | *.go | *.obj | *.sx | *.cu | *.cup) + func_xform "$libobj" + libobj=$func_xform_result + ;; + esac + + case $libobj in + *.lo) func_lo2o "$libobj"; obj=$func_lo2o_result ;; + *) + func_fatal_error "cannot determine name of library object from \`$libobj'" + ;; + esac + + func_infer_tag $base_compile + + for arg in $later; do + case $arg in + -shared) + test "$build_libtool_libs" != yes && \ + func_fatal_configuration "can not build a shared library" + build_old_libs=no + continue + ;; + + -static) + build_libtool_libs=no + build_old_libs=yes + continue + ;; + + -prefer-pic) + pic_mode=yes + continue + ;; + + -prefer-non-pic) + pic_mode=no + continue + ;; + esac + done + + func_quote_for_eval "$libobj" + test "X$libobj" != "X$func_quote_for_eval_result" \ + && $ECHO "X$libobj" | $GREP '[]~#^*{};<>?"'"'"' &()|`$[]' \ + && func_warning "libobj name \`$libobj' may not contain shell special characters." + func_dirname_and_basename "$obj" "/" "" + objname="$func_basename_result" + xdir="$func_dirname_result" + lobj=${xdir}$objdir/$objname + + test -z "$base_compile" && \ + func_fatal_help "you must specify a compilation command" + + # Delete any leftover library objects. + if test "$build_old_libs" = yes; then + removelist="$obj $lobj $libobj ${libobj}T" + else + removelist="$lobj $libobj ${libobj}T" + fi + + # On Cygwin there's no "real" PIC flag so we must build both object types + case $host_os in + cygwin* | mingw* | pw32* | os2* | cegcc*) + pic_mode=default + ;; + esac + if test "$pic_mode" = no && test "$deplibs_check_method" != pass_all; then + # non-PIC code in shared libraries is not supported + pic_mode=default + fi + + # Calculate the filename of the output object if compiler does + # not support -o with -c + if test "$compiler_c_o" = no; then + output_obj=`$ECHO "$srcfile" | $SED 's%^.*/%%; s%\.[^.]*$%%'`.${objext} + lockfile="$output_obj.lock" + else + output_obj= + need_locks=no + lockfile= + fi + + # Lock this critical section if it is needed + # We use this script file to make the link, it avoids creating a new file + if test "$need_locks" = yes; then + until $opt_dry_run || ln "$progpath" "$lockfile" 2>/dev/null; do + func_echo "Waiting for $lockfile to be removed" + sleep 2 + done + elif test "$need_locks" = warn; then + if test -f "$lockfile"; then + $ECHO "\ +*** ERROR, $lockfile exists and contains: +`cat $lockfile 2>/dev/null` + +This indicates that another process is trying to use the same +temporary object file, and libtool could not work around it because +your compiler does not support \`-c' and \`-o' together. If you +repeat this compilation, it may succeed, by chance, but you had better +avoid parallel builds (make -j) in this platform, or get a better +compiler." + + $opt_dry_run || $RM $removelist + exit $EXIT_FAILURE + fi + func_append removelist " $output_obj" + $ECHO "$srcfile" > "$lockfile" + fi + + $opt_dry_run || $RM $removelist + func_append removelist " $lockfile" + trap '$opt_dry_run || $RM $removelist; exit $EXIT_FAILURE' 1 2 15 + + func_to_tool_file "$srcfile" func_convert_file_msys_to_w32 + srcfile=$func_to_tool_file_result + func_quote_for_eval "$srcfile" + qsrcfile=$func_quote_for_eval_result + + # Only build a PIC object if we are building libtool libraries. + if test "$build_libtool_libs" = yes; then + # Without this assignment, base_compile gets emptied. + fbsd_hideous_sh_bug=$base_compile + + if test "$pic_mode" != no; then + command="$base_compile $qsrcfile $pic_flag" + else + # Don't build PIC code + command="$base_compile $qsrcfile" + fi + + func_mkdir_p "$xdir$objdir" + + if test -z "$output_obj"; then + # Place PIC objects in $objdir + func_append command " -o $lobj" + fi + + func_show_eval_locale "$command" \ + 'test -n "$output_obj" && $RM $removelist; exit $EXIT_FAILURE' + + if test "$need_locks" = warn && + test "X`cat $lockfile 2>/dev/null`" != "X$srcfile"; then + $ECHO "\ +*** ERROR, $lockfile contains: +`cat $lockfile 2>/dev/null` + +but it should contain: +$srcfile + +This indicates that another process is trying to use the same +temporary object file, and libtool could not work around it because +your compiler does not support \`-c' and \`-o' together. If you +repeat this compilation, it may succeed, by chance, but you had better +avoid parallel builds (make -j) in this platform, or get a better +compiler." + + $opt_dry_run || $RM $removelist + exit $EXIT_FAILURE + fi + + # Just move the object if needed, then go on to compile the next one + if test -n "$output_obj" && test "X$output_obj" != "X$lobj"; then + func_show_eval '$MV "$output_obj" "$lobj"' \ + 'error=$?; $opt_dry_run || $RM $removelist; exit $error' + fi + + # Allow error messages only from the first compilation. + if test "$suppress_opt" = yes; then + suppress_output=' >/dev/null 2>&1' + fi + fi + + # Only build a position-dependent object if we build old libraries. + if test "$build_old_libs" = yes; then + if test "$pic_mode" != yes; then + # Don't build PIC code + command="$base_compile $qsrcfile$pie_flag" + else + command="$base_compile $qsrcfile $pic_flag" + fi + if test "$compiler_c_o" = yes; then + func_append command " -o $obj" + fi + + # Suppress compiler output if we already did a PIC compilation. + func_append command "$suppress_output" + func_show_eval_locale "$command" \ + '$opt_dry_run || $RM $removelist; exit $EXIT_FAILURE' + + if test "$need_locks" = warn && + test "X`cat $lockfile 2>/dev/null`" != "X$srcfile"; then + $ECHO "\ +*** ERROR, $lockfile contains: +`cat $lockfile 2>/dev/null` + +but it should contain: +$srcfile + +This indicates that another process is trying to use the same +temporary object file, and libtool could not work around it because +your compiler does not support \`-c' and \`-o' together. If you +repeat this compilation, it may succeed, by chance, but you had better +avoid parallel builds (make -j) in this platform, or get a better +compiler." + + $opt_dry_run || $RM $removelist + exit $EXIT_FAILURE + fi + + # Just move the object if needed + if test -n "$output_obj" && test "X$output_obj" != "X$obj"; then + func_show_eval '$MV "$output_obj" "$obj"' \ + 'error=$?; $opt_dry_run || $RM $removelist; exit $error' + fi + fi + + $opt_dry_run || { + func_write_libtool_object "$libobj" "$objdir/$objname" "$objname" + + # Unlock the critical section if it was locked + if test "$need_locks" != no; then + removelist=$lockfile + $RM "$lockfile" + fi + } + + exit $EXIT_SUCCESS +} + +$opt_help || { + test "$opt_mode" = compile && func_mode_compile ${1+"$@"} +} + +func_mode_help () +{ + # We need to display help for each of the modes. + case $opt_mode in + "") + # Generic help is extracted from the usage comments + # at the start of this file. + func_help + ;; + + clean) + $ECHO \ +"Usage: $progname [OPTION]... --mode=clean RM [RM-OPTION]... FILE... + +Remove files from the build directory. + +RM is the name of the program to use to delete files associated with each FILE +(typically \`/bin/rm'). RM-OPTIONS are options (such as \`-f') to be passed +to RM. + +If FILE is a libtool library, object or program, all the files associated +with it are deleted. Otherwise, only FILE itself is deleted using RM." + ;; + + compile) + $ECHO \ +"Usage: $progname [OPTION]... --mode=compile COMPILE-COMMAND... SOURCEFILE + +Compile a source file into a libtool library object. + +This mode accepts the following additional options: + + -o OUTPUT-FILE set the output file name to OUTPUT-FILE + -no-suppress do not suppress compiler output for multiple passes + -prefer-pic try to build PIC objects only + -prefer-non-pic try to build non-PIC objects only + -shared do not build a \`.o' file suitable for static linking + -static only build a \`.o' file suitable for static linking + -Wc,FLAG pass FLAG directly to the compiler + +COMPILE-COMMAND is a command to be used in creating a \`standard' object file +from the given SOURCEFILE. + +The output file name is determined by removing the directory component from +SOURCEFILE, then substituting the C source code suffix \`.c' with the +library object suffix, \`.lo'." + ;; + + execute) + $ECHO \ +"Usage: $progname [OPTION]... --mode=execute COMMAND [ARGS]... + +Automatically set library path, then run a program. + +This mode accepts the following additional options: + + -dlopen FILE add the directory containing FILE to the library path + +This mode sets the library path environment variable according to \`-dlopen' +flags. + +If any of the ARGS are libtool executable wrappers, then they are translated +into their corresponding uninstalled binary, and any of their required library +directories are added to the library path. + +Then, COMMAND is executed, with ARGS as arguments." + ;; + + finish) + $ECHO \ +"Usage: $progname [OPTION]... --mode=finish [LIBDIR]... + +Complete the installation of libtool libraries. + +Each LIBDIR is a directory that contains libtool libraries. + +The commands that this mode executes may require superuser privileges. Use +the \`--dry-run' option if you just want to see what would be executed." + ;; + + install) + $ECHO \ +"Usage: $progname [OPTION]... --mode=install INSTALL-COMMAND... + +Install executables or libraries. + +INSTALL-COMMAND is the installation command. The first component should be +either the \`install' or \`cp' program. + +The following components of INSTALL-COMMAND are treated specially: + + -inst-prefix-dir PREFIX-DIR Use PREFIX-DIR as a staging area for installation + +The rest of the components are interpreted as arguments to that command (only +BSD-compatible install options are recognized)." + ;; + + link) + $ECHO \ +"Usage: $progname [OPTION]... --mode=link LINK-COMMAND... + +Link object files or libraries together to form another library, or to +create an executable program. + +LINK-COMMAND is a command using the C compiler that you would use to create +a program from several object files. + +The following components of LINK-COMMAND are treated specially: + + -all-static do not do any dynamic linking at all + -avoid-version do not add a version suffix if possible + -bindir BINDIR specify path to binaries directory (for systems where + libraries must be found in the PATH setting at runtime) + -dlopen FILE \`-dlpreopen' FILE if it cannot be dlopened at runtime + -dlpreopen FILE link in FILE and add its symbols to lt_preloaded_symbols + -export-dynamic allow symbols from OUTPUT-FILE to be resolved with dlsym(3) + -export-symbols SYMFILE + try to export only the symbols listed in SYMFILE + -export-symbols-regex REGEX + try to export only the symbols matching REGEX + -LLIBDIR search LIBDIR for required installed libraries + -lNAME OUTPUT-FILE requires the installed library libNAME + -module build a library that can dlopened + -no-fast-install disable the fast-install mode + -no-install link a not-installable executable + -no-undefined declare that a library does not refer to external symbols + -o OUTPUT-FILE create OUTPUT-FILE from the specified objects + -objectlist FILE Use a list of object files found in FILE to specify objects + -precious-files-regex REGEX + don't remove output files matching REGEX + -release RELEASE specify package release information + -rpath LIBDIR the created library will eventually be installed in LIBDIR + -R[ ]LIBDIR add LIBDIR to the runtime path of programs and libraries + -shared only do dynamic linking of libtool libraries + -shrext SUFFIX override the standard shared library file extension + -static do not do any dynamic linking of uninstalled libtool libraries + -static-libtool-libs + do not do any dynamic linking of libtool libraries + -version-info CURRENT[:REVISION[:AGE]] + specify library version info [each variable defaults to 0] + -weak LIBNAME declare that the target provides the LIBNAME interface + -Wc,FLAG + -Xcompiler FLAG pass linker-specific FLAG directly to the compiler + -Wl,FLAG + -Xlinker FLAG pass linker-specific FLAG directly to the linker + -XCClinker FLAG pass link-specific FLAG to the compiler driver (CC) + +All other options (arguments beginning with \`-') are ignored. + +Every other argument is treated as a filename. Files ending in \`.la' are +treated as uninstalled libtool libraries, other files are standard or library +object files. + +If the OUTPUT-FILE ends in \`.la', then a libtool library is created, +only library objects (\`.lo' files) may be specified, and \`-rpath' is +required, except when creating a convenience library. + +If OUTPUT-FILE ends in \`.a' or \`.lib', then a standard library is created +using \`ar' and \`ranlib', or on Windows using \`lib'. + +If OUTPUT-FILE ends in \`.lo' or \`.${objext}', then a reloadable object file +is created, otherwise an executable program is created." + ;; + + uninstall) + $ECHO \ +"Usage: $progname [OPTION]... --mode=uninstall RM [RM-OPTION]... FILE... + +Remove libraries from an installation directory. + +RM is the name of the program to use to delete files associated with each FILE +(typically \`/bin/rm'). RM-OPTIONS are options (such as \`-f') to be passed +to RM. + +If FILE is a libtool library, all the files associated with it are deleted. +Otherwise, only FILE itself is deleted using RM." + ;; + + *) + func_fatal_help "invalid operation mode \`$opt_mode'" + ;; + esac + + echo + $ECHO "Try \`$progname --help' for more information about other modes." +} + +# Now that we've collected a possible --mode arg, show help if necessary +if $opt_help; then + if test "$opt_help" = :; then + func_mode_help + else + { + func_help noexit + for opt_mode in compile link execute install finish uninstall clean; do + func_mode_help + done + } | sed -n '1p; 2,$s/^Usage:/ or: /p' + { + func_help noexit + for opt_mode in compile link execute install finish uninstall clean; do + echo + func_mode_help + done + } | + sed '1d + /^When reporting/,/^Report/{ + H + d + } + $x + /information about other modes/d + /more detailed .*MODE/d + s/^Usage:.*--mode=\([^ ]*\) .*/Description of \1 mode:/' + fi + exit $? +fi + + +# func_mode_execute arg... +func_mode_execute () +{ + $opt_debug + # The first argument is the command name. + cmd="$nonopt" + test -z "$cmd" && \ + func_fatal_help "you must specify a COMMAND" + + # Handle -dlopen flags immediately. + for file in $opt_dlopen; do + test -f "$file" \ + || func_fatal_help "\`$file' is not a file" + + dir= + case $file in + *.la) + func_resolve_sysroot "$file" + file=$func_resolve_sysroot_result + + # Check to see that this really is a libtool archive. + func_lalib_unsafe_p "$file" \ + || func_fatal_help "\`$lib' is not a valid libtool archive" + + # Read the libtool library. + dlname= + library_names= + func_source "$file" + + # Skip this library if it cannot be dlopened. + if test -z "$dlname"; then + # Warn if it was a shared library. + test -n "$library_names" && \ + func_warning "\`$file' was not linked with \`-export-dynamic'" + continue + fi + + func_dirname "$file" "" "." + dir="$func_dirname_result" + + if test -f "$dir/$objdir/$dlname"; then + func_append dir "/$objdir" + else + if test ! -f "$dir/$dlname"; then + func_fatal_error "cannot find \`$dlname' in \`$dir' or \`$dir/$objdir'" + fi + fi + ;; + + *.lo) + # Just add the directory containing the .lo file. + func_dirname "$file" "" "." + dir="$func_dirname_result" + ;; + + *) + func_warning "\`-dlopen' is ignored for non-libtool libraries and objects" + continue + ;; + esac + + # Get the absolute pathname. + absdir=`cd "$dir" && pwd` + test -n "$absdir" && dir="$absdir" + + # Now add the directory to shlibpath_var. + if eval "test -z \"\$$shlibpath_var\""; then + eval "$shlibpath_var=\"\$dir\"" + else + eval "$shlibpath_var=\"\$dir:\$$shlibpath_var\"" + fi + done + + # This variable tells wrapper scripts just to set shlibpath_var + # rather than running their programs. + libtool_execute_magic="$magic" + + # Check if any of the arguments is a wrapper script. + args= + for file + do + case $file in + -* | *.la | *.lo ) ;; + *) + # Do a test to see if this is really a libtool program. + if func_ltwrapper_script_p "$file"; then + func_source "$file" + # Transform arg to wrapped name. + file="$progdir/$program" + elif func_ltwrapper_executable_p "$file"; then + func_ltwrapper_scriptname "$file" + func_source "$func_ltwrapper_scriptname_result" + # Transform arg to wrapped name. + file="$progdir/$program" + fi + ;; + esac + # Quote arguments (to preserve shell metacharacters). + func_append_quoted args "$file" + done + + if test "X$opt_dry_run" = Xfalse; then + if test -n "$shlibpath_var"; then + # Export the shlibpath_var. + eval "export $shlibpath_var" + fi + + # Restore saved environment variables + for lt_var in LANG LANGUAGE LC_ALL LC_CTYPE LC_COLLATE LC_MESSAGES + do + eval "if test \"\${save_$lt_var+set}\" = set; then + $lt_var=\$save_$lt_var; export $lt_var + else + $lt_unset $lt_var + fi" + done + + # Now prepare to actually exec the command. + exec_cmd="\$cmd$args" + else + # Display what would be done. + if test -n "$shlibpath_var"; then + eval "\$ECHO \"\$shlibpath_var=\$$shlibpath_var\"" + echo "export $shlibpath_var" + fi + $ECHO "$cmd$args" + exit $EXIT_SUCCESS + fi +} + +test "$opt_mode" = execute && func_mode_execute ${1+"$@"} + + +# func_mode_finish arg... +func_mode_finish () +{ + $opt_debug + libs= + libdirs= + admincmds= + + for opt in "$nonopt" ${1+"$@"} + do + if test -d "$opt"; then + func_append libdirs " $opt" + + elif test -f "$opt"; then + if func_lalib_unsafe_p "$opt"; then + func_append libs " $opt" + else + func_warning "\`$opt' is not a valid libtool archive" + fi + + else + func_fatal_error "invalid argument \`$opt'" + fi + done + + if test -n "$libs"; then + if test -n "$lt_sysroot"; then + sysroot_regex=`$ECHO "$lt_sysroot" | $SED "$sed_make_literal_regex"` + sysroot_cmd="s/\([ ']\)$sysroot_regex/\1/g;" + else + sysroot_cmd= + fi + + # Remove sysroot references + if $opt_dry_run; then + for lib in $libs; do + echo "removing references to $lt_sysroot and \`=' prefixes from $lib" + done + else + tmpdir=`func_mktempdir` + for lib in $libs; do + sed -e "${sysroot_cmd} s/\([ ']-[LR]\)=/\1/g; s/\([ ']\)=/\1/g" $lib \ + > $tmpdir/tmp-la + mv -f $tmpdir/tmp-la $lib + done + ${RM}r "$tmpdir" + fi + fi + + if test -n "$finish_cmds$finish_eval" && test -n "$libdirs"; then + for libdir in $libdirs; do + if test -n "$finish_cmds"; then + # Do each command in the finish commands. + func_execute_cmds "$finish_cmds" 'admincmds="$admincmds +'"$cmd"'"' + fi + if test -n "$finish_eval"; then + # Do the single finish_eval. + eval cmds=\"$finish_eval\" + $opt_dry_run || eval "$cmds" || func_append admincmds " + $cmds" + fi + done + fi + + # Exit here if they wanted silent mode. + $opt_silent && exit $EXIT_SUCCESS + + if test -n "$finish_cmds$finish_eval" && test -n "$libdirs"; then + echo "----------------------------------------------------------------------" + echo "Libraries have been installed in:" + for libdir in $libdirs; do + $ECHO " $libdir" + done + echo + echo "If you ever happen to want to link against installed libraries" + echo "in a given directory, LIBDIR, you must either use libtool, and" + echo "specify the full pathname of the library, or use the \`-LLIBDIR'" + echo "flag during linking and do at least one of the following:" + if test -n "$shlibpath_var"; then + echo " - add LIBDIR to the \`$shlibpath_var' environment variable" + echo " during execution" + fi + if test -n "$runpath_var"; then + echo " - add LIBDIR to the \`$runpath_var' environment variable" + echo " during linking" + fi + if test -n "$hardcode_libdir_flag_spec"; then + libdir=LIBDIR + eval flag=\"$hardcode_libdir_flag_spec\" + + $ECHO " - use the \`$flag' linker flag" + fi + if test -n "$admincmds"; then + $ECHO " - have your system administrator run these commands:$admincmds" + fi + if test -f /etc/ld.so.conf; then + echo " - have your system administrator add LIBDIR to \`/etc/ld.so.conf'" + fi + echo + + echo "See any operating system documentation about shared libraries for" + case $host in + solaris2.[6789]|solaris2.1[0-9]) + echo "more information, such as the ld(1), crle(1) and ld.so(8) manual" + echo "pages." + ;; + *) + echo "more information, such as the ld(1) and ld.so(8) manual pages." + ;; + esac + echo "----------------------------------------------------------------------" + fi + exit $EXIT_SUCCESS +} + +test "$opt_mode" = finish && func_mode_finish ${1+"$@"} + + +# func_mode_install arg... +func_mode_install () +{ + $opt_debug + # There may be an optional sh(1) argument at the beginning of + # install_prog (especially on Windows NT). + if test "$nonopt" = "$SHELL" || test "$nonopt" = /bin/sh || + # Allow the use of GNU shtool's install command. + case $nonopt in *shtool*) :;; *) false;; esac; then + # Aesthetically quote it. + func_quote_for_eval "$nonopt" + install_prog="$func_quote_for_eval_result " + arg=$1 + shift + else + install_prog= + arg=$nonopt + fi + + # The real first argument should be the name of the installation program. + # Aesthetically quote it. + func_quote_for_eval "$arg" + func_append install_prog "$func_quote_for_eval_result" + install_shared_prog=$install_prog + case " $install_prog " in + *[\\\ /]cp\ *) install_cp=: ;; + *) install_cp=false ;; + esac + + # We need to accept at least all the BSD install flags. + dest= + files= + opts= + prev= + install_type= + isdir=no + stripme= + no_mode=: + for arg + do + arg2= + if test -n "$dest"; then + func_append files " $dest" + dest=$arg + continue + fi + + case $arg in + -d) isdir=yes ;; + -f) + if $install_cp; then :; else + prev=$arg + fi + ;; + -g | -m | -o) + prev=$arg + ;; + -s) + stripme=" -s" + continue + ;; + -*) + ;; + *) + # If the previous option needed an argument, then skip it. + if test -n "$prev"; then + if test "x$prev" = x-m && test -n "$install_override_mode"; then + arg2=$install_override_mode + no_mode=false + fi + prev= + else + dest=$arg + continue + fi + ;; + esac + + # Aesthetically quote the argument. + func_quote_for_eval "$arg" + func_append install_prog " $func_quote_for_eval_result" + if test -n "$arg2"; then + func_quote_for_eval "$arg2" + fi + func_append install_shared_prog " $func_quote_for_eval_result" + done + + test -z "$install_prog" && \ + func_fatal_help "you must specify an install program" + + test -n "$prev" && \ + func_fatal_help "the \`$prev' option requires an argument" + + if test -n "$install_override_mode" && $no_mode; then + if $install_cp; then :; else + func_quote_for_eval "$install_override_mode" + func_append install_shared_prog " -m $func_quote_for_eval_result" + fi + fi + + if test -z "$files"; then + if test -z "$dest"; then + func_fatal_help "no file or destination specified" + else + func_fatal_help "you must specify a destination" + fi + fi + + # Strip any trailing slash from the destination. + func_stripname '' '/' "$dest" + dest=$func_stripname_result + + # Check to see that the destination is a directory. + test -d "$dest" && isdir=yes + if test "$isdir" = yes; then + destdir="$dest" + destname= + else + func_dirname_and_basename "$dest" "" "." + destdir="$func_dirname_result" + destname="$func_basename_result" + + # Not a directory, so check to see that there is only one file specified. + set dummy $files; shift + test "$#" -gt 1 && \ + func_fatal_help "\`$dest' is not a directory" + fi + case $destdir in + [\\/]* | [A-Za-z]:[\\/]*) ;; + *) + for file in $files; do + case $file in + *.lo) ;; + *) + func_fatal_help "\`$destdir' must be an absolute directory name" + ;; + esac + done + ;; + esac + + # This variable tells wrapper scripts just to set variables rather + # than running their programs. + libtool_install_magic="$magic" + + staticlibs= + future_libdirs= + current_libdirs= + for file in $files; do + + # Do each installation. + case $file in + *.$libext) + # Do the static libraries later. + func_append staticlibs " $file" + ;; + + *.la) + func_resolve_sysroot "$file" + file=$func_resolve_sysroot_result + + # Check to see that this really is a libtool archive. + func_lalib_unsafe_p "$file" \ + || func_fatal_help "\`$file' is not a valid libtool archive" + + library_names= + old_library= + relink_command= + func_source "$file" + + # Add the libdir to current_libdirs if it is the destination. + if test "X$destdir" = "X$libdir"; then + case "$current_libdirs " in + *" $libdir "*) ;; + *) func_append current_libdirs " $libdir" ;; + esac + else + # Note the libdir as a future libdir. + case "$future_libdirs " in + *" $libdir "*) ;; + *) func_append future_libdirs " $libdir" ;; + esac + fi + + func_dirname "$file" "/" "" + dir="$func_dirname_result" + func_append dir "$objdir" + + if test -n "$relink_command"; then + # Determine the prefix the user has applied to our future dir. + inst_prefix_dir=`$ECHO "$destdir" | $SED -e "s%$libdir\$%%"` + + # Don't allow the user to place us outside of our expected + # location b/c this prevents finding dependent libraries that + # are installed to the same prefix. + # At present, this check doesn't affect windows .dll's that + # are installed into $libdir/../bin (currently, that works fine) + # but it's something to keep an eye on. + test "$inst_prefix_dir" = "$destdir" && \ + func_fatal_error "error: cannot install \`$file' to a directory not ending in $libdir" + + if test -n "$inst_prefix_dir"; then + # Stick the inst_prefix_dir data into the link command. + relink_command=`$ECHO "$relink_command" | $SED "s%@inst_prefix_dir@%-inst-prefix-dir $inst_prefix_dir%"` + else + relink_command=`$ECHO "$relink_command" | $SED "s%@inst_prefix_dir@%%"` + fi + + func_warning "relinking \`$file'" + func_show_eval "$relink_command" \ + 'func_fatal_error "error: relink \`$file'\'' with the above command before installing it"' + fi + + # See the names of the shared library. + set dummy $library_names; shift + if test -n "$1"; then + realname="$1" + shift + + srcname="$realname" + test -n "$relink_command" && srcname="$realname"T + + # Install the shared library and build the symlinks. + func_show_eval "$install_shared_prog $dir/$srcname $destdir/$realname" \ + 'exit $?' + tstripme="$stripme" + case $host_os in + cygwin* | mingw* | pw32* | cegcc*) + case $realname in + *.dll.a) + tstripme="" + ;; + esac + ;; + esac + if test -n "$tstripme" && test -n "$striplib"; then + func_show_eval "$striplib $destdir/$realname" 'exit $?' + fi + + if test "$#" -gt 0; then + # Delete the old symlinks, and create new ones. + # Try `ln -sf' first, because the `ln' binary might depend on + # the symlink we replace! Solaris /bin/ln does not understand -f, + # so we also need to try rm && ln -s. + for linkname + do + test "$linkname" != "$realname" \ + && func_show_eval "(cd $destdir && { $LN_S -f $realname $linkname || { $RM $linkname && $LN_S $realname $linkname; }; })" + done + fi + + # Do each command in the postinstall commands. + lib="$destdir/$realname" + func_execute_cmds "$postinstall_cmds" 'exit $?' + fi + + # Install the pseudo-library for information purposes. + func_basename "$file" + name="$func_basename_result" + instname="$dir/$name"i + func_show_eval "$install_prog $instname $destdir/$name" 'exit $?' + + # Maybe install the static library, too. + test -n "$old_library" && func_append staticlibs " $dir/$old_library" + ;; + + *.lo) + # Install (i.e. copy) a libtool object. + + # Figure out destination file name, if it wasn't already specified. + if test -n "$destname"; then + destfile="$destdir/$destname" + else + func_basename "$file" + destfile="$func_basename_result" + destfile="$destdir/$destfile" + fi + + # Deduce the name of the destination old-style object file. + case $destfile in + *.lo) + func_lo2o "$destfile" + staticdest=$func_lo2o_result + ;; + *.$objext) + staticdest="$destfile" + destfile= + ;; + *) + func_fatal_help "cannot copy a libtool object to \`$destfile'" + ;; + esac + + # Install the libtool object if requested. + test -n "$destfile" && \ + func_show_eval "$install_prog $file $destfile" 'exit $?' + + # Install the old object if enabled. + if test "$build_old_libs" = yes; then + # Deduce the name of the old-style object file. + func_lo2o "$file" + staticobj=$func_lo2o_result + func_show_eval "$install_prog \$staticobj \$staticdest" 'exit $?' + fi + exit $EXIT_SUCCESS + ;; + + *) + # Figure out destination file name, if it wasn't already specified. + if test -n "$destname"; then + destfile="$destdir/$destname" + else + func_basename "$file" + destfile="$func_basename_result" + destfile="$destdir/$destfile" + fi + + # If the file is missing, and there is a .exe on the end, strip it + # because it is most likely a libtool script we actually want to + # install + stripped_ext="" + case $file in + *.exe) + if test ! -f "$file"; then + func_stripname '' '.exe' "$file" + file=$func_stripname_result + stripped_ext=".exe" + fi + ;; + esac + + # Do a test to see if this is really a libtool program. + case $host in + *cygwin* | *mingw*) + if func_ltwrapper_executable_p "$file"; then + func_ltwrapper_scriptname "$file" + wrapper=$func_ltwrapper_scriptname_result + else + func_stripname '' '.exe' "$file" + wrapper=$func_stripname_result + fi + ;; + *) + wrapper=$file + ;; + esac + if func_ltwrapper_script_p "$wrapper"; then + notinst_deplibs= + relink_command= + + func_source "$wrapper" + + # Check the variables that should have been set. + test -z "$generated_by_libtool_version" && \ + func_fatal_error "invalid libtool wrapper script \`$wrapper'" + + finalize=yes + for lib in $notinst_deplibs; do + # Check to see that each library is installed. + libdir= + if test -f "$lib"; then + func_source "$lib" + fi + libfile="$libdir/"`$ECHO "$lib" | $SED 's%^.*/%%g'` ### testsuite: skip nested quoting test + if test -n "$libdir" && test ! -f "$libfile"; then + func_warning "\`$lib' has not been installed in \`$libdir'" + finalize=no + fi + done + + relink_command= + func_source "$wrapper" + + outputname= + if test "$fast_install" = no && test -n "$relink_command"; then + $opt_dry_run || { + if test "$finalize" = yes; then + tmpdir=`func_mktempdir` + func_basename "$file$stripped_ext" + file="$func_basename_result" + outputname="$tmpdir/$file" + # Replace the output file specification. + relink_command=`$ECHO "$relink_command" | $SED 's%@OUTPUT@%'"$outputname"'%g'` + + $opt_silent || { + func_quote_for_expand "$relink_command" + eval "func_echo $func_quote_for_expand_result" + } + if eval "$relink_command"; then : + else + func_error "error: relink \`$file' with the above command before installing it" + $opt_dry_run || ${RM}r "$tmpdir" + continue + fi + file="$outputname" + else + func_warning "cannot relink \`$file'" + fi + } + else + # Install the binary that we compiled earlier. + file=`$ECHO "$file$stripped_ext" | $SED "s%\([^/]*\)$%$objdir/\1%"` + fi + fi + + # remove .exe since cygwin /usr/bin/install will append another + # one anyway + case $install_prog,$host in + */usr/bin/install*,*cygwin*) + case $file:$destfile in + *.exe:*.exe) + # this is ok + ;; + *.exe:*) + destfile=$destfile.exe + ;; + *:*.exe) + func_stripname '' '.exe' "$destfile" + destfile=$func_stripname_result + ;; + esac + ;; + esac + func_show_eval "$install_prog\$stripme \$file \$destfile" 'exit $?' + $opt_dry_run || if test -n "$outputname"; then + ${RM}r "$tmpdir" + fi + ;; + esac + done + + for file in $staticlibs; do + func_basename "$file" + name="$func_basename_result" + + # Set up the ranlib parameters. + oldlib="$destdir/$name" + func_to_tool_file "$oldlib" func_convert_file_msys_to_w32 + tool_oldlib=$func_to_tool_file_result + + func_show_eval "$install_prog \$file \$oldlib" 'exit $?' + + if test -n "$stripme" && test -n "$old_striplib"; then + func_show_eval "$old_striplib $tool_oldlib" 'exit $?' + fi + + # Do each command in the postinstall commands. + func_execute_cmds "$old_postinstall_cmds" 'exit $?' + done + + test -n "$future_libdirs" && \ + func_warning "remember to run \`$progname --finish$future_libdirs'" + + if test -n "$current_libdirs"; then + # Maybe just do a dry run. + $opt_dry_run && current_libdirs=" -n$current_libdirs" + exec_cmd='$SHELL $progpath $preserve_args --finish$current_libdirs' + else + exit $EXIT_SUCCESS + fi +} + +test "$opt_mode" = install && func_mode_install ${1+"$@"} + + +# func_generate_dlsyms outputname originator pic_p +# Extract symbols from dlprefiles and create ${outputname}S.o with +# a dlpreopen symbol table. +func_generate_dlsyms () +{ + $opt_debug + my_outputname="$1" + my_originator="$2" + my_pic_p="${3-no}" + my_prefix=`$ECHO "$my_originator" | sed 's%[^a-zA-Z0-9]%_%g'` + my_dlsyms= + + if test -n "$dlfiles$dlprefiles" || test "$dlself" != no; then + if test -n "$NM" && test -n "$global_symbol_pipe"; then + my_dlsyms="${my_outputname}S.c" + else + func_error "not configured to extract global symbols from dlpreopened files" + fi + fi + + if test -n "$my_dlsyms"; then + case $my_dlsyms in + "") ;; + *.c) + # Discover the nlist of each of the dlfiles. + nlist="$output_objdir/${my_outputname}.nm" + + func_show_eval "$RM $nlist ${nlist}S ${nlist}T" + + # Parse the name list into a source file. + func_verbose "creating $output_objdir/$my_dlsyms" + + $opt_dry_run || $ECHO > "$output_objdir/$my_dlsyms" "\ +/* $my_dlsyms - symbol resolution table for \`$my_outputname' dlsym emulation. */ +/* Generated by $PROGRAM (GNU $PACKAGE$TIMESTAMP) $VERSION */ + +#ifdef __cplusplus +extern \"C\" { +#endif + +#if defined(__GNUC__) && (((__GNUC__ == 4) && (__GNUC_MINOR__ >= 4)) || (__GNUC__ > 4)) +#pragma GCC diagnostic ignored \"-Wstrict-prototypes\" +#endif + +/* Keep this code in sync between libtool.m4, ltmain, lt_system.h, and tests. */ +#if defined(_WIN32) || defined(__CYGWIN__) || defined(_WIN32_WCE) +/* DATA imports from DLLs on WIN32 con't be const, because runtime + relocations are performed -- see ld's documentation on pseudo-relocs. */ +# define LT_DLSYM_CONST +#elif defined(__osf__) +/* This system does not cope well with relocations in const data. */ +# define LT_DLSYM_CONST +#else +# define LT_DLSYM_CONST const +#endif + +/* External symbol declarations for the compiler. */\ +" + + if test "$dlself" = yes; then + func_verbose "generating symbol list for \`$output'" + + $opt_dry_run || echo ': @PROGRAM@ ' > "$nlist" + + # Add our own program objects to the symbol list. + progfiles=`$ECHO "$objs$old_deplibs" | $SP2NL | $SED "$lo2o" | $NL2SP` + for progfile in $progfiles; do + func_to_tool_file "$progfile" func_convert_file_msys_to_w32 + func_verbose "extracting global C symbols from \`$func_to_tool_file_result'" + $opt_dry_run || eval "$NM $func_to_tool_file_result | $global_symbol_pipe >> '$nlist'" + done + + if test -n "$exclude_expsyms"; then + $opt_dry_run || { + eval '$EGREP -v " ($exclude_expsyms)$" "$nlist" > "$nlist"T' + eval '$MV "$nlist"T "$nlist"' + } + fi + + if test -n "$export_symbols_regex"; then + $opt_dry_run || { + eval '$EGREP -e "$export_symbols_regex" "$nlist" > "$nlist"T' + eval '$MV "$nlist"T "$nlist"' + } + fi + + # Prepare the list of exported symbols + if test -z "$export_symbols"; then + export_symbols="$output_objdir/$outputname.exp" + $opt_dry_run || { + $RM $export_symbols + eval "${SED} -n -e '/^: @PROGRAM@ $/d' -e 's/^.* \(.*\)$/\1/p' "'< "$nlist" > "$export_symbols"' + case $host in + *cygwin* | *mingw* | *cegcc* ) + eval "echo EXPORTS "'> "$output_objdir/$outputname.def"' + eval 'cat "$export_symbols" >> "$output_objdir/$outputname.def"' + ;; + esac + } + else + $opt_dry_run || { + eval "${SED} -e 's/\([].[*^$]\)/\\\\\1/g' -e 's/^/ /' -e 's/$/$/'"' < "$export_symbols" > "$output_objdir/$outputname.exp"' + eval '$GREP -f "$output_objdir/$outputname.exp" < "$nlist" > "$nlist"T' + eval '$MV "$nlist"T "$nlist"' + case $host in + *cygwin* | *mingw* | *cegcc* ) + eval "echo EXPORTS "'> "$output_objdir/$outputname.def"' + eval 'cat "$nlist" >> "$output_objdir/$outputname.def"' + ;; + esac + } + fi + fi + + for dlprefile in $dlprefiles; do + func_verbose "extracting global C symbols from \`$dlprefile'" + func_basename "$dlprefile" + name="$func_basename_result" + case $host in + *cygwin* | *mingw* | *cegcc* ) + # if an import library, we need to obtain dlname + if func_win32_import_lib_p "$dlprefile"; then + func_tr_sh "$dlprefile" + eval "curr_lafile=\$libfile_$func_tr_sh_result" + dlprefile_dlbasename="" + if test -n "$curr_lafile" && func_lalib_p "$curr_lafile"; then + # Use subshell, to avoid clobbering current variable values + dlprefile_dlname=`source "$curr_lafile" && echo "$dlname"` + if test -n "$dlprefile_dlname" ; then + func_basename "$dlprefile_dlname" + dlprefile_dlbasename="$func_basename_result" + else + # no lafile. user explicitly requested -dlpreopen . + $sharedlib_from_linklib_cmd "$dlprefile" + dlprefile_dlbasename=$sharedlib_from_linklib_result + fi + fi + $opt_dry_run || { + if test -n "$dlprefile_dlbasename" ; then + eval '$ECHO ": $dlprefile_dlbasename" >> "$nlist"' + else + func_warning "Could not compute DLL name from $name" + eval '$ECHO ": $name " >> "$nlist"' + fi + func_to_tool_file "$dlprefile" func_convert_file_msys_to_w32 + eval "$NM \"$func_to_tool_file_result\" 2>/dev/null | $global_symbol_pipe | + $SED -e '/I __imp/d' -e 's/I __nm_/D /;s/_nm__//' >> '$nlist'" + } + else # not an import lib + $opt_dry_run || { + eval '$ECHO ": $name " >> "$nlist"' + func_to_tool_file "$dlprefile" func_convert_file_msys_to_w32 + eval "$NM \"$func_to_tool_file_result\" 2>/dev/null | $global_symbol_pipe >> '$nlist'" + } + fi + ;; + *) + $opt_dry_run || { + eval '$ECHO ": $name " >> "$nlist"' + func_to_tool_file "$dlprefile" func_convert_file_msys_to_w32 + eval "$NM \"$func_to_tool_file_result\" 2>/dev/null | $global_symbol_pipe >> '$nlist'" + } + ;; + esac + done + + $opt_dry_run || { + # Make sure we have at least an empty file. + test -f "$nlist" || : > "$nlist" + + if test -n "$exclude_expsyms"; then + $EGREP -v " ($exclude_expsyms)$" "$nlist" > "$nlist"T + $MV "$nlist"T "$nlist" + fi + + # Try sorting and uniquifying the output. + if $GREP -v "^: " < "$nlist" | + if sort -k 3 /dev/null 2>&1; then + sort -k 3 + else + sort +2 + fi | + uniq > "$nlist"S; then + : + else + $GREP -v "^: " < "$nlist" > "$nlist"S + fi + + if test -f "$nlist"S; then + eval "$global_symbol_to_cdecl"' < "$nlist"S >> "$output_objdir/$my_dlsyms"' + else + echo '/* NONE */' >> "$output_objdir/$my_dlsyms" + fi + + echo >> "$output_objdir/$my_dlsyms" "\ + +/* The mapping between symbol names and symbols. */ +typedef struct { + const char *name; + void *address; +} lt_dlsymlist; +extern LT_DLSYM_CONST lt_dlsymlist +lt_${my_prefix}_LTX_preloaded_symbols[]; +LT_DLSYM_CONST lt_dlsymlist +lt_${my_prefix}_LTX_preloaded_symbols[] = +{\ + { \"$my_originator\", (void *) 0 }," + + case $need_lib_prefix in + no) + eval "$global_symbol_to_c_name_address" < "$nlist" >> "$output_objdir/$my_dlsyms" + ;; + *) + eval "$global_symbol_to_c_name_address_lib_prefix" < "$nlist" >> "$output_objdir/$my_dlsyms" + ;; + esac + echo >> "$output_objdir/$my_dlsyms" "\ + {0, (void *) 0} +}; + +/* This works around a problem in FreeBSD linker */ +#ifdef FREEBSD_WORKAROUND +static const void *lt_preloaded_setup() { + return lt_${my_prefix}_LTX_preloaded_symbols; +} +#endif + +#ifdef __cplusplus +} +#endif\ +" + } # !$opt_dry_run + + pic_flag_for_symtable= + case "$compile_command " in + *" -static "*) ;; + *) + case $host in + # compiling the symbol table file with pic_flag works around + # a FreeBSD bug that causes programs to crash when -lm is + # linked before any other PIC object. But we must not use + # pic_flag when linking with -static. The problem exists in + # FreeBSD 2.2.6 and is fixed in FreeBSD 3.1. + *-*-freebsd2.*|*-*-freebsd3.0*|*-*-freebsdelf3.0*) + pic_flag_for_symtable=" $pic_flag -DFREEBSD_WORKAROUND" ;; + *-*-hpux*) + pic_flag_for_symtable=" $pic_flag" ;; + *) + if test "X$my_pic_p" != Xno; then + pic_flag_for_symtable=" $pic_flag" + fi + ;; + esac + ;; + esac + symtab_cflags= + for arg in $LTCFLAGS; do + case $arg in + -pie | -fpie | -fPIE) ;; + *) func_append symtab_cflags " $arg" ;; + esac + done + + # Now compile the dynamic symbol file. + func_show_eval '(cd $output_objdir && $LTCC$symtab_cflags -c$no_builtin_flag$pic_flag_for_symtable "$my_dlsyms")' 'exit $?' + + # Clean up the generated files. + func_show_eval '$RM "$output_objdir/$my_dlsyms" "$nlist" "${nlist}S" "${nlist}T"' + + # Transform the symbol file into the correct name. + symfileobj="$output_objdir/${my_outputname}S.$objext" + case $host in + *cygwin* | *mingw* | *cegcc* ) + if test -f "$output_objdir/$my_outputname.def"; then + compile_command=`$ECHO "$compile_command" | $SED "s%@SYMFILE@%$output_objdir/$my_outputname.def $symfileobj%"` + finalize_command=`$ECHO "$finalize_command" | $SED "s%@SYMFILE@%$output_objdir/$my_outputname.def $symfileobj%"` + else + compile_command=`$ECHO "$compile_command" | $SED "s%@SYMFILE@%$symfileobj%"` + finalize_command=`$ECHO "$finalize_command" | $SED "s%@SYMFILE@%$symfileobj%"` + fi + ;; + *) + compile_command=`$ECHO "$compile_command" | $SED "s%@SYMFILE@%$symfileobj%"` + finalize_command=`$ECHO "$finalize_command" | $SED "s%@SYMFILE@%$symfileobj%"` + ;; + esac + ;; + *) + func_fatal_error "unknown suffix for \`$my_dlsyms'" + ;; + esac + else + # We keep going just in case the user didn't refer to + # lt_preloaded_symbols. The linker will fail if global_symbol_pipe + # really was required. + + # Nullify the symbol file. + compile_command=`$ECHO "$compile_command" | $SED "s% @SYMFILE@%%"` + finalize_command=`$ECHO "$finalize_command" | $SED "s% @SYMFILE@%%"` + fi +} + +# func_win32_libid arg +# return the library type of file 'arg' +# +# Need a lot of goo to handle *both* DLLs and import libs +# Has to be a shell function in order to 'eat' the argument +# that is supplied when $file_magic_command is called. +# Despite the name, also deal with 64 bit binaries. +func_win32_libid () +{ + $opt_debug + win32_libid_type="unknown" + win32_fileres=`file -L $1 2>/dev/null` + case $win32_fileres in + *ar\ archive\ import\ library*) # definitely import + win32_libid_type="x86 archive import" + ;; + *ar\ archive*) # could be an import, or static + # Keep the egrep pattern in sync with the one in _LT_CHECK_MAGIC_METHOD. + if eval $OBJDUMP -f $1 | $SED -e '10q' 2>/dev/null | + $EGREP 'file format (pei*-i386(.*architecture: i386)?|pe-arm-wince|pe-x86-64)' >/dev/null; then + func_to_tool_file "$1" func_convert_file_msys_to_w32 + win32_nmres=`eval $NM -f posix -A \"$func_to_tool_file_result\" | + $SED -n -e ' + 1,100{ + / I /{ + s,.*,import, + p + q + } + }'` + case $win32_nmres in + import*) win32_libid_type="x86 archive import";; + *) win32_libid_type="x86 archive static";; + esac + fi + ;; + *DLL*) + win32_libid_type="x86 DLL" + ;; + *executable*) # but shell scripts are "executable" too... + case $win32_fileres in + *MS\ Windows\ PE\ Intel*) + win32_libid_type="x86 DLL" + ;; + esac + ;; + esac + $ECHO "$win32_libid_type" +} + +# func_cygming_dll_for_implib ARG +# +# Platform-specific function to extract the +# name of the DLL associated with the specified +# import library ARG. +# Invoked by eval'ing the libtool variable +# $sharedlib_from_linklib_cmd +# Result is available in the variable +# $sharedlib_from_linklib_result +func_cygming_dll_for_implib () +{ + $opt_debug + sharedlib_from_linklib_result=`$DLLTOOL --identify-strict --identify "$1"` +} + +# func_cygming_dll_for_implib_fallback_core SECTION_NAME LIBNAMEs +# +# The is the core of a fallback implementation of a +# platform-specific function to extract the name of the +# DLL associated with the specified import library LIBNAME. +# +# SECTION_NAME is either .idata$6 or .idata$7, depending +# on the platform and compiler that created the implib. +# +# Echos the name of the DLL associated with the +# specified import library. +func_cygming_dll_for_implib_fallback_core () +{ + $opt_debug + match_literal=`$ECHO "$1" | $SED "$sed_make_literal_regex"` + $OBJDUMP -s --section "$1" "$2" 2>/dev/null | + $SED '/^Contents of section '"$match_literal"':/{ + # Place marker at beginning of archive member dllname section + s/.*/====MARK====/ + p + d + } + # These lines can sometimes be longer than 43 characters, but + # are always uninteresting + /:[ ]*file format pe[i]\{,1\}-/d + /^In archive [^:]*:/d + # Ensure marker is printed + /^====MARK====/p + # Remove all lines with less than 43 characters + /^.\{43\}/!d + # From remaining lines, remove first 43 characters + s/^.\{43\}//' | + $SED -n ' + # Join marker and all lines until next marker into a single line + /^====MARK====/ b para + H + $ b para + b + :para + x + s/\n//g + # Remove the marker + s/^====MARK====// + # Remove trailing dots and whitespace + s/[\. \t]*$// + # Print + /./p' | + # we now have a list, one entry per line, of the stringified + # contents of the appropriate section of all members of the + # archive which possess that section. Heuristic: eliminate + # all those which have a first or second character that is + # a '.' (that is, objdump's representation of an unprintable + # character.) This should work for all archives with less than + # 0x302f exports -- but will fail for DLLs whose name actually + # begins with a literal '.' or a single character followed by + # a '.'. + # + # Of those that remain, print the first one. + $SED -e '/^\./d;/^.\./d;q' +} + +# func_cygming_gnu_implib_p ARG +# This predicate returns with zero status (TRUE) if +# ARG is a GNU/binutils-style import library. Returns +# with nonzero status (FALSE) otherwise. +func_cygming_gnu_implib_p () +{ + $opt_debug + func_to_tool_file "$1" func_convert_file_msys_to_w32 + func_cygming_gnu_implib_tmp=`$NM "$func_to_tool_file_result" | eval "$global_symbol_pipe" | $EGREP ' (_head_[A-Za-z0-9_]+_[ad]l*|[A-Za-z0-9_]+_[ad]l*_iname)$'` + test -n "$func_cygming_gnu_implib_tmp" +} + +# func_cygming_ms_implib_p ARG +# This predicate returns with zero status (TRUE) if +# ARG is an MS-style import library. Returns +# with nonzero status (FALSE) otherwise. +func_cygming_ms_implib_p () +{ + $opt_debug + func_to_tool_file "$1" func_convert_file_msys_to_w32 + func_cygming_ms_implib_tmp=`$NM "$func_to_tool_file_result" | eval "$global_symbol_pipe" | $GREP '_NULL_IMPORT_DESCRIPTOR'` + test -n "$func_cygming_ms_implib_tmp" +} + +# func_cygming_dll_for_implib_fallback ARG +# Platform-specific function to extract the +# name of the DLL associated with the specified +# import library ARG. +# +# This fallback implementation is for use when $DLLTOOL +# does not support the --identify-strict option. +# Invoked by eval'ing the libtool variable +# $sharedlib_from_linklib_cmd +# Result is available in the variable +# $sharedlib_from_linklib_result +func_cygming_dll_for_implib_fallback () +{ + $opt_debug + if func_cygming_gnu_implib_p "$1" ; then + # binutils import library + sharedlib_from_linklib_result=`func_cygming_dll_for_implib_fallback_core '.idata$7' "$1"` + elif func_cygming_ms_implib_p "$1" ; then + # ms-generated import library + sharedlib_from_linklib_result=`func_cygming_dll_for_implib_fallback_core '.idata$6' "$1"` + else + # unknown + sharedlib_from_linklib_result="" + fi +} + + +# func_extract_an_archive dir oldlib +func_extract_an_archive () +{ + $opt_debug + f_ex_an_ar_dir="$1"; shift + f_ex_an_ar_oldlib="$1" + if test "$lock_old_archive_extraction" = yes; then + lockfile=$f_ex_an_ar_oldlib.lock + until $opt_dry_run || ln "$progpath" "$lockfile" 2>/dev/null; do + func_echo "Waiting for $lockfile to be removed" + sleep 2 + done + fi + func_show_eval "(cd \$f_ex_an_ar_dir && $AR x \"\$f_ex_an_ar_oldlib\")" \ + 'stat=$?; rm -f "$lockfile"; exit $stat' + if test "$lock_old_archive_extraction" = yes; then + $opt_dry_run || rm -f "$lockfile" + fi + if ($AR t "$f_ex_an_ar_oldlib" | sort | sort -uc >/dev/null 2>&1); then + : + else + func_fatal_error "object name conflicts in archive: $f_ex_an_ar_dir/$f_ex_an_ar_oldlib" + fi +} + + +# func_extract_archives gentop oldlib ... +func_extract_archives () +{ + $opt_debug + my_gentop="$1"; shift + my_oldlibs=${1+"$@"} + my_oldobjs="" + my_xlib="" + my_xabs="" + my_xdir="" + + for my_xlib in $my_oldlibs; do + # Extract the objects. + case $my_xlib in + [\\/]* | [A-Za-z]:[\\/]*) my_xabs="$my_xlib" ;; + *) my_xabs=`pwd`"/$my_xlib" ;; + esac + func_basename "$my_xlib" + my_xlib="$func_basename_result" + my_xlib_u=$my_xlib + while :; do + case " $extracted_archives " in + *" $my_xlib_u "*) + func_arith $extracted_serial + 1 + extracted_serial=$func_arith_result + my_xlib_u=lt$extracted_serial-$my_xlib ;; + *) break ;; + esac + done + extracted_archives="$extracted_archives $my_xlib_u" + my_xdir="$my_gentop/$my_xlib_u" + + func_mkdir_p "$my_xdir" + + case $host in + *-darwin*) + func_verbose "Extracting $my_xabs" + # Do not bother doing anything if just a dry run + $opt_dry_run || { + darwin_orig_dir=`pwd` + cd $my_xdir || exit $? + darwin_archive=$my_xabs + darwin_curdir=`pwd` + darwin_base_archive=`basename "$darwin_archive"` + darwin_arches=`$LIPO -info "$darwin_archive" 2>/dev/null | $GREP Architectures 2>/dev/null || true` + if test -n "$darwin_arches"; then + darwin_arches=`$ECHO "$darwin_arches" | $SED -e 's/.*are://'` + darwin_arch= + func_verbose "$darwin_base_archive has multiple architectures $darwin_arches" + for darwin_arch in $darwin_arches ; do + func_mkdir_p "unfat-$$/${darwin_base_archive}-${darwin_arch}" + $LIPO -thin $darwin_arch -output "unfat-$$/${darwin_base_archive}-${darwin_arch}/${darwin_base_archive}" "${darwin_archive}" + cd "unfat-$$/${darwin_base_archive}-${darwin_arch}" + func_extract_an_archive "`pwd`" "${darwin_base_archive}" + cd "$darwin_curdir" + $RM "unfat-$$/${darwin_base_archive}-${darwin_arch}/${darwin_base_archive}" + done # $darwin_arches + ## Okay now we've a bunch of thin objects, gotta fatten them up :) + darwin_filelist=`find unfat-$$ -type f -name \*.o -print -o -name \*.lo -print | $SED -e "$basename" | sort -u` + darwin_file= + darwin_files= + for darwin_file in $darwin_filelist; do + darwin_files=`find unfat-$$ -name $darwin_file -print | sort | $NL2SP` + $LIPO -create -output "$darwin_file" $darwin_files + done # $darwin_filelist + $RM -rf unfat-$$ + cd "$darwin_orig_dir" + else + cd $darwin_orig_dir + func_extract_an_archive "$my_xdir" "$my_xabs" + fi # $darwin_arches + } # !$opt_dry_run + ;; + *) + func_extract_an_archive "$my_xdir" "$my_xabs" + ;; + esac + my_oldobjs="$my_oldobjs "`find $my_xdir -name \*.$objext -print -o -name \*.lo -print | sort | $NL2SP` + done + + func_extract_archives_result="$my_oldobjs" +} + + +# func_emit_wrapper [arg=no] +# +# Emit a libtool wrapper script on stdout. +# Don't directly open a file because we may want to +# incorporate the script contents within a cygwin/mingw +# wrapper executable. Must ONLY be called from within +# func_mode_link because it depends on a number of variables +# set therein. +# +# ARG is the value that the WRAPPER_SCRIPT_BELONGS_IN_OBJDIR +# variable will take. If 'yes', then the emitted script +# will assume that the directory in which it is stored is +# the $objdir directory. This is a cygwin/mingw-specific +# behavior. +func_emit_wrapper () +{ + func_emit_wrapper_arg1=${1-no} + + $ECHO "\ +#! $SHELL + +# $output - temporary wrapper script for $objdir/$outputname +# Generated by $PROGRAM (GNU $PACKAGE$TIMESTAMP) $VERSION +# +# The $output program cannot be directly executed until all the libtool +# libraries that it depends on are installed. +# +# This wrapper script should never be moved out of the build directory. +# If it is, it will not operate correctly. + +# Sed substitution that helps us do robust quoting. It backslashifies +# metacharacters that are still active within double-quoted strings. +sed_quote_subst='$sed_quote_subst' + +# Be Bourne compatible +if test -n \"\${ZSH_VERSION+set}\" && (emulate sh) >/dev/null 2>&1; then + emulate sh + NULLCMD=: + # Zsh 3.x and 4.x performs word splitting on \${1+\"\$@\"}, which + # is contrary to our usage. Disable this feature. + alias -g '\${1+\"\$@\"}'='\"\$@\"' + setopt NO_GLOB_SUBST +else + case \`(set -o) 2>/dev/null\` in *posix*) set -o posix;; esac +fi +BIN_SH=xpg4; export BIN_SH # for Tru64 +DUALCASE=1; export DUALCASE # for MKS sh + +# The HP-UX ksh and POSIX shell print the target directory to stdout +# if CDPATH is set. +(unset CDPATH) >/dev/null 2>&1 && unset CDPATH + +relink_command=\"$relink_command\" + +# This environment variable determines our operation mode. +if test \"\$libtool_install_magic\" = \"$magic\"; then + # install mode needs the following variables: + generated_by_libtool_version='$macro_version' + notinst_deplibs='$notinst_deplibs' +else + # When we are sourced in execute mode, \$file and \$ECHO are already set. + if test \"\$libtool_execute_magic\" != \"$magic\"; then + file=\"\$0\"" + + qECHO=`$ECHO "$ECHO" | $SED "$sed_quote_subst"` + $ECHO "\ + +# A function that is used when there is no print builtin or printf. +func_fallback_echo () +{ + eval 'cat <<_LTECHO_EOF +\$1 +_LTECHO_EOF' +} + ECHO=\"$qECHO\" + fi + +# Very basic option parsing. These options are (a) specific to +# the libtool wrapper, (b) are identical between the wrapper +# /script/ and the wrapper /executable/ which is used only on +# windows platforms, and (c) all begin with the string "--lt-" +# (application programs are unlikely to have options which match +# this pattern). +# +# There are only two supported options: --lt-debug and +# --lt-dump-script. There is, deliberately, no --lt-help. +# +# The first argument to this parsing function should be the +# script's $0 value, followed by "$@". +lt_option_debug= +func_parse_lt_options () +{ + lt_script_arg0=\$0 + shift + for lt_opt + do + case \"\$lt_opt\" in + --lt-debug) lt_option_debug=1 ;; + --lt-dump-script) + lt_dump_D=\`\$ECHO \"X\$lt_script_arg0\" | $SED -e 's/^X//' -e 's%/[^/]*$%%'\` + test \"X\$lt_dump_D\" = \"X\$lt_script_arg0\" && lt_dump_D=. + lt_dump_F=\`\$ECHO \"X\$lt_script_arg0\" | $SED -e 's/^X//' -e 's%^.*/%%'\` + cat \"\$lt_dump_D/\$lt_dump_F\" + exit 0 + ;; + --lt-*) + \$ECHO \"Unrecognized --lt- option: '\$lt_opt'\" 1>&2 + exit 1 + ;; + esac + done + + # Print the debug banner immediately: + if test -n \"\$lt_option_debug\"; then + echo \"${outputname}:${output}:\${LINENO}: libtool wrapper (GNU $PACKAGE$TIMESTAMP) $VERSION\" 1>&2 + fi +} + +# Used when --lt-debug. Prints its arguments to stdout +# (redirection is the responsibility of the caller) +func_lt_dump_args () +{ + lt_dump_args_N=1; + for lt_arg + do + \$ECHO \"${outputname}:${output}:\${LINENO}: newargv[\$lt_dump_args_N]: \$lt_arg\" + lt_dump_args_N=\`expr \$lt_dump_args_N + 1\` + done +} + +# Core function for launching the target application +func_exec_program_core () +{ +" + case $host in + # Backslashes separate directories on plain windows + *-*-mingw | *-*-os2* | *-cegcc*) + $ECHO "\ + if test -n \"\$lt_option_debug\"; then + \$ECHO \"${outputname}:${output}:\${LINENO}: newargv[0]: \$progdir\\\\\$program\" 1>&2 + func_lt_dump_args \${1+\"\$@\"} 1>&2 + fi + exec \"\$progdir\\\\\$program\" \${1+\"\$@\"} +" + ;; + + *) + $ECHO "\ + if test -n \"\$lt_option_debug\"; then + \$ECHO \"${outputname}:${output}:\${LINENO}: newargv[0]: \$progdir/\$program\" 1>&2 + func_lt_dump_args \${1+\"\$@\"} 1>&2 + fi + exec \"\$progdir/\$program\" \${1+\"\$@\"} +" + ;; + esac + $ECHO "\ + \$ECHO \"\$0: cannot exec \$program \$*\" 1>&2 + exit 1 +} + +# A function to encapsulate launching the target application +# Strips options in the --lt-* namespace from \$@ and +# launches target application with the remaining arguments. +func_exec_program () +{ + case \" \$* \" in + *\\ --lt-*) + for lt_wr_arg + do + case \$lt_wr_arg in + --lt-*) ;; + *) set x \"\$@\" \"\$lt_wr_arg\"; shift;; + esac + shift + done ;; + esac + func_exec_program_core \${1+\"\$@\"} +} + + # Parse options + func_parse_lt_options \"\$0\" \${1+\"\$@\"} + + # Find the directory that this script lives in. + thisdir=\`\$ECHO \"\$file\" | $SED 's%/[^/]*$%%'\` + test \"x\$thisdir\" = \"x\$file\" && thisdir=. + + # Follow symbolic links until we get to the real thisdir. + file=\`ls -ld \"\$file\" | $SED -n 's/.*-> //p'\` + while test -n \"\$file\"; do + destdir=\`\$ECHO \"\$file\" | $SED 's%/[^/]*\$%%'\` + + # If there was a directory component, then change thisdir. + if test \"x\$destdir\" != \"x\$file\"; then + case \"\$destdir\" in + [\\\\/]* | [A-Za-z]:[\\\\/]*) thisdir=\"\$destdir\" ;; + *) thisdir=\"\$thisdir/\$destdir\" ;; + esac + fi + + file=\`\$ECHO \"\$file\" | $SED 's%^.*/%%'\` + file=\`ls -ld \"\$thisdir/\$file\" | $SED -n 's/.*-> //p'\` + done + + # Usually 'no', except on cygwin/mingw when embedded into + # the cwrapper. + WRAPPER_SCRIPT_BELONGS_IN_OBJDIR=$func_emit_wrapper_arg1 + if test \"\$WRAPPER_SCRIPT_BELONGS_IN_OBJDIR\" = \"yes\"; then + # special case for '.' + if test \"\$thisdir\" = \".\"; then + thisdir=\`pwd\` + fi + # remove .libs from thisdir + case \"\$thisdir\" in + *[\\\\/]$objdir ) thisdir=\`\$ECHO \"\$thisdir\" | $SED 's%[\\\\/][^\\\\/]*$%%'\` ;; + $objdir ) thisdir=. ;; + esac + fi + + # Try to get the absolute directory name. + absdir=\`cd \"\$thisdir\" && pwd\` + test -n \"\$absdir\" && thisdir=\"\$absdir\" +" + + if test "$fast_install" = yes; then + $ECHO "\ + program=lt-'$outputname'$exeext + progdir=\"\$thisdir/$objdir\" + + if test ! -f \"\$progdir/\$program\" || + { file=\`ls -1dt \"\$progdir/\$program\" \"\$progdir/../\$program\" 2>/dev/null | ${SED} 1q\`; \\ + test \"X\$file\" != \"X\$progdir/\$program\"; }; then + + file=\"\$\$-\$program\" + + if test ! -d \"\$progdir\"; then + $MKDIR \"\$progdir\" + else + $RM \"\$progdir/\$file\" + fi" + + $ECHO "\ + + # relink executable if necessary + if test -n \"\$relink_command\"; then + if relink_command_output=\`eval \$relink_command 2>&1\`; then : + else + $ECHO \"\$relink_command_output\" >&2 + $RM \"\$progdir/\$file\" + exit 1 + fi + fi + + $MV \"\$progdir/\$file\" \"\$progdir/\$program\" 2>/dev/null || + { $RM \"\$progdir/\$program\"; + $MV \"\$progdir/\$file\" \"\$progdir/\$program\"; } + $RM \"\$progdir/\$file\" + fi" + else + $ECHO "\ + program='$outputname' + progdir=\"\$thisdir/$objdir\" +" + fi + + $ECHO "\ + + if test -f \"\$progdir/\$program\"; then" + + # fixup the dll searchpath if we need to. + # + # Fix the DLL searchpath if we need to. Do this before prepending + # to shlibpath, because on Windows, both are PATH and uninstalled + # libraries must come first. + if test -n "$dllsearchpath"; then + $ECHO "\ + # Add the dll search path components to the executable PATH + PATH=$dllsearchpath:\$PATH +" + fi + + # Export our shlibpath_var if we have one. + if test "$shlibpath_overrides_runpath" = yes && test -n "$shlibpath_var" && test -n "$temp_rpath"; then + $ECHO "\ + # Add our own library path to $shlibpath_var + $shlibpath_var=\"$temp_rpath\$$shlibpath_var\" + + # Some systems cannot cope with colon-terminated $shlibpath_var + # The second colon is a workaround for a bug in BeOS R4 sed + $shlibpath_var=\`\$ECHO \"\$$shlibpath_var\" | $SED 's/::*\$//'\` + + export $shlibpath_var +" + fi + + $ECHO "\ + if test \"\$libtool_execute_magic\" != \"$magic\"; then + # Run the actual program with our arguments. + func_exec_program \${1+\"\$@\"} + fi + else + # The program doesn't exist. + \$ECHO \"\$0: error: \\\`\$progdir/\$program' does not exist\" 1>&2 + \$ECHO \"This script is just a wrapper for \$program.\" 1>&2 + \$ECHO \"See the $PACKAGE documentation for more information.\" 1>&2 + exit 1 + fi +fi\ +" +} + + +# func_emit_cwrapperexe_src +# emit the source code for a wrapper executable on stdout +# Must ONLY be called from within func_mode_link because +# it depends on a number of variable set therein. +func_emit_cwrapperexe_src () +{ + cat < +#include +#ifdef _MSC_VER +# include +# include +# include +#else +# include +# include +# ifdef __CYGWIN__ +# include +# endif +#endif +#include +#include +#include +#include +#include +#include +#include +#include + +/* declarations of non-ANSI functions */ +#if defined(__MINGW32__) +# ifdef __STRICT_ANSI__ +int _putenv (const char *); +# endif +#elif defined(__CYGWIN__) +# ifdef __STRICT_ANSI__ +char *realpath (const char *, char *); +int putenv (char *); +int setenv (const char *, const char *, int); +# endif +/* #elif defined (other platforms) ... */ +#endif + +/* portability defines, excluding path handling macros */ +#if defined(_MSC_VER) +# define setmode _setmode +# define stat _stat +# define chmod _chmod +# define getcwd _getcwd +# define putenv _putenv +# define S_IXUSR _S_IEXEC +# ifndef _INTPTR_T_DEFINED +# define _INTPTR_T_DEFINED +# define intptr_t int +# endif +#elif defined(__MINGW32__) +# define setmode _setmode +# define stat _stat +# define chmod _chmod +# define getcwd _getcwd +# define putenv _putenv +#elif defined(__CYGWIN__) +# define HAVE_SETENV +# define FOPEN_WB "wb" +/* #elif defined (other platforms) ... */ +#endif + +#if defined(PATH_MAX) +# define LT_PATHMAX PATH_MAX +#elif defined(MAXPATHLEN) +# define LT_PATHMAX MAXPATHLEN +#else +# define LT_PATHMAX 1024 +#endif + +#ifndef S_IXOTH +# define S_IXOTH 0 +#endif +#ifndef S_IXGRP +# define S_IXGRP 0 +#endif + +/* path handling portability macros */ +#ifndef DIR_SEPARATOR +# define DIR_SEPARATOR '/' +# define PATH_SEPARATOR ':' +#endif + +#if defined (_WIN32) || defined (__MSDOS__) || defined (__DJGPP__) || \ + defined (__OS2__) +# define HAVE_DOS_BASED_FILE_SYSTEM +# define FOPEN_WB "wb" +# ifndef DIR_SEPARATOR_2 +# define DIR_SEPARATOR_2 '\\' +# endif +# ifndef PATH_SEPARATOR_2 +# define PATH_SEPARATOR_2 ';' +# endif +#endif + +#ifndef DIR_SEPARATOR_2 +# define IS_DIR_SEPARATOR(ch) ((ch) == DIR_SEPARATOR) +#else /* DIR_SEPARATOR_2 */ +# define IS_DIR_SEPARATOR(ch) \ + (((ch) == DIR_SEPARATOR) || ((ch) == DIR_SEPARATOR_2)) +#endif /* DIR_SEPARATOR_2 */ + +#ifndef PATH_SEPARATOR_2 +# define IS_PATH_SEPARATOR(ch) ((ch) == PATH_SEPARATOR) +#else /* PATH_SEPARATOR_2 */ +# define IS_PATH_SEPARATOR(ch) ((ch) == PATH_SEPARATOR_2) +#endif /* PATH_SEPARATOR_2 */ + +#ifndef FOPEN_WB +# define FOPEN_WB "w" +#endif +#ifndef _O_BINARY +# define _O_BINARY 0 +#endif + +#define XMALLOC(type, num) ((type *) xmalloc ((num) * sizeof(type))) +#define XFREE(stale) do { \ + if (stale) { free ((void *) stale); stale = 0; } \ +} while (0) + +#if defined(LT_DEBUGWRAPPER) +static int lt_debug = 1; +#else +static int lt_debug = 0; +#endif + +const char *program_name = "libtool-wrapper"; /* in case xstrdup fails */ + +void *xmalloc (size_t num); +char *xstrdup (const char *string); +const char *base_name (const char *name); +char *find_executable (const char *wrapper); +char *chase_symlinks (const char *pathspec); +int make_executable (const char *path); +int check_executable (const char *path); +char *strendzap (char *str, const char *pat); +void lt_debugprintf (const char *file, int line, const char *fmt, ...); +void lt_fatal (const char *file, int line, const char *message, ...); +static const char *nonnull (const char *s); +static const char *nonempty (const char *s); +void lt_setenv (const char *name, const char *value); +char *lt_extend_str (const char *orig_value, const char *add, int to_end); +void lt_update_exe_path (const char *name, const char *value); +void lt_update_lib_path (const char *name, const char *value); +char **prepare_spawn (char **argv); +void lt_dump_script (FILE *f); +EOF + + cat <= 0) + && (st.st_mode & (S_IXUSR | S_IXGRP | S_IXOTH))) + return 1; + else + return 0; +} + +int +make_executable (const char *path) +{ + int rval = 0; + struct stat st; + + lt_debugprintf (__FILE__, __LINE__, "(make_executable): %s\n", + nonempty (path)); + if ((!path) || (!*path)) + return 0; + + if (stat (path, &st) >= 0) + { + rval = chmod (path, st.st_mode | S_IXOTH | S_IXGRP | S_IXUSR); + } + return rval; +} + +/* Searches for the full path of the wrapper. Returns + newly allocated full path name if found, NULL otherwise + Does not chase symlinks, even on platforms that support them. +*/ +char * +find_executable (const char *wrapper) +{ + int has_slash = 0; + const char *p; + const char *p_next; + /* static buffer for getcwd */ + char tmp[LT_PATHMAX + 1]; + int tmp_len; + char *concat_name; + + lt_debugprintf (__FILE__, __LINE__, "(find_executable): %s\n", + nonempty (wrapper)); + + if ((wrapper == NULL) || (*wrapper == '\0')) + return NULL; + + /* Absolute path? */ +#if defined (HAVE_DOS_BASED_FILE_SYSTEM) + if (isalpha ((unsigned char) wrapper[0]) && wrapper[1] == ':') + { + concat_name = xstrdup (wrapper); + if (check_executable (concat_name)) + return concat_name; + XFREE (concat_name); + } + else + { +#endif + if (IS_DIR_SEPARATOR (wrapper[0])) + { + concat_name = xstrdup (wrapper); + if (check_executable (concat_name)) + return concat_name; + XFREE (concat_name); + } +#if defined (HAVE_DOS_BASED_FILE_SYSTEM) + } +#endif + + for (p = wrapper; *p; p++) + if (*p == '/') + { + has_slash = 1; + break; + } + if (!has_slash) + { + /* no slashes; search PATH */ + const char *path = getenv ("PATH"); + if (path != NULL) + { + for (p = path; *p; p = p_next) + { + const char *q; + size_t p_len; + for (q = p; *q; q++) + if (IS_PATH_SEPARATOR (*q)) + break; + p_len = q - p; + p_next = (*q == '\0' ? q : q + 1); + if (p_len == 0) + { + /* empty path: current directory */ + if (getcwd (tmp, LT_PATHMAX) == NULL) + lt_fatal (__FILE__, __LINE__, "getcwd failed: %s", + nonnull (strerror (errno))); + tmp_len = strlen (tmp); + concat_name = + XMALLOC (char, tmp_len + 1 + strlen (wrapper) + 1); + memcpy (concat_name, tmp, tmp_len); + concat_name[tmp_len] = '/'; + strcpy (concat_name + tmp_len + 1, wrapper); + } + else + { + concat_name = + XMALLOC (char, p_len + 1 + strlen (wrapper) + 1); + memcpy (concat_name, p, p_len); + concat_name[p_len] = '/'; + strcpy (concat_name + p_len + 1, wrapper); + } + if (check_executable (concat_name)) + return concat_name; + XFREE (concat_name); + } + } + /* not found in PATH; assume curdir */ + } + /* Relative path | not found in path: prepend cwd */ + if (getcwd (tmp, LT_PATHMAX) == NULL) + lt_fatal (__FILE__, __LINE__, "getcwd failed: %s", + nonnull (strerror (errno))); + tmp_len = strlen (tmp); + concat_name = XMALLOC (char, tmp_len + 1 + strlen (wrapper) + 1); + memcpy (concat_name, tmp, tmp_len); + concat_name[tmp_len] = '/'; + strcpy (concat_name + tmp_len + 1, wrapper); + + if (check_executable (concat_name)) + return concat_name; + XFREE (concat_name); + return NULL; +} + +char * +chase_symlinks (const char *pathspec) +{ +#ifndef S_ISLNK + return xstrdup (pathspec); +#else + char buf[LT_PATHMAX]; + struct stat s; + char *tmp_pathspec = xstrdup (pathspec); + char *p; + int has_symlinks = 0; + while (strlen (tmp_pathspec) && !has_symlinks) + { + lt_debugprintf (__FILE__, __LINE__, + "checking path component for symlinks: %s\n", + tmp_pathspec); + if (lstat (tmp_pathspec, &s) == 0) + { + if (S_ISLNK (s.st_mode) != 0) + { + has_symlinks = 1; + break; + } + + /* search backwards for last DIR_SEPARATOR */ + p = tmp_pathspec + strlen (tmp_pathspec) - 1; + while ((p > tmp_pathspec) && (!IS_DIR_SEPARATOR (*p))) + p--; + if ((p == tmp_pathspec) && (!IS_DIR_SEPARATOR (*p))) + { + /* no more DIR_SEPARATORS left */ + break; + } + *p = '\0'; + } + else + { + lt_fatal (__FILE__, __LINE__, + "error accessing file \"%s\": %s", + tmp_pathspec, nonnull (strerror (errno))); + } + } + XFREE (tmp_pathspec); + + if (!has_symlinks) + { + return xstrdup (pathspec); + } + + tmp_pathspec = realpath (pathspec, buf); + if (tmp_pathspec == 0) + { + lt_fatal (__FILE__, __LINE__, + "could not follow symlinks for %s", pathspec); + } + return xstrdup (tmp_pathspec); +#endif +} + +char * +strendzap (char *str, const char *pat) +{ + size_t len, patlen; + + assert (str != NULL); + assert (pat != NULL); + + len = strlen (str); + patlen = strlen (pat); + + if (patlen <= len) + { + str += len - patlen; + if (strcmp (str, pat) == 0) + *str = '\0'; + } + return str; +} + +void +lt_debugprintf (const char *file, int line, const char *fmt, ...) +{ + va_list args; + if (lt_debug) + { + (void) fprintf (stderr, "%s:%s:%d: ", program_name, file, line); + va_start (args, fmt); + (void) vfprintf (stderr, fmt, args); + va_end (args); + } +} + +static void +lt_error_core (int exit_status, const char *file, + int line, const char *mode, + const char *message, va_list ap) +{ + fprintf (stderr, "%s:%s:%d: %s: ", program_name, file, line, mode); + vfprintf (stderr, message, ap); + fprintf (stderr, ".\n"); + + if (exit_status >= 0) + exit (exit_status); +} + +void +lt_fatal (const char *file, int line, const char *message, ...) +{ + va_list ap; + va_start (ap, message); + lt_error_core (EXIT_FAILURE, file, line, "FATAL", message, ap); + va_end (ap); +} + +static const char * +nonnull (const char *s) +{ + return s ? s : "(null)"; +} + +static const char * +nonempty (const char *s) +{ + return (s && !*s) ? "(empty)" : nonnull (s); +} + +void +lt_setenv (const char *name, const char *value) +{ + lt_debugprintf (__FILE__, __LINE__, + "(lt_setenv) setting '%s' to '%s'\n", + nonnull (name), nonnull (value)); + { +#ifdef HAVE_SETENV + /* always make a copy, for consistency with !HAVE_SETENV */ + char *str = xstrdup (value); + setenv (name, str, 1); +#else + int len = strlen (name) + 1 + strlen (value) + 1; + char *str = XMALLOC (char, len); + sprintf (str, "%s=%s", name, value); + if (putenv (str) != EXIT_SUCCESS) + { + XFREE (str); + } +#endif + } +} + +char * +lt_extend_str (const char *orig_value, const char *add, int to_end) +{ + char *new_value; + if (orig_value && *orig_value) + { + int orig_value_len = strlen (orig_value); + int add_len = strlen (add); + new_value = XMALLOC (char, add_len + orig_value_len + 1); + if (to_end) + { + strcpy (new_value, orig_value); + strcpy (new_value + orig_value_len, add); + } + else + { + strcpy (new_value, add); + strcpy (new_value + add_len, orig_value); + } + } + else + { + new_value = xstrdup (add); + } + return new_value; +} + +void +lt_update_exe_path (const char *name, const char *value) +{ + lt_debugprintf (__FILE__, __LINE__, + "(lt_update_exe_path) modifying '%s' by prepending '%s'\n", + nonnull (name), nonnull (value)); + + if (name && *name && value && *value) + { + char *new_value = lt_extend_str (getenv (name), value, 0); + /* some systems can't cope with a ':'-terminated path #' */ + int len = strlen (new_value); + while (((len = strlen (new_value)) > 0) && IS_PATH_SEPARATOR (new_value[len-1])) + { + new_value[len-1] = '\0'; + } + lt_setenv (name, new_value); + XFREE (new_value); + } +} + +void +lt_update_lib_path (const char *name, const char *value) +{ + lt_debugprintf (__FILE__, __LINE__, + "(lt_update_lib_path) modifying '%s' by prepending '%s'\n", + nonnull (name), nonnull (value)); + + if (name && *name && value && *value) + { + char *new_value = lt_extend_str (getenv (name), value, 0); + lt_setenv (name, new_value); + XFREE (new_value); + } +} + +EOF + case $host_os in + mingw*) + cat <<"EOF" + +/* Prepares an argument vector before calling spawn(). + Note that spawn() does not by itself call the command interpreter + (getenv ("COMSPEC") != NULL ? getenv ("COMSPEC") : + ({ OSVERSIONINFO v; v.dwOSVersionInfoSize = sizeof(OSVERSIONINFO); + GetVersionEx(&v); + v.dwPlatformId == VER_PLATFORM_WIN32_NT; + }) ? "cmd.exe" : "command.com"). + Instead it simply concatenates the arguments, separated by ' ', and calls + CreateProcess(). We must quote the arguments since Win32 CreateProcess() + interprets characters like ' ', '\t', '\\', '"' (but not '<' and '>') in a + special way: + - Space and tab are interpreted as delimiters. They are not treated as + delimiters if they are surrounded by double quotes: "...". + - Unescaped double quotes are removed from the input. Their only effect is + that within double quotes, space and tab are treated like normal + characters. + - Backslashes not followed by double quotes are not special. + - But 2*n+1 backslashes followed by a double quote become + n backslashes followed by a double quote (n >= 0): + \" -> " + \\\" -> \" + \\\\\" -> \\" + */ +#define SHELL_SPECIAL_CHARS "\"\\ \001\002\003\004\005\006\007\010\011\012\013\014\015\016\017\020\021\022\023\024\025\026\027\030\031\032\033\034\035\036\037" +#define SHELL_SPACE_CHARS " \001\002\003\004\005\006\007\010\011\012\013\014\015\016\017\020\021\022\023\024\025\026\027\030\031\032\033\034\035\036\037" +char ** +prepare_spawn (char **argv) +{ + size_t argc; + char **new_argv; + size_t i; + + /* Count number of arguments. */ + for (argc = 0; argv[argc] != NULL; argc++) + ; + + /* Allocate new argument vector. */ + new_argv = XMALLOC (char *, argc + 1); + + /* Put quoted arguments into the new argument vector. */ + for (i = 0; i < argc; i++) + { + const char *string = argv[i]; + + if (string[0] == '\0') + new_argv[i] = xstrdup ("\"\""); + else if (strpbrk (string, SHELL_SPECIAL_CHARS) != NULL) + { + int quote_around = (strpbrk (string, SHELL_SPACE_CHARS) != NULL); + size_t length; + unsigned int backslashes; + const char *s; + char *quoted_string; + char *p; + + length = 0; + backslashes = 0; + if (quote_around) + length++; + for (s = string; *s != '\0'; s++) + { + char c = *s; + if (c == '"') + length += backslashes + 1; + length++; + if (c == '\\') + backslashes++; + else + backslashes = 0; + } + if (quote_around) + length += backslashes + 1; + + quoted_string = XMALLOC (char, length + 1); + + p = quoted_string; + backslashes = 0; + if (quote_around) + *p++ = '"'; + for (s = string; *s != '\0'; s++) + { + char c = *s; + if (c == '"') + { + unsigned int j; + for (j = backslashes + 1; j > 0; j--) + *p++ = '\\'; + } + *p++ = c; + if (c == '\\') + backslashes++; + else + backslashes = 0; + } + if (quote_around) + { + unsigned int j; + for (j = backslashes; j > 0; j--) + *p++ = '\\'; + *p++ = '"'; + } + *p = '\0'; + + new_argv[i] = quoted_string; + } + else + new_argv[i] = (char *) string; + } + new_argv[argc] = NULL; + + return new_argv; +} +EOF + ;; + esac + + cat <<"EOF" +void lt_dump_script (FILE* f) +{ +EOF + func_emit_wrapper yes | + $SED -n -e ' +s/^\(.\{79\}\)\(..*\)/\1\ +\2/ +h +s/\([\\"]\)/\\\1/g +s/$/\\n/ +s/\([^\n]*\).*/ fputs ("\1", f);/p +g +D' + cat <<"EOF" +} +EOF +} +# end: func_emit_cwrapperexe_src + +# func_win32_import_lib_p ARG +# True if ARG is an import lib, as indicated by $file_magic_cmd +func_win32_import_lib_p () +{ + $opt_debug + case `eval $file_magic_cmd \"\$1\" 2>/dev/null | $SED -e 10q` in + *import*) : ;; + *) false ;; + esac +} + +# func_mode_link arg... +func_mode_link () +{ + $opt_debug + case $host in + *-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-os2* | *-cegcc*) + # It is impossible to link a dll without this setting, and + # we shouldn't force the makefile maintainer to figure out + # which system we are compiling for in order to pass an extra + # flag for every libtool invocation. + # allow_undefined=no + + # FIXME: Unfortunately, there are problems with the above when trying + # to make a dll which has undefined symbols, in which case not + # even a static library is built. For now, we need to specify + # -no-undefined on the libtool link line when we can be certain + # that all symbols are satisfied, otherwise we get a static library. + allow_undefined=yes + ;; + *) + allow_undefined=yes + ;; + esac + libtool_args=$nonopt + base_compile="$nonopt $@" + compile_command=$nonopt + finalize_command=$nonopt + + compile_rpath= + finalize_rpath= + compile_shlibpath= + finalize_shlibpath= + convenience= + old_convenience= + deplibs= + old_deplibs= + compiler_flags= + linker_flags= + dllsearchpath= + lib_search_path=`pwd` + inst_prefix_dir= + new_inherited_linker_flags= + + avoid_version=no + bindir= + dlfiles= + dlprefiles= + dlself=no + export_dynamic=no + export_symbols= + export_symbols_regex= + generated= + libobjs= + ltlibs= + module=no + no_install=no + objs= + non_pic_objects= + precious_files_regex= + prefer_static_libs=no + preload=no + prev= + prevarg= + release= + rpath= + xrpath= + perm_rpath= + temp_rpath= + thread_safe=no + vinfo= + vinfo_number=no + weak_libs= + single_module="${wl}-single_module" + func_infer_tag $base_compile + + # We need to know -static, to get the right output filenames. + for arg + do + case $arg in + -shared) + test "$build_libtool_libs" != yes && \ + func_fatal_configuration "can not build a shared library" + build_old_libs=no + break + ;; + -all-static | -static | -static-libtool-libs) + case $arg in + -all-static) + if test "$build_libtool_libs" = yes && test -z "$link_static_flag"; then + func_warning "complete static linking is impossible in this configuration" + fi + if test -n "$link_static_flag"; then + dlopen_self=$dlopen_self_static + fi + prefer_static_libs=yes + ;; + -static) + if test -z "$pic_flag" && test -n "$link_static_flag"; then + dlopen_self=$dlopen_self_static + fi + prefer_static_libs=built + ;; + -static-libtool-libs) + if test -z "$pic_flag" && test -n "$link_static_flag"; then + dlopen_self=$dlopen_self_static + fi + prefer_static_libs=yes + ;; + esac + build_libtool_libs=no + build_old_libs=yes + break + ;; + esac + done + + # See if our shared archives depend on static archives. + test -n "$old_archive_from_new_cmds" && build_old_libs=yes + + # Go through the arguments, transforming them on the way. + while test "$#" -gt 0; do + arg="$1" + shift + func_quote_for_eval "$arg" + qarg=$func_quote_for_eval_unquoted_result + func_append libtool_args " $func_quote_for_eval_result" + + # If the previous option needs an argument, assign it. + if test -n "$prev"; then + case $prev in + output) + func_append compile_command " @OUTPUT@" + func_append finalize_command " @OUTPUT@" + ;; + esac + + case $prev in + bindir) + bindir="$arg" + prev= + continue + ;; + dlfiles|dlprefiles) + if test "$preload" = no; then + # Add the symbol object into the linking commands. + func_append compile_command " @SYMFILE@" + func_append finalize_command " @SYMFILE@" + preload=yes + fi + case $arg in + *.la | *.lo) ;; # We handle these cases below. + force) + if test "$dlself" = no; then + dlself=needless + export_dynamic=yes + fi + prev= + continue + ;; + self) + if test "$prev" = dlprefiles; then + dlself=yes + elif test "$prev" = dlfiles && test "$dlopen_self" != yes; then + dlself=yes + else + dlself=needless + export_dynamic=yes + fi + prev= + continue + ;; + *) + if test "$prev" = dlfiles; then + func_append dlfiles " $arg" + else + func_append dlprefiles " $arg" + fi + prev= + continue + ;; + esac + ;; + expsyms) + export_symbols="$arg" + test -f "$arg" \ + || func_fatal_error "symbol file \`$arg' does not exist" + prev= + continue + ;; + expsyms_regex) + export_symbols_regex="$arg" + prev= + continue + ;; + framework) + case $host in + *-*-darwin*) + case "$deplibs " in + *" $qarg.ltframework "*) ;; + *) func_append deplibs " $qarg.ltframework" # this is fixed later + ;; + esac + ;; + esac + prev= + continue + ;; + inst_prefix) + inst_prefix_dir="$arg" + prev= + continue + ;; + objectlist) + if test -f "$arg"; then + save_arg=$arg + moreargs= + for fil in `cat "$save_arg"` + do +# func_append moreargs " $fil" + arg=$fil + # A libtool-controlled object. + + # Check to see that this really is a libtool object. + if func_lalib_unsafe_p "$arg"; then + pic_object= + non_pic_object= + + # Read the .lo file + func_source "$arg" + + if test -z "$pic_object" || + test -z "$non_pic_object" || + test "$pic_object" = none && + test "$non_pic_object" = none; then + func_fatal_error "cannot find name of object for \`$arg'" + fi + + # Extract subdirectory from the argument. + func_dirname "$arg" "/" "" + xdir="$func_dirname_result" + + if test "$pic_object" != none; then + # Prepend the subdirectory the object is found in. + pic_object="$xdir$pic_object" + + if test "$prev" = dlfiles; then + if test "$build_libtool_libs" = yes && test "$dlopen_support" = yes; then + func_append dlfiles " $pic_object" + prev= + continue + else + # If libtool objects are unsupported, then we need to preload. + prev=dlprefiles + fi + fi + + # CHECK ME: I think I busted this. -Ossama + if test "$prev" = dlprefiles; then + # Preload the old-style object. + func_append dlprefiles " $pic_object" + prev= + fi + + # A PIC object. + func_append libobjs " $pic_object" + arg="$pic_object" + fi + + # Non-PIC object. + if test "$non_pic_object" != none; then + # Prepend the subdirectory the object is found in. + non_pic_object="$xdir$non_pic_object" + + # A standard non-PIC object + func_append non_pic_objects " $non_pic_object" + if test -z "$pic_object" || test "$pic_object" = none ; then + arg="$non_pic_object" + fi + else + # If the PIC object exists, use it instead. + # $xdir was prepended to $pic_object above. + non_pic_object="$pic_object" + func_append non_pic_objects " $non_pic_object" + fi + else + # Only an error if not doing a dry-run. + if $opt_dry_run; then + # Extract subdirectory from the argument. + func_dirname "$arg" "/" "" + xdir="$func_dirname_result" + + func_lo2o "$arg" + pic_object=$xdir$objdir/$func_lo2o_result + non_pic_object=$xdir$func_lo2o_result + func_append libobjs " $pic_object" + func_append non_pic_objects " $non_pic_object" + else + func_fatal_error "\`$arg' is not a valid libtool object" + fi + fi + done + else + func_fatal_error "link input file \`$arg' does not exist" + fi + arg=$save_arg + prev= + continue + ;; + precious_regex) + precious_files_regex="$arg" + prev= + continue + ;; + release) + release="-$arg" + prev= + continue + ;; + rpath | xrpath) + # We need an absolute path. + case $arg in + [\\/]* | [A-Za-z]:[\\/]*) ;; + *) + func_fatal_error "only absolute run-paths are allowed" + ;; + esac + if test "$prev" = rpath; then + case "$rpath " in + *" $arg "*) ;; + *) func_append rpath " $arg" ;; + esac + else + case "$xrpath " in + *" $arg "*) ;; + *) func_append xrpath " $arg" ;; + esac + fi + prev= + continue + ;; + shrext) + shrext_cmds="$arg" + prev= + continue + ;; + weak) + func_append weak_libs " $arg" + prev= + continue + ;; + xcclinker) + func_append linker_flags " $qarg" + func_append compiler_flags " $qarg" + prev= + func_append compile_command " $qarg" + func_append finalize_command " $qarg" + continue + ;; + xcompiler) + func_append compiler_flags " $qarg" + prev= + func_append compile_command " $qarg" + func_append finalize_command " $qarg" + continue + ;; + xlinker) + func_append linker_flags " $qarg" + func_append compiler_flags " $wl$qarg" + prev= + func_append compile_command " $wl$qarg" + func_append finalize_command " $wl$qarg" + continue + ;; + *) + eval "$prev=\"\$arg\"" + prev= + continue + ;; + esac + fi # test -n "$prev" + + prevarg="$arg" + + case $arg in + -all-static) + if test -n "$link_static_flag"; then + # See comment for -static flag below, for more details. + func_append compile_command " $link_static_flag" + func_append finalize_command " $link_static_flag" + fi + continue + ;; + + -allow-undefined) + # FIXME: remove this flag sometime in the future. + func_fatal_error "\`-allow-undefined' must not be used because it is the default" + ;; + + -avoid-version) + avoid_version=yes + continue + ;; + + -bindir) + prev=bindir + continue + ;; + + -dlopen) + prev=dlfiles + continue + ;; + + -dlpreopen) + prev=dlprefiles + continue + ;; + + -export-dynamic) + export_dynamic=yes + continue + ;; + + -export-symbols | -export-symbols-regex) + if test -n "$export_symbols" || test -n "$export_symbols_regex"; then + func_fatal_error "more than one -exported-symbols argument is not allowed" + fi + if test "X$arg" = "X-export-symbols"; then + prev=expsyms + else + prev=expsyms_regex + fi + continue + ;; + + -framework) + prev=framework + continue + ;; + + -inst-prefix-dir) + prev=inst_prefix + continue + ;; + + # The native IRIX linker understands -LANG:*, -LIST:* and -LNO:* + # so, if we see these flags be careful not to treat them like -L + -L[A-Z][A-Z]*:*) + case $with_gcc/$host in + no/*-*-irix* | /*-*-irix*) + func_append compile_command " $arg" + func_append finalize_command " $arg" + ;; + esac + continue + ;; + + -L*) + func_stripname "-L" '' "$arg" + if test -z "$func_stripname_result"; then + if test "$#" -gt 0; then + func_fatal_error "require no space between \`-L' and \`$1'" + else + func_fatal_error "need path for \`-L' option" + fi + fi + func_resolve_sysroot "$func_stripname_result" + dir=$func_resolve_sysroot_result + # We need an absolute path. + case $dir in + [\\/]* | [A-Za-z]:[\\/]*) ;; + *) + absdir=`cd "$dir" && pwd` + test -z "$absdir" && \ + func_fatal_error "cannot determine absolute directory name of \`$dir'" + dir="$absdir" + ;; + esac + case "$deplibs " in + *" -L$dir "* | *" $arg "*) + # Will only happen for absolute or sysroot arguments + ;; + *) + # Preserve sysroot, but never include relative directories + case $dir in + [\\/]* | [A-Za-z]:[\\/]* | =*) func_append deplibs " $arg" ;; + *) func_append deplibs " -L$dir" ;; + esac + func_append lib_search_path " $dir" + ;; + esac + case $host in + *-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-os2* | *-cegcc*) + testbindir=`$ECHO "$dir" | $SED 's*/lib$*/bin*'` + case :$dllsearchpath: in + *":$dir:"*) ;; + ::) dllsearchpath=$dir;; + *) func_append dllsearchpath ":$dir";; + esac + case :$dllsearchpath: in + *":$testbindir:"*) ;; + ::) dllsearchpath=$testbindir;; + *) func_append dllsearchpath ":$testbindir";; + esac + ;; + esac + continue + ;; + + -l*) + if test "X$arg" = "X-lc" || test "X$arg" = "X-lm"; then + case $host in + *-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-beos* | *-cegcc* | *-*-haiku*) + # These systems don't actually have a C or math library (as such) + continue + ;; + *-*-os2*) + # These systems don't actually have a C library (as such) + test "X$arg" = "X-lc" && continue + ;; + *-*-openbsd* | *-*-freebsd* | *-*-dragonfly*) + # Do not include libc due to us having libc/libc_r. + test "X$arg" = "X-lc" && continue + ;; + *-*-rhapsody* | *-*-darwin1.[012]) + # Rhapsody C and math libraries are in the System framework + func_append deplibs " System.ltframework" + continue + ;; + *-*-sco3.2v5* | *-*-sco5v6*) + # Causes problems with __ctype + test "X$arg" = "X-lc" && continue + ;; + *-*-sysv4.2uw2* | *-*-sysv5* | *-*-unixware* | *-*-OpenUNIX*) + # Compiler inserts libc in the correct place for threads to work + test "X$arg" = "X-lc" && continue + ;; + esac + elif test "X$arg" = "X-lc_r"; then + case $host in + *-*-openbsd* | *-*-freebsd* | *-*-dragonfly*) + # Do not include libc_r directly, use -pthread flag. + continue + ;; + esac + fi + func_append deplibs " $arg" + continue + ;; + + -module) + module=yes + continue + ;; + + # Tru64 UNIX uses -model [arg] to determine the layout of C++ + # classes, name mangling, and exception handling. + # Darwin uses the -arch flag to determine output architecture. + -model|-arch|-isysroot|--sysroot) + func_append compiler_flags " $arg" + func_append compile_command " $arg" + func_append finalize_command " $arg" + prev=xcompiler + continue + ;; + + -mt|-mthreads|-kthread|-Kthread|-pthread|-pthreads|--thread-safe \ + |-threads|-fopenmp|-openmp|-mp|-xopenmp|-omp|-qsmp=*) + func_append compiler_flags " $arg" + func_append compile_command " $arg" + func_append finalize_command " $arg" + case "$new_inherited_linker_flags " in + *" $arg "*) ;; + * ) func_append new_inherited_linker_flags " $arg" ;; + esac + continue + ;; + + -multi_module) + single_module="${wl}-multi_module" + continue + ;; + + -no-fast-install) + fast_install=no + continue + ;; + + -no-install) + case $host in + *-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-os2* | *-*-darwin* | *-cegcc*) + # The PATH hackery in wrapper scripts is required on Windows + # and Darwin in order for the loader to find any dlls it needs. + func_warning "\`-no-install' is ignored for $host" + func_warning "assuming \`-no-fast-install' instead" + fast_install=no + ;; + *) no_install=yes ;; + esac + continue + ;; + + -no-undefined) + allow_undefined=no + continue + ;; + + -objectlist) + prev=objectlist + continue + ;; + + -o) prev=output ;; + + -precious-files-regex) + prev=precious_regex + continue + ;; + + -release) + prev=release + continue + ;; + + -rpath) + prev=rpath + continue + ;; + + -R) + prev=xrpath + continue + ;; + + -R*) + func_stripname '-R' '' "$arg" + dir=$func_stripname_result + # We need an absolute path. + case $dir in + [\\/]* | [A-Za-z]:[\\/]*) ;; + =*) + func_stripname '=' '' "$dir" + dir=$lt_sysroot$func_stripname_result + ;; + *) + func_fatal_error "only absolute run-paths are allowed" + ;; + esac + case "$xrpath " in + *" $dir "*) ;; + *) func_append xrpath " $dir" ;; + esac + continue + ;; + + -shared) + # The effects of -shared are defined in a previous loop. + continue + ;; + + -shrext) + prev=shrext + continue + ;; + + -static | -static-libtool-libs) + # The effects of -static are defined in a previous loop. + # We used to do the same as -all-static on platforms that + # didn't have a PIC flag, but the assumption that the effects + # would be equivalent was wrong. It would break on at least + # Digital Unix and AIX. + continue + ;; + + -thread-safe) + thread_safe=yes + continue + ;; + + -version-info) + prev=vinfo + continue + ;; + + -version-number) + prev=vinfo + vinfo_number=yes + continue + ;; + + -weak) + prev=weak + continue + ;; + + -Wc,*) + func_stripname '-Wc,' '' "$arg" + args=$func_stripname_result + arg= + save_ifs="$IFS"; IFS=',' + for flag in $args; do + IFS="$save_ifs" + func_quote_for_eval "$flag" + func_append arg " $func_quote_for_eval_result" + func_append compiler_flags " $func_quote_for_eval_result" + done + IFS="$save_ifs" + func_stripname ' ' '' "$arg" + arg=$func_stripname_result + ;; + + -Wl,*) + func_stripname '-Wl,' '' "$arg" + args=$func_stripname_result + arg= + save_ifs="$IFS"; IFS=',' + for flag in $args; do + IFS="$save_ifs" + func_quote_for_eval "$flag" + func_append arg " $wl$func_quote_for_eval_result" + func_append compiler_flags " $wl$func_quote_for_eval_result" + func_append linker_flags " $func_quote_for_eval_result" + done + IFS="$save_ifs" + func_stripname ' ' '' "$arg" + arg=$func_stripname_result + ;; + + -Xcompiler) + prev=xcompiler + continue + ;; + + -Xlinker) + prev=xlinker + continue + ;; + + -XCClinker) + prev=xcclinker + continue + ;; + + # -msg_* for osf cc + -msg_*) + func_quote_for_eval "$arg" + arg="$func_quote_for_eval_result" + ;; + + # Flags to be passed through unchanged, with rationale: + # -64, -mips[0-9] enable 64-bit mode for the SGI compiler + # -r[0-9][0-9]* specify processor for the SGI compiler + # -xarch=*, -xtarget=* enable 64-bit mode for the Sun compiler + # +DA*, +DD* enable 64-bit mode for the HP compiler + # -q* compiler args for the IBM compiler + # -m*, -t[45]*, -txscale* architecture-specific flags for GCC + # -F/path path to uninstalled frameworks, gcc on darwin + # -p, -pg, --coverage, -fprofile-* profiling flags for GCC + # @file GCC response files + # -tp=* Portland pgcc target processor selection + # --sysroot=* for sysroot support + # -O*, -flto*, -fwhopr*, -fuse-linker-plugin GCC link-time optimization + -64|-mips[0-9]|-r[0-9][0-9]*|-xarch=*|-xtarget=*|+DA*|+DD*|-q*|-m*| \ + -t[45]*|-txscale*|-p|-pg|--coverage|-fprofile-*|-F*|@*|-tp=*|--sysroot=*| \ + -O*|-flto*|-fwhopr*|-fuse-linker-plugin) + func_quote_for_eval "$arg" + arg="$func_quote_for_eval_result" + func_append compile_command " $arg" + func_append finalize_command " $arg" + func_append compiler_flags " $arg" + continue + ;; + + # Some other compiler flag. + -* | +*) + func_quote_for_eval "$arg" + arg="$func_quote_for_eval_result" + ;; + + *.$objext) + # A standard object. + func_append objs " $arg" + ;; + + *.lo) + # A libtool-controlled object. + + # Check to see that this really is a libtool object. + if func_lalib_unsafe_p "$arg"; then + pic_object= + non_pic_object= + + # Read the .lo file + func_source "$arg" + + if test -z "$pic_object" || + test -z "$non_pic_object" || + test "$pic_object" = none && + test "$non_pic_object" = none; then + func_fatal_error "cannot find name of object for \`$arg'" + fi + + # Extract subdirectory from the argument. + func_dirname "$arg" "/" "" + xdir="$func_dirname_result" + + if test "$pic_object" != none; then + # Prepend the subdirectory the object is found in. + pic_object="$xdir$pic_object" + + if test "$prev" = dlfiles; then + if test "$build_libtool_libs" = yes && test "$dlopen_support" = yes; then + func_append dlfiles " $pic_object" + prev= + continue + else + # If libtool objects are unsupported, then we need to preload. + prev=dlprefiles + fi + fi + + # CHECK ME: I think I busted this. -Ossama + if test "$prev" = dlprefiles; then + # Preload the old-style object. + func_append dlprefiles " $pic_object" + prev= + fi + + # A PIC object. + func_append libobjs " $pic_object" + arg="$pic_object" + fi + + # Non-PIC object. + if test "$non_pic_object" != none; then + # Prepend the subdirectory the object is found in. + non_pic_object="$xdir$non_pic_object" + + # A standard non-PIC object + func_append non_pic_objects " $non_pic_object" + if test -z "$pic_object" || test "$pic_object" = none ; then + arg="$non_pic_object" + fi + else + # If the PIC object exists, use it instead. + # $xdir was prepended to $pic_object above. + non_pic_object="$pic_object" + func_append non_pic_objects " $non_pic_object" + fi + else + # Only an error if not doing a dry-run. + if $opt_dry_run; then + # Extract subdirectory from the argument. + func_dirname "$arg" "/" "" + xdir="$func_dirname_result" + + func_lo2o "$arg" + pic_object=$xdir$objdir/$func_lo2o_result + non_pic_object=$xdir$func_lo2o_result + func_append libobjs " $pic_object" + func_append non_pic_objects " $non_pic_object" + else + func_fatal_error "\`$arg' is not a valid libtool object" + fi + fi + ;; + + *.$libext) + # An archive. + func_append deplibs " $arg" + func_append old_deplibs " $arg" + continue + ;; + + *.la) + # A libtool-controlled library. + + func_resolve_sysroot "$arg" + if test "$prev" = dlfiles; then + # This library was specified with -dlopen. + func_append dlfiles " $func_resolve_sysroot_result" + prev= + elif test "$prev" = dlprefiles; then + # The library was specified with -dlpreopen. + func_append dlprefiles " $func_resolve_sysroot_result" + prev= + else + func_append deplibs " $func_resolve_sysroot_result" + fi + continue + ;; + + # Some other compiler argument. + *) + # Unknown arguments in both finalize_command and compile_command need + # to be aesthetically quoted because they are evaled later. + func_quote_for_eval "$arg" + arg="$func_quote_for_eval_result" + ;; + esac # arg + + # Now actually substitute the argument into the commands. + if test -n "$arg"; then + func_append compile_command " $arg" + func_append finalize_command " $arg" + fi + done # argument parsing loop + + test -n "$prev" && \ + func_fatal_help "the \`$prevarg' option requires an argument" + + if test "$export_dynamic" = yes && test -n "$export_dynamic_flag_spec"; then + eval arg=\"$export_dynamic_flag_spec\" + func_append compile_command " $arg" + func_append finalize_command " $arg" + fi + + oldlibs= + # calculate the name of the file, without its directory + func_basename "$output" + outputname="$func_basename_result" + libobjs_save="$libobjs" + + if test -n "$shlibpath_var"; then + # get the directories listed in $shlibpath_var + eval shlib_search_path=\`\$ECHO \"\${$shlibpath_var}\" \| \$SED \'s/:/ /g\'\` + else + shlib_search_path= + fi + eval sys_lib_search_path=\"$sys_lib_search_path_spec\" + eval sys_lib_dlsearch_path=\"$sys_lib_dlsearch_path_spec\" + + func_dirname "$output" "/" "" + output_objdir="$func_dirname_result$objdir" + func_to_tool_file "$output_objdir/" + tool_output_objdir=$func_to_tool_file_result + # Create the object directory. + func_mkdir_p "$output_objdir" + + # Determine the type of output + case $output in + "") + func_fatal_help "you must specify an output file" + ;; + *.$libext) linkmode=oldlib ;; + *.lo | *.$objext) linkmode=obj ;; + *.la) linkmode=lib ;; + *) linkmode=prog ;; # Anything else should be a program. + esac + + specialdeplibs= + + libs= + # Find all interdependent deplibs by searching for libraries + # that are linked more than once (e.g. -la -lb -la) + for deplib in $deplibs; do + if $opt_preserve_dup_deps ; then + case "$libs " in + *" $deplib "*) func_append specialdeplibs " $deplib" ;; + esac + fi + func_append libs " $deplib" + done + + if test "$linkmode" = lib; then + libs="$predeps $libs $compiler_lib_search_path $postdeps" + + # Compute libraries that are listed more than once in $predeps + # $postdeps and mark them as special (i.e., whose duplicates are + # not to be eliminated). + pre_post_deps= + if $opt_duplicate_compiler_generated_deps; then + for pre_post_dep in $predeps $postdeps; do + case "$pre_post_deps " in + *" $pre_post_dep "*) func_append specialdeplibs " $pre_post_deps" ;; + esac + func_append pre_post_deps " $pre_post_dep" + done + fi + pre_post_deps= + fi + + deplibs= + newdependency_libs= + newlib_search_path= + need_relink=no # whether we're linking any uninstalled libtool libraries + notinst_deplibs= # not-installed libtool libraries + notinst_path= # paths that contain not-installed libtool libraries + + case $linkmode in + lib) + passes="conv dlpreopen link" + for file in $dlfiles $dlprefiles; do + case $file in + *.la) ;; + *) + func_fatal_help "libraries can \`-dlopen' only libtool libraries: $file" + ;; + esac + done + ;; + prog) + compile_deplibs= + finalize_deplibs= + alldeplibs=no + newdlfiles= + newdlprefiles= + passes="conv scan dlopen dlpreopen link" + ;; + *) passes="conv" + ;; + esac + + for pass in $passes; do + # The preopen pass in lib mode reverses $deplibs; put it back here + # so that -L comes before libs that need it for instance... + if test "$linkmode,$pass" = "lib,link"; then + ## FIXME: Find the place where the list is rebuilt in the wrong + ## order, and fix it there properly + tmp_deplibs= + for deplib in $deplibs; do + tmp_deplibs="$deplib $tmp_deplibs" + done + deplibs="$tmp_deplibs" + fi + + if test "$linkmode,$pass" = "lib,link" || + test "$linkmode,$pass" = "prog,scan"; then + libs="$deplibs" + deplibs= + fi + if test "$linkmode" = prog; then + case $pass in + dlopen) libs="$dlfiles" ;; + dlpreopen) libs="$dlprefiles" ;; + link) libs="$deplibs %DEPLIBS% $dependency_libs" ;; + esac + fi + if test "$linkmode,$pass" = "lib,dlpreopen"; then + # Collect and forward deplibs of preopened libtool libs + for lib in $dlprefiles; do + # Ignore non-libtool-libs + dependency_libs= + func_resolve_sysroot "$lib" + case $lib in + *.la) func_source "$func_resolve_sysroot_result" ;; + esac + + # Collect preopened libtool deplibs, except any this library + # has declared as weak libs + for deplib in $dependency_libs; do + func_basename "$deplib" + deplib_base=$func_basename_result + case " $weak_libs " in + *" $deplib_base "*) ;; + *) func_append deplibs " $deplib" ;; + esac + done + done + libs="$dlprefiles" + fi + if test "$pass" = dlopen; then + # Collect dlpreopened libraries + save_deplibs="$deplibs" + deplibs= + fi + + for deplib in $libs; do + lib= + found=no + case $deplib in + -mt|-mthreads|-kthread|-Kthread|-pthread|-pthreads|--thread-safe \ + |-threads|-fopenmp|-openmp|-mp|-xopenmp|-omp|-qsmp=*) + if test "$linkmode,$pass" = "prog,link"; then + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + else + func_append compiler_flags " $deplib" + if test "$linkmode" = lib ; then + case "$new_inherited_linker_flags " in + *" $deplib "*) ;; + * ) func_append new_inherited_linker_flags " $deplib" ;; + esac + fi + fi + continue + ;; + -l*) + if test "$linkmode" != lib && test "$linkmode" != prog; then + func_warning "\`-l' is ignored for archives/objects" + continue + fi + func_stripname '-l' '' "$deplib" + name=$func_stripname_result + if test "$linkmode" = lib; then + searchdirs="$newlib_search_path $lib_search_path $compiler_lib_search_dirs $sys_lib_search_path $shlib_search_path" + else + searchdirs="$newlib_search_path $lib_search_path $sys_lib_search_path $shlib_search_path" + fi + for searchdir in $searchdirs; do + for search_ext in .la $std_shrext .so .a; do + # Search the libtool library + lib="$searchdir/lib${name}${search_ext}" + if test -f "$lib"; then + if test "$search_ext" = ".la"; then + found=yes + else + found=no + fi + break 2 + fi + done + done + if test "$found" != yes; then + # deplib doesn't seem to be a libtool library + if test "$linkmode,$pass" = "prog,link"; then + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + else + deplibs="$deplib $deplibs" + test "$linkmode" = lib && newdependency_libs="$deplib $newdependency_libs" + fi + continue + else # deplib is a libtool library + # If $allow_libtool_libs_with_static_runtimes && $deplib is a stdlib, + # We need to do some special things here, and not later. + if test "X$allow_libtool_libs_with_static_runtimes" = "Xyes" ; then + case " $predeps $postdeps " in + *" $deplib "*) + if func_lalib_p "$lib"; then + library_names= + old_library= + func_source "$lib" + for l in $old_library $library_names; do + ll="$l" + done + if test "X$ll" = "X$old_library" ; then # only static version available + found=no + func_dirname "$lib" "" "." + ladir="$func_dirname_result" + lib=$ladir/$old_library + if test "$linkmode,$pass" = "prog,link"; then + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + else + deplibs="$deplib $deplibs" + test "$linkmode" = lib && newdependency_libs="$deplib $newdependency_libs" + fi + continue + fi + fi + ;; + *) ;; + esac + fi + fi + ;; # -l + *.ltframework) + if test "$linkmode,$pass" = "prog,link"; then + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + else + deplibs="$deplib $deplibs" + if test "$linkmode" = lib ; then + case "$new_inherited_linker_flags " in + *" $deplib "*) ;; + * ) func_append new_inherited_linker_flags " $deplib" ;; + esac + fi + fi + continue + ;; + -L*) + case $linkmode in + lib) + deplibs="$deplib $deplibs" + test "$pass" = conv && continue + newdependency_libs="$deplib $newdependency_libs" + func_stripname '-L' '' "$deplib" + func_resolve_sysroot "$func_stripname_result" + func_append newlib_search_path " $func_resolve_sysroot_result" + ;; + prog) + if test "$pass" = conv; then + deplibs="$deplib $deplibs" + continue + fi + if test "$pass" = scan; then + deplibs="$deplib $deplibs" + else + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + fi + func_stripname '-L' '' "$deplib" + func_resolve_sysroot "$func_stripname_result" + func_append newlib_search_path " $func_resolve_sysroot_result" + ;; + *) + func_warning "\`-L' is ignored for archives/objects" + ;; + esac # linkmode + continue + ;; # -L + -R*) + if test "$pass" = link; then + func_stripname '-R' '' "$deplib" + func_resolve_sysroot "$func_stripname_result" + dir=$func_resolve_sysroot_result + # Make sure the xrpath contains only unique directories. + case "$xrpath " in + *" $dir "*) ;; + *) func_append xrpath " $dir" ;; + esac + fi + deplibs="$deplib $deplibs" + continue + ;; + *.la) + func_resolve_sysroot "$deplib" + lib=$func_resolve_sysroot_result + ;; + *.$libext) + if test "$pass" = conv; then + deplibs="$deplib $deplibs" + continue + fi + case $linkmode in + lib) + # Linking convenience modules into shared libraries is allowed, + # but linking other static libraries is non-portable. + case " $dlpreconveniencelibs " in + *" $deplib "*) ;; + *) + valid_a_lib=no + case $deplibs_check_method in + match_pattern*) + set dummy $deplibs_check_method; shift + match_pattern_regex=`expr "$deplibs_check_method" : "$1 \(.*\)"` + if eval "\$ECHO \"$deplib\"" 2>/dev/null | $SED 10q \ + | $EGREP "$match_pattern_regex" > /dev/null; then + valid_a_lib=yes + fi + ;; + pass_all) + valid_a_lib=yes + ;; + esac + if test "$valid_a_lib" != yes; then + echo + $ECHO "*** Warning: Trying to link with static lib archive $deplib." + echo "*** I have the capability to make that library automatically link in when" + echo "*** you link to this library. But I can only do this if you have a" + echo "*** shared version of the library, which you do not appear to have" + echo "*** because the file extensions .$libext of this argument makes me believe" + echo "*** that it is just a static archive that I should not use here." + else + echo + $ECHO "*** Warning: Linking the shared library $output against the" + $ECHO "*** static library $deplib is not portable!" + deplibs="$deplib $deplibs" + fi + ;; + esac + continue + ;; + prog) + if test "$pass" != link; then + deplibs="$deplib $deplibs" + else + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + fi + continue + ;; + esac # linkmode + ;; # *.$libext + *.lo | *.$objext) + if test "$pass" = conv; then + deplibs="$deplib $deplibs" + elif test "$linkmode" = prog; then + if test "$pass" = dlpreopen || test "$dlopen_support" != yes || test "$build_libtool_libs" = no; then + # If there is no dlopen support or we're linking statically, + # we need to preload. + func_append newdlprefiles " $deplib" + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + else + func_append newdlfiles " $deplib" + fi + fi + continue + ;; + %DEPLIBS%) + alldeplibs=yes + continue + ;; + esac # case $deplib + + if test "$found" = yes || test -f "$lib"; then : + else + func_fatal_error "cannot find the library \`$lib' or unhandled argument \`$deplib'" + fi + + # Check to see that this really is a libtool archive. + func_lalib_unsafe_p "$lib" \ + || func_fatal_error "\`$lib' is not a valid libtool archive" + + func_dirname "$lib" "" "." + ladir="$func_dirname_result" + + dlname= + dlopen= + dlpreopen= + libdir= + library_names= + old_library= + inherited_linker_flags= + # If the library was installed with an old release of libtool, + # it will not redefine variables installed, or shouldnotlink + installed=yes + shouldnotlink=no + avoidtemprpath= + + + # Read the .la file + func_source "$lib" + + # Convert "-framework foo" to "foo.ltframework" + if test -n "$inherited_linker_flags"; then + tmp_inherited_linker_flags=`$ECHO "$inherited_linker_flags" | $SED 's/-framework \([^ $]*\)/\1.ltframework/g'` + for tmp_inherited_linker_flag in $tmp_inherited_linker_flags; do + case " $new_inherited_linker_flags " in + *" $tmp_inherited_linker_flag "*) ;; + *) func_append new_inherited_linker_flags " $tmp_inherited_linker_flag";; + esac + done + fi + dependency_libs=`$ECHO " $dependency_libs" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + if test "$linkmode,$pass" = "lib,link" || + test "$linkmode,$pass" = "prog,scan" || + { test "$linkmode" != prog && test "$linkmode" != lib; }; then + test -n "$dlopen" && func_append dlfiles " $dlopen" + test -n "$dlpreopen" && func_append dlprefiles " $dlpreopen" + fi + + if test "$pass" = conv; then + # Only check for convenience libraries + deplibs="$lib $deplibs" + if test -z "$libdir"; then + if test -z "$old_library"; then + func_fatal_error "cannot find name of link library for \`$lib'" + fi + # It is a libtool convenience library, so add in its objects. + func_append convenience " $ladir/$objdir/$old_library" + func_append old_convenience " $ladir/$objdir/$old_library" + elif test "$linkmode" != prog && test "$linkmode" != lib; then + func_fatal_error "\`$lib' is not a convenience library" + fi + tmp_libs= + for deplib in $dependency_libs; do + deplibs="$deplib $deplibs" + if $opt_preserve_dup_deps ; then + case "$tmp_libs " in + *" $deplib "*) func_append specialdeplibs " $deplib" ;; + esac + fi + func_append tmp_libs " $deplib" + done + continue + fi # $pass = conv + + + # Get the name of the library we link against. + linklib= + if test -n "$old_library" && + { test "$prefer_static_libs" = yes || + test "$prefer_static_libs,$installed" = "built,no"; }; then + linklib=$old_library + else + for l in $old_library $library_names; do + linklib="$l" + done + fi + if test -z "$linklib"; then + func_fatal_error "cannot find name of link library for \`$lib'" + fi + + # This library was specified with -dlopen. + if test "$pass" = dlopen; then + if test -z "$libdir"; then + func_fatal_error "cannot -dlopen a convenience library: \`$lib'" + fi + if test -z "$dlname" || + test "$dlopen_support" != yes || + test "$build_libtool_libs" = no; then + # If there is no dlname, no dlopen support or we're linking + # statically, we need to preload. We also need to preload any + # dependent libraries so libltdl's deplib preloader doesn't + # bomb out in the load deplibs phase. + func_append dlprefiles " $lib $dependency_libs" + else + func_append newdlfiles " $lib" + fi + continue + fi # $pass = dlopen + + # We need an absolute path. + case $ladir in + [\\/]* | [A-Za-z]:[\\/]*) abs_ladir="$ladir" ;; + *) + abs_ladir=`cd "$ladir" && pwd` + if test -z "$abs_ladir"; then + func_warning "cannot determine absolute directory name of \`$ladir'" + func_warning "passing it literally to the linker, although it might fail" + abs_ladir="$ladir" + fi + ;; + esac + func_basename "$lib" + laname="$func_basename_result" + + # Find the relevant object directory and library name. + if test "X$installed" = Xyes; then + if test ! -f "$lt_sysroot$libdir/$linklib" && test -f "$abs_ladir/$linklib"; then + func_warning "library \`$lib' was moved." + dir="$ladir" + absdir="$abs_ladir" + libdir="$abs_ladir" + else + dir="$lt_sysroot$libdir" + absdir="$lt_sysroot$libdir" + fi + test "X$hardcode_automatic" = Xyes && avoidtemprpath=yes + else + if test ! -f "$ladir/$objdir/$linklib" && test -f "$abs_ladir/$linklib"; then + dir="$ladir" + absdir="$abs_ladir" + # Remove this search path later + func_append notinst_path " $abs_ladir" + else + dir="$ladir/$objdir" + absdir="$abs_ladir/$objdir" + # Remove this search path later + func_append notinst_path " $abs_ladir" + fi + fi # $installed = yes + func_stripname 'lib' '.la' "$laname" + name=$func_stripname_result + + # This library was specified with -dlpreopen. + if test "$pass" = dlpreopen; then + if test -z "$libdir" && test "$linkmode" = prog; then + func_fatal_error "only libraries may -dlpreopen a convenience library: \`$lib'" + fi + case "$host" in + # special handling for platforms with PE-DLLs. + *cygwin* | *mingw* | *cegcc* ) + # Linker will automatically link against shared library if both + # static and shared are present. Therefore, ensure we extract + # symbols from the import library if a shared library is present + # (otherwise, the dlopen module name will be incorrect). We do + # this by putting the import library name into $newdlprefiles. + # We recover the dlopen module name by 'saving' the la file + # name in a special purpose variable, and (later) extracting the + # dlname from the la file. + if test -n "$dlname"; then + func_tr_sh "$dir/$linklib" + eval "libfile_$func_tr_sh_result=\$abs_ladir/\$laname" + func_append newdlprefiles " $dir/$linklib" + else + func_append newdlprefiles " $dir/$old_library" + # Keep a list of preopened convenience libraries to check + # that they are being used correctly in the link pass. + test -z "$libdir" && \ + func_append dlpreconveniencelibs " $dir/$old_library" + fi + ;; + * ) + # Prefer using a static library (so that no silly _DYNAMIC symbols + # are required to link). + if test -n "$old_library"; then + func_append newdlprefiles " $dir/$old_library" + # Keep a list of preopened convenience libraries to check + # that they are being used correctly in the link pass. + test -z "$libdir" && \ + func_append dlpreconveniencelibs " $dir/$old_library" + # Otherwise, use the dlname, so that lt_dlopen finds it. + elif test -n "$dlname"; then + func_append newdlprefiles " $dir/$dlname" + else + func_append newdlprefiles " $dir/$linklib" + fi + ;; + esac + fi # $pass = dlpreopen + + if test -z "$libdir"; then + # Link the convenience library + if test "$linkmode" = lib; then + deplibs="$dir/$old_library $deplibs" + elif test "$linkmode,$pass" = "prog,link"; then + compile_deplibs="$dir/$old_library $compile_deplibs" + finalize_deplibs="$dir/$old_library $finalize_deplibs" + else + deplibs="$lib $deplibs" # used for prog,scan pass + fi + continue + fi + + + if test "$linkmode" = prog && test "$pass" != link; then + func_append newlib_search_path " $ladir" + deplibs="$lib $deplibs" + + linkalldeplibs=no + if test "$link_all_deplibs" != no || test -z "$library_names" || + test "$build_libtool_libs" = no; then + linkalldeplibs=yes + fi + + tmp_libs= + for deplib in $dependency_libs; do + case $deplib in + -L*) func_stripname '-L' '' "$deplib" + func_resolve_sysroot "$func_stripname_result" + func_append newlib_search_path " $func_resolve_sysroot_result" + ;; + esac + # Need to link against all dependency_libs? + if test "$linkalldeplibs" = yes; then + deplibs="$deplib $deplibs" + else + # Need to hardcode shared library paths + # or/and link against static libraries + newdependency_libs="$deplib $newdependency_libs" + fi + if $opt_preserve_dup_deps ; then + case "$tmp_libs " in + *" $deplib "*) func_append specialdeplibs " $deplib" ;; + esac + fi + func_append tmp_libs " $deplib" + done # for deplib + continue + fi # $linkmode = prog... + + if test "$linkmode,$pass" = "prog,link"; then + if test -n "$library_names" && + { { test "$prefer_static_libs" = no || + test "$prefer_static_libs,$installed" = "built,yes"; } || + test -z "$old_library"; }; then + # We need to hardcode the library path + if test -n "$shlibpath_var" && test -z "$avoidtemprpath" ; then + # Make sure the rpath contains only unique directories. + case "$temp_rpath:" in + *"$absdir:"*) ;; + *) func_append temp_rpath "$absdir:" ;; + esac + fi + + # Hardcode the library path. + # Skip directories that are in the system default run-time + # search path. + case " $sys_lib_dlsearch_path " in + *" $absdir "*) ;; + *) + case "$compile_rpath " in + *" $absdir "*) ;; + *) func_append compile_rpath " $absdir" ;; + esac + ;; + esac + case " $sys_lib_dlsearch_path " in + *" $libdir "*) ;; + *) + case "$finalize_rpath " in + *" $libdir "*) ;; + *) func_append finalize_rpath " $libdir" ;; + esac + ;; + esac + fi # $linkmode,$pass = prog,link... + + if test "$alldeplibs" = yes && + { test "$deplibs_check_method" = pass_all || + { test "$build_libtool_libs" = yes && + test -n "$library_names"; }; }; then + # We only need to search for static libraries + continue + fi + fi + + link_static=no # Whether the deplib will be linked statically + use_static_libs=$prefer_static_libs + if test "$use_static_libs" = built && test "$installed" = yes; then + use_static_libs=no + fi + if test -n "$library_names" && + { test "$use_static_libs" = no || test -z "$old_library"; }; then + case $host in + *cygwin* | *mingw* | *cegcc*) + # No point in relinking DLLs because paths are not encoded + func_append notinst_deplibs " $lib" + need_relink=no + ;; + *) + if test "$installed" = no; then + func_append notinst_deplibs " $lib" + need_relink=yes + fi + ;; + esac + # This is a shared library + + # Warn about portability, can't link against -module's on some + # systems (darwin). Don't bleat about dlopened modules though! + dlopenmodule="" + for dlpremoduletest in $dlprefiles; do + if test "X$dlpremoduletest" = "X$lib"; then + dlopenmodule="$dlpremoduletest" + break + fi + done + if test -z "$dlopenmodule" && test "$shouldnotlink" = yes && test "$pass" = link; then + echo + if test "$linkmode" = prog; then + $ECHO "*** Warning: Linking the executable $output against the loadable module" + else + $ECHO "*** Warning: Linking the shared library $output against the loadable module" + fi + $ECHO "*** $linklib is not portable!" + fi + if test "$linkmode" = lib && + test "$hardcode_into_libs" = yes; then + # Hardcode the library path. + # Skip directories that are in the system default run-time + # search path. + case " $sys_lib_dlsearch_path " in + *" $absdir "*) ;; + *) + case "$compile_rpath " in + *" $absdir "*) ;; + *) func_append compile_rpath " $absdir" ;; + esac + ;; + esac + case " $sys_lib_dlsearch_path " in + *" $libdir "*) ;; + *) + case "$finalize_rpath " in + *" $libdir "*) ;; + *) func_append finalize_rpath " $libdir" ;; + esac + ;; + esac + fi + + if test -n "$old_archive_from_expsyms_cmds"; then + # figure out the soname + set dummy $library_names + shift + realname="$1" + shift + libname=`eval "\\$ECHO \"$libname_spec\""` + # use dlname if we got it. it's perfectly good, no? + if test -n "$dlname"; then + soname="$dlname" + elif test -n "$soname_spec"; then + # bleh windows + case $host in + *cygwin* | mingw* | *cegcc*) + func_arith $current - $age + major=$func_arith_result + versuffix="-$major" + ;; + esac + eval soname=\"$soname_spec\" + else + soname="$realname" + fi + + # Make a new name for the extract_expsyms_cmds to use + soroot="$soname" + func_basename "$soroot" + soname="$func_basename_result" + func_stripname 'lib' '.dll' "$soname" + newlib=libimp-$func_stripname_result.a + + # If the library has no export list, then create one now + if test -f "$output_objdir/$soname-def"; then : + else + func_verbose "extracting exported symbol list from \`$soname'" + func_execute_cmds "$extract_expsyms_cmds" 'exit $?' + fi + + # Create $newlib + if test -f "$output_objdir/$newlib"; then :; else + func_verbose "generating import library for \`$soname'" + func_execute_cmds "$old_archive_from_expsyms_cmds" 'exit $?' + fi + # make sure the library variables are pointing to the new library + dir=$output_objdir + linklib=$newlib + fi # test -n "$old_archive_from_expsyms_cmds" + + if test "$linkmode" = prog || test "$opt_mode" != relink; then + add_shlibpath= + add_dir= + add= + lib_linked=yes + case $hardcode_action in + immediate | unsupported) + if test "$hardcode_direct" = no; then + add="$dir/$linklib" + case $host in + *-*-sco3.2v5.0.[024]*) add_dir="-L$dir" ;; + *-*-sysv4*uw2*) add_dir="-L$dir" ;; + *-*-sysv5OpenUNIX* | *-*-sysv5UnixWare7.[01].[10]* | \ + *-*-unixware7*) add_dir="-L$dir" ;; + *-*-darwin* ) + # if the lib is a (non-dlopened) module then we can not + # link against it, someone is ignoring the earlier warnings + if /usr/bin/file -L $add 2> /dev/null | + $GREP ": [^:]* bundle" >/dev/null ; then + if test "X$dlopenmodule" != "X$lib"; then + $ECHO "*** Warning: lib $linklib is a module, not a shared library" + if test -z "$old_library" ; then + echo + echo "*** And there doesn't seem to be a static archive available" + echo "*** The link will probably fail, sorry" + else + add="$dir/$old_library" + fi + elif test -n "$old_library"; then + add="$dir/$old_library" + fi + fi + esac + elif test "$hardcode_minus_L" = no; then + case $host in + *-*-sunos*) add_shlibpath="$dir" ;; + esac + add_dir="-L$dir" + add="-l$name" + elif test "$hardcode_shlibpath_var" = no; then + add_shlibpath="$dir" + add="-l$name" + else + lib_linked=no + fi + ;; + relink) + if test "$hardcode_direct" = yes && + test "$hardcode_direct_absolute" = no; then + add="$dir/$linklib" + elif test "$hardcode_minus_L" = yes; then + add_dir="-L$absdir" + # Try looking first in the location we're being installed to. + if test -n "$inst_prefix_dir"; then + case $libdir in + [\\/]*) + func_append add_dir " -L$inst_prefix_dir$libdir" + ;; + esac + fi + add="-l$name" + elif test "$hardcode_shlibpath_var" = yes; then + add_shlibpath="$dir" + add="-l$name" + else + lib_linked=no + fi + ;; + *) lib_linked=no ;; + esac + + if test "$lib_linked" != yes; then + func_fatal_configuration "unsupported hardcode properties" + fi + + if test -n "$add_shlibpath"; then + case :$compile_shlibpath: in + *":$add_shlibpath:"*) ;; + *) func_append compile_shlibpath "$add_shlibpath:" ;; + esac + fi + if test "$linkmode" = prog; then + test -n "$add_dir" && compile_deplibs="$add_dir $compile_deplibs" + test -n "$add" && compile_deplibs="$add $compile_deplibs" + else + test -n "$add_dir" && deplibs="$add_dir $deplibs" + test -n "$add" && deplibs="$add $deplibs" + if test "$hardcode_direct" != yes && + test "$hardcode_minus_L" != yes && + test "$hardcode_shlibpath_var" = yes; then + case :$finalize_shlibpath: in + *":$libdir:"*) ;; + *) func_append finalize_shlibpath "$libdir:" ;; + esac + fi + fi + fi + + if test "$linkmode" = prog || test "$opt_mode" = relink; then + add_shlibpath= + add_dir= + add= + # Finalize command for both is simple: just hardcode it. + if test "$hardcode_direct" = yes && + test "$hardcode_direct_absolute" = no; then + add="$libdir/$linklib" + elif test "$hardcode_minus_L" = yes; then + add_dir="-L$libdir" + add="-l$name" + elif test "$hardcode_shlibpath_var" = yes; then + case :$finalize_shlibpath: in + *":$libdir:"*) ;; + *) func_append finalize_shlibpath "$libdir:" ;; + esac + add="-l$name" + elif test "$hardcode_automatic" = yes; then + if test -n "$inst_prefix_dir" && + test -f "$inst_prefix_dir$libdir/$linklib" ; then + add="$inst_prefix_dir$libdir/$linklib" + else + add="$libdir/$linklib" + fi + else + # We cannot seem to hardcode it, guess we'll fake it. + add_dir="-L$libdir" + # Try looking first in the location we're being installed to. + if test -n "$inst_prefix_dir"; then + case $libdir in + [\\/]*) + func_append add_dir " -L$inst_prefix_dir$libdir" + ;; + esac + fi + add="-l$name" + fi + + if test "$linkmode" = prog; then + test -n "$add_dir" && finalize_deplibs="$add_dir $finalize_deplibs" + test -n "$add" && finalize_deplibs="$add $finalize_deplibs" + else + test -n "$add_dir" && deplibs="$add_dir $deplibs" + test -n "$add" && deplibs="$add $deplibs" + fi + fi + elif test "$linkmode" = prog; then + # Here we assume that one of hardcode_direct or hardcode_minus_L + # is not unsupported. This is valid on all known static and + # shared platforms. + if test "$hardcode_direct" != unsupported; then + test -n "$old_library" && linklib="$old_library" + compile_deplibs="$dir/$linklib $compile_deplibs" + finalize_deplibs="$dir/$linklib $finalize_deplibs" + else + compile_deplibs="-l$name -L$dir $compile_deplibs" + finalize_deplibs="-l$name -L$dir $finalize_deplibs" + fi + elif test "$build_libtool_libs" = yes; then + # Not a shared library + if test "$deplibs_check_method" != pass_all; then + # We're trying link a shared library against a static one + # but the system doesn't support it. + + # Just print a warning and add the library to dependency_libs so + # that the program can be linked against the static library. + echo + $ECHO "*** Warning: This system can not link to static lib archive $lib." + echo "*** I have the capability to make that library automatically link in when" + echo "*** you link to this library. But I can only do this if you have a" + echo "*** shared version of the library, which you do not appear to have." + if test "$module" = yes; then + echo "*** But as you try to build a module library, libtool will still create " + echo "*** a static module, that should work as long as the dlopening application" + echo "*** is linked with the -dlopen flag to resolve symbols at runtime." + if test -z "$global_symbol_pipe"; then + echo + echo "*** However, this would only work if libtool was able to extract symbol" + echo "*** lists from a program, using \`nm' or equivalent, but libtool could" + echo "*** not find such a program. So, this module is probably useless." + echo "*** \`nm' from GNU binutils and a full rebuild may help." + fi + if test "$build_old_libs" = no; then + build_libtool_libs=module + build_old_libs=yes + else + build_libtool_libs=no + fi + fi + else + deplibs="$dir/$old_library $deplibs" + link_static=yes + fi + fi # link shared/static library? + + if test "$linkmode" = lib; then + if test -n "$dependency_libs" && + { test "$hardcode_into_libs" != yes || + test "$build_old_libs" = yes || + test "$link_static" = yes; }; then + # Extract -R from dependency_libs + temp_deplibs= + for libdir in $dependency_libs; do + case $libdir in + -R*) func_stripname '-R' '' "$libdir" + temp_xrpath=$func_stripname_result + case " $xrpath " in + *" $temp_xrpath "*) ;; + *) func_append xrpath " $temp_xrpath";; + esac;; + *) func_append temp_deplibs " $libdir";; + esac + done + dependency_libs="$temp_deplibs" + fi + + func_append newlib_search_path " $absdir" + # Link against this library + test "$link_static" = no && newdependency_libs="$abs_ladir/$laname $newdependency_libs" + # ... and its dependency_libs + tmp_libs= + for deplib in $dependency_libs; do + newdependency_libs="$deplib $newdependency_libs" + case $deplib in + -L*) func_stripname '-L' '' "$deplib" + func_resolve_sysroot "$func_stripname_result";; + *) func_resolve_sysroot "$deplib" ;; + esac + if $opt_preserve_dup_deps ; then + case "$tmp_libs " in + *" $func_resolve_sysroot_result "*) + func_append specialdeplibs " $func_resolve_sysroot_result" ;; + esac + fi + func_append tmp_libs " $func_resolve_sysroot_result" + done + + if test "$link_all_deplibs" != no; then + # Add the search paths of all dependency libraries + for deplib in $dependency_libs; do + path= + case $deplib in + -L*) path="$deplib" ;; + *.la) + func_resolve_sysroot "$deplib" + deplib=$func_resolve_sysroot_result + func_dirname "$deplib" "" "." + dir=$func_dirname_result + # We need an absolute path. + case $dir in + [\\/]* | [A-Za-z]:[\\/]*) absdir="$dir" ;; + *) + absdir=`cd "$dir" && pwd` + if test -z "$absdir"; then + func_warning "cannot determine absolute directory name of \`$dir'" + absdir="$dir" + fi + ;; + esac + if $GREP "^installed=no" $deplib > /dev/null; then + case $host in + *-*-darwin*) + depdepl= + eval deplibrary_names=`${SED} -n -e 's/^library_names=\(.*\)$/\1/p' $deplib` + if test -n "$deplibrary_names" ; then + for tmp in $deplibrary_names ; do + depdepl=$tmp + done + if test -f "$absdir/$objdir/$depdepl" ; then + depdepl="$absdir/$objdir/$depdepl" + darwin_install_name=`${OTOOL} -L $depdepl | awk '{if (NR == 2) {print $1;exit}}'` + if test -z "$darwin_install_name"; then + darwin_install_name=`${OTOOL64} -L $depdepl | awk '{if (NR == 2) {print $1;exit}}'` + fi + func_append compiler_flags " ${wl}-dylib_file ${wl}${darwin_install_name}:${depdepl}" + func_append linker_flags " -dylib_file ${darwin_install_name}:${depdepl}" + path= + fi + fi + ;; + *) + path="-L$absdir/$objdir" + ;; + esac + else + eval libdir=`${SED} -n -e 's/^libdir=\(.*\)$/\1/p' $deplib` + test -z "$libdir" && \ + func_fatal_error "\`$deplib' is not a valid libtool archive" + test "$absdir" != "$libdir" && \ + func_warning "\`$deplib' seems to be moved" + + path="-L$absdir" + fi + ;; + esac + case " $deplibs " in + *" $path "*) ;; + *) deplibs="$path $deplibs" ;; + esac + done + fi # link_all_deplibs != no + fi # linkmode = lib + done # for deplib in $libs + if test "$pass" = link; then + if test "$linkmode" = "prog"; then + compile_deplibs="$new_inherited_linker_flags $compile_deplibs" + finalize_deplibs="$new_inherited_linker_flags $finalize_deplibs" + else + compiler_flags="$compiler_flags "`$ECHO " $new_inherited_linker_flags" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + fi + fi + dependency_libs="$newdependency_libs" + if test "$pass" = dlpreopen; then + # Link the dlpreopened libraries before other libraries + for deplib in $save_deplibs; do + deplibs="$deplib $deplibs" + done + fi + if test "$pass" != dlopen; then + if test "$pass" != conv; then + # Make sure lib_search_path contains only unique directories. + lib_search_path= + for dir in $newlib_search_path; do + case "$lib_search_path " in + *" $dir "*) ;; + *) func_append lib_search_path " $dir" ;; + esac + done + newlib_search_path= + fi + + if test "$linkmode,$pass" != "prog,link"; then + vars="deplibs" + else + vars="compile_deplibs finalize_deplibs" + fi + for var in $vars dependency_libs; do + # Add libraries to $var in reverse order + eval tmp_libs=\"\$$var\" + new_libs= + for deplib in $tmp_libs; do + # FIXME: Pedantically, this is the right thing to do, so + # that some nasty dependency loop isn't accidentally + # broken: + #new_libs="$deplib $new_libs" + # Pragmatically, this seems to cause very few problems in + # practice: + case $deplib in + -L*) new_libs="$deplib $new_libs" ;; + -R*) ;; + *) + # And here is the reason: when a library appears more + # than once as an explicit dependence of a library, or + # is implicitly linked in more than once by the + # compiler, it is considered special, and multiple + # occurrences thereof are not removed. Compare this + # with having the same library being listed as a + # dependency of multiple other libraries: in this case, + # we know (pedantically, we assume) the library does not + # need to be listed more than once, so we keep only the + # last copy. This is not always right, but it is rare + # enough that we require users that really mean to play + # such unportable linking tricks to link the library + # using -Wl,-lname, so that libtool does not consider it + # for duplicate removal. + case " $specialdeplibs " in + *" $deplib "*) new_libs="$deplib $new_libs" ;; + *) + case " $new_libs " in + *" $deplib "*) ;; + *) new_libs="$deplib $new_libs" ;; + esac + ;; + esac + ;; + esac + done + tmp_libs= + for deplib in $new_libs; do + case $deplib in + -L*) + case " $tmp_libs " in + *" $deplib "*) ;; + *) func_append tmp_libs " $deplib" ;; + esac + ;; + *) func_append tmp_libs " $deplib" ;; + esac + done + eval $var=\"$tmp_libs\" + done # for var + fi + # Last step: remove runtime libs from dependency_libs + # (they stay in deplibs) + tmp_libs= + for i in $dependency_libs ; do + case " $predeps $postdeps $compiler_lib_search_path " in + *" $i "*) + i="" + ;; + esac + if test -n "$i" ; then + func_append tmp_libs " $i" + fi + done + dependency_libs=$tmp_libs + done # for pass + if test "$linkmode" = prog; then + dlfiles="$newdlfiles" + fi + if test "$linkmode" = prog || test "$linkmode" = lib; then + dlprefiles="$newdlprefiles" + fi + + case $linkmode in + oldlib) + if test -n "$dlfiles$dlprefiles" || test "$dlself" != no; then + func_warning "\`-dlopen' is ignored for archives" + fi + + case " $deplibs" in + *\ -l* | *\ -L*) + func_warning "\`-l' and \`-L' are ignored for archives" ;; + esac + + test -n "$rpath" && \ + func_warning "\`-rpath' is ignored for archives" + + test -n "$xrpath" && \ + func_warning "\`-R' is ignored for archives" + + test -n "$vinfo" && \ + func_warning "\`-version-info/-version-number' is ignored for archives" + + test -n "$release" && \ + func_warning "\`-release' is ignored for archives" + + test -n "$export_symbols$export_symbols_regex" && \ + func_warning "\`-export-symbols' is ignored for archives" + + # Now set the variables for building old libraries. + build_libtool_libs=no + oldlibs="$output" + func_append objs "$old_deplibs" + ;; + + lib) + # Make sure we only generate libraries of the form `libNAME.la'. + case $outputname in + lib*) + func_stripname 'lib' '.la' "$outputname" + name=$func_stripname_result + eval shared_ext=\"$shrext_cmds\" + eval libname=\"$libname_spec\" + ;; + *) + test "$module" = no && \ + func_fatal_help "libtool library \`$output' must begin with \`lib'" + + if test "$need_lib_prefix" != no; then + # Add the "lib" prefix for modules if required + func_stripname '' '.la' "$outputname" + name=$func_stripname_result + eval shared_ext=\"$shrext_cmds\" + eval libname=\"$libname_spec\" + else + func_stripname '' '.la' "$outputname" + libname=$func_stripname_result + fi + ;; + esac + + if test -n "$objs"; then + if test "$deplibs_check_method" != pass_all; then + func_fatal_error "cannot build libtool library \`$output' from non-libtool objects on this host:$objs" + else + echo + $ECHO "*** Warning: Linking the shared library $output against the non-libtool" + $ECHO "*** objects $objs is not portable!" + func_append libobjs " $objs" + fi + fi + + test "$dlself" != no && \ + func_warning "\`-dlopen self' is ignored for libtool libraries" + + set dummy $rpath + shift + test "$#" -gt 1 && \ + func_warning "ignoring multiple \`-rpath's for a libtool library" + + install_libdir="$1" + + oldlibs= + if test -z "$rpath"; then + if test "$build_libtool_libs" = yes; then + # Building a libtool convenience library. + # Some compilers have problems with a `.al' extension so + # convenience libraries should have the same extension an + # archive normally would. + oldlibs="$output_objdir/$libname.$libext $oldlibs" + build_libtool_libs=convenience + build_old_libs=yes + fi + + test -n "$vinfo" && \ + func_warning "\`-version-info/-version-number' is ignored for convenience libraries" + + test -n "$release" && \ + func_warning "\`-release' is ignored for convenience libraries" + else + + # Parse the version information argument. + save_ifs="$IFS"; IFS=':' + set dummy $vinfo 0 0 0 + shift + IFS="$save_ifs" + + test -n "$7" && \ + func_fatal_help "too many parameters to \`-version-info'" + + # convert absolute version numbers to libtool ages + # this retains compatibility with .la files and attempts + # to make the code below a bit more comprehensible + + case $vinfo_number in + yes) + number_major="$1" + number_minor="$2" + number_revision="$3" + # + # There are really only two kinds -- those that + # use the current revision as the major version + # and those that subtract age and use age as + # a minor version. But, then there is irix + # which has an extra 1 added just for fun + # + case $version_type in + # correct linux to gnu/linux during the next big refactor + darwin|linux|osf|windows|none) + func_arith $number_major + $number_minor + current=$func_arith_result + age="$number_minor" + revision="$number_revision" + ;; + freebsd-aout|freebsd-elf|qnx|sunos) + current="$number_major" + revision="$number_minor" + age="0" + ;; + irix|nonstopux) + func_arith $number_major + $number_minor + current=$func_arith_result + age="$number_minor" + revision="$number_minor" + lt_irix_increment=no + ;; + esac + ;; + no) + current="$1" + revision="$2" + age="$3" + ;; + esac + + # Check that each of the things are valid numbers. + case $current in + 0|[1-9]|[1-9][0-9]|[1-9][0-9][0-9]|[1-9][0-9][0-9][0-9]|[1-9][0-9][0-9][0-9][0-9]) ;; + *) + func_error "CURRENT \`$current' must be a nonnegative integer" + func_fatal_error "\`$vinfo' is not valid version information" + ;; + esac + + case $revision in + 0|[1-9]|[1-9][0-9]|[1-9][0-9][0-9]|[1-9][0-9][0-9][0-9]|[1-9][0-9][0-9][0-9][0-9]) ;; + *) + func_error "REVISION \`$revision' must be a nonnegative integer" + func_fatal_error "\`$vinfo' is not valid version information" + ;; + esac + + case $age in + 0|[1-9]|[1-9][0-9]|[1-9][0-9][0-9]|[1-9][0-9][0-9][0-9]|[1-9][0-9][0-9][0-9][0-9]) ;; + *) + func_error "AGE \`$age' must be a nonnegative integer" + func_fatal_error "\`$vinfo' is not valid version information" + ;; + esac + + if test "$age" -gt "$current"; then + func_error "AGE \`$age' is greater than the current interface number \`$current'" + func_fatal_error "\`$vinfo' is not valid version information" + fi + + # Calculate the version variables. + major= + versuffix= + verstring= + case $version_type in + none) ;; + + darwin) + # Like Linux, but with the current version available in + # verstring for coding it into the library header + func_arith $current - $age + major=.$func_arith_result + versuffix="$major.$age.$revision" + # Darwin ld doesn't like 0 for these options... + func_arith $current + 1 + minor_current=$func_arith_result + xlcverstring="${wl}-compatibility_version ${wl}$minor_current ${wl}-current_version ${wl}$minor_current.$revision" + verstring="-compatibility_version $minor_current -current_version $minor_current.$revision" + ;; + + freebsd-aout) + major=".$current" + versuffix=".$current.$revision"; + ;; + + freebsd-elf) + major=".$current" + versuffix=".$current" + ;; + + irix | nonstopux) + if test "X$lt_irix_increment" = "Xno"; then + func_arith $current - $age + else + func_arith $current - $age + 1 + fi + major=$func_arith_result + + case $version_type in + nonstopux) verstring_prefix=nonstopux ;; + *) verstring_prefix=sgi ;; + esac + verstring="$verstring_prefix$major.$revision" + + # Add in all the interfaces that we are compatible with. + loop=$revision + while test "$loop" -ne 0; do + func_arith $revision - $loop + iface=$func_arith_result + func_arith $loop - 1 + loop=$func_arith_result + verstring="$verstring_prefix$major.$iface:$verstring" + done + + # Before this point, $major must not contain `.'. + major=.$major + versuffix="$major.$revision" + ;; + + linux) # correct to gnu/linux during the next big refactor + func_arith $current - $age + major=.$func_arith_result + versuffix="$major.$age.$revision" + ;; + + osf) + func_arith $current - $age + major=.$func_arith_result + versuffix=".$current.$age.$revision" + verstring="$current.$age.$revision" + + # Add in all the interfaces that we are compatible with. + loop=$age + while test "$loop" -ne 0; do + func_arith $current - $loop + iface=$func_arith_result + func_arith $loop - 1 + loop=$func_arith_result + verstring="$verstring:${iface}.0" + done + + # Make executables depend on our current version. + func_append verstring ":${current}.0" + ;; + + qnx) + major=".$current" + versuffix=".$current" + ;; + + sunos) + major=".$current" + versuffix=".$current.$revision" + ;; + + windows) + # Use '-' rather than '.', since we only want one + # extension on DOS 8.3 filesystems. + func_arith $current - $age + major=$func_arith_result + versuffix="-$major" + ;; + + *) + func_fatal_configuration "unknown library version type \`$version_type'" + ;; + esac + + # Clear the version info if we defaulted, and they specified a release. + if test -z "$vinfo" && test -n "$release"; then + major= + case $version_type in + darwin) + # we can't check for "0.0" in archive_cmds due to quoting + # problems, so we reset it completely + verstring= + ;; + *) + verstring="0.0" + ;; + esac + if test "$need_version" = no; then + versuffix= + else + versuffix=".0.0" + fi + fi + + # Remove version info from name if versioning should be avoided + if test "$avoid_version" = yes && test "$need_version" = no; then + major= + versuffix= + verstring="" + fi + + # Check to see if the archive will have undefined symbols. + if test "$allow_undefined" = yes; then + if test "$allow_undefined_flag" = unsupported; then + func_warning "undefined symbols not allowed in $host shared libraries" + build_libtool_libs=no + build_old_libs=yes + fi + else + # Don't allow undefined symbols. + allow_undefined_flag="$no_undefined_flag" + fi + + fi + + func_generate_dlsyms "$libname" "$libname" "yes" + func_append libobjs " $symfileobj" + test "X$libobjs" = "X " && libobjs= + + if test "$opt_mode" != relink; then + # Remove our outputs, but don't remove object files since they + # may have been created when compiling PIC objects. + removelist= + tempremovelist=`$ECHO "$output_objdir/*"` + for p in $tempremovelist; do + case $p in + *.$objext | *.gcno) + ;; + $output_objdir/$outputname | $output_objdir/$libname.* | $output_objdir/${libname}${release}.*) + if test "X$precious_files_regex" != "X"; then + if $ECHO "$p" | $EGREP -e "$precious_files_regex" >/dev/null 2>&1 + then + continue + fi + fi + func_append removelist " $p" + ;; + *) ;; + esac + done + test -n "$removelist" && \ + func_show_eval "${RM}r \$removelist" + fi + + # Now set the variables for building old libraries. + if test "$build_old_libs" = yes && test "$build_libtool_libs" != convenience ; then + func_append oldlibs " $output_objdir/$libname.$libext" + + # Transform .lo files to .o files. + oldobjs="$objs "`$ECHO "$libobjs" | $SP2NL | $SED "/\.${libext}$/d; $lo2o" | $NL2SP` + fi + + # Eliminate all temporary directories. + #for path in $notinst_path; do + # lib_search_path=`$ECHO "$lib_search_path " | $SED "s% $path % %g"` + # deplibs=`$ECHO "$deplibs " | $SED "s% -L$path % %g"` + # dependency_libs=`$ECHO "$dependency_libs " | $SED "s% -L$path % %g"` + #done + + if test -n "$xrpath"; then + # If the user specified any rpath flags, then add them. + temp_xrpath= + for libdir in $xrpath; do + func_replace_sysroot "$libdir" + func_append temp_xrpath " -R$func_replace_sysroot_result" + case "$finalize_rpath " in + *" $libdir "*) ;; + *) func_append finalize_rpath " $libdir" ;; + esac + done + if test "$hardcode_into_libs" != yes || test "$build_old_libs" = yes; then + dependency_libs="$temp_xrpath $dependency_libs" + fi + fi + + # Make sure dlfiles contains only unique files that won't be dlpreopened + old_dlfiles="$dlfiles" + dlfiles= + for lib in $old_dlfiles; do + case " $dlprefiles $dlfiles " in + *" $lib "*) ;; + *) func_append dlfiles " $lib" ;; + esac + done + + # Make sure dlprefiles contains only unique files + old_dlprefiles="$dlprefiles" + dlprefiles= + for lib in $old_dlprefiles; do + case "$dlprefiles " in + *" $lib "*) ;; + *) func_append dlprefiles " $lib" ;; + esac + done + + if test "$build_libtool_libs" = yes; then + if test -n "$rpath"; then + case $host in + *-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-os2* | *-*-beos* | *-cegcc* | *-*-haiku*) + # these systems don't actually have a c library (as such)! + ;; + *-*-rhapsody* | *-*-darwin1.[012]) + # Rhapsody C library is in the System framework + func_append deplibs " System.ltframework" + ;; + *-*-netbsd*) + # Don't link with libc until the a.out ld.so is fixed. + ;; + *-*-openbsd* | *-*-freebsd* | *-*-dragonfly*) + # Do not include libc due to us having libc/libc_r. + ;; + *-*-sco3.2v5* | *-*-sco5v6*) + # Causes problems with __ctype + ;; + *-*-sysv4.2uw2* | *-*-sysv5* | *-*-unixware* | *-*-OpenUNIX*) + # Compiler inserts libc in the correct place for threads to work + ;; + *) + # Add libc to deplibs on all other systems if necessary. + if test "$build_libtool_need_lc" = "yes"; then + func_append deplibs " -lc" + fi + ;; + esac + fi + + # Transform deplibs into only deplibs that can be linked in shared. + name_save=$name + libname_save=$libname + release_save=$release + versuffix_save=$versuffix + major_save=$major + # I'm not sure if I'm treating the release correctly. I think + # release should show up in the -l (ie -lgmp5) so we don't want to + # add it in twice. Is that correct? + release="" + versuffix="" + major="" + newdeplibs= + droppeddeps=no + case $deplibs_check_method in + pass_all) + # Don't check for shared/static. Everything works. + # This might be a little naive. We might want to check + # whether the library exists or not. But this is on + # osf3 & osf4 and I'm not really sure... Just + # implementing what was already the behavior. + newdeplibs=$deplibs + ;; + test_compile) + # This code stresses the "libraries are programs" paradigm to its + # limits. Maybe even breaks it. We compile a program, linking it + # against the deplibs as a proxy for the library. Then we can check + # whether they linked in statically or dynamically with ldd. + $opt_dry_run || $RM conftest.c + cat > conftest.c </dev/null` + $nocaseglob + else + potential_libs=`ls $i/$libnameglob[.-]* 2>/dev/null` + fi + for potent_lib in $potential_libs; do + # Follow soft links. + if ls -lLd "$potent_lib" 2>/dev/null | + $GREP " -> " >/dev/null; then + continue + fi + # The statement above tries to avoid entering an + # endless loop below, in case of cyclic links. + # We might still enter an endless loop, since a link + # loop can be closed while we follow links, + # but so what? + potlib="$potent_lib" + while test -h "$potlib" 2>/dev/null; do + potliblink=`ls -ld $potlib | ${SED} 's/.* -> //'` + case $potliblink in + [\\/]* | [A-Za-z]:[\\/]*) potlib="$potliblink";; + *) potlib=`$ECHO "$potlib" | $SED 's,[^/]*$,,'`"$potliblink";; + esac + done + if eval $file_magic_cmd \"\$potlib\" 2>/dev/null | + $SED -e 10q | + $EGREP "$file_magic_regex" > /dev/null; then + func_append newdeplibs " $a_deplib" + a_deplib="" + break 2 + fi + done + done + fi + if test -n "$a_deplib" ; then + droppeddeps=yes + echo + $ECHO "*** Warning: linker path does not have real file for library $a_deplib." + echo "*** I have the capability to make that library automatically link in when" + echo "*** you link to this library. But I can only do this if you have a" + echo "*** shared version of the library, which you do not appear to have" + echo "*** because I did check the linker path looking for a file starting" + if test -z "$potlib" ; then + $ECHO "*** with $libname but no candidates were found. (...for file magic test)" + else + $ECHO "*** with $libname and none of the candidates passed a file format test" + $ECHO "*** using a file magic. Last file checked: $potlib" + fi + fi + ;; + *) + # Add a -L argument. + func_append newdeplibs " $a_deplib" + ;; + esac + done # Gone through all deplibs. + ;; + match_pattern*) + set dummy $deplibs_check_method; shift + match_pattern_regex=`expr "$deplibs_check_method" : "$1 \(.*\)"` + for a_deplib in $deplibs; do + case $a_deplib in + -l*) + func_stripname -l '' "$a_deplib" + name=$func_stripname_result + if test "X$allow_libtool_libs_with_static_runtimes" = "Xyes" ; then + case " $predeps $postdeps " in + *" $a_deplib "*) + func_append newdeplibs " $a_deplib" + a_deplib="" + ;; + esac + fi + if test -n "$a_deplib" ; then + libname=`eval "\\$ECHO \"$libname_spec\""` + for i in $lib_search_path $sys_lib_search_path $shlib_search_path; do + potential_libs=`ls $i/$libname[.-]* 2>/dev/null` + for potent_lib in $potential_libs; do + potlib="$potent_lib" # see symlink-check above in file_magic test + if eval "\$ECHO \"$potent_lib\"" 2>/dev/null | $SED 10q | \ + $EGREP "$match_pattern_regex" > /dev/null; then + func_append newdeplibs " $a_deplib" + a_deplib="" + break 2 + fi + done + done + fi + if test -n "$a_deplib" ; then + droppeddeps=yes + echo + $ECHO "*** Warning: linker path does not have real file for library $a_deplib." + echo "*** I have the capability to make that library automatically link in when" + echo "*** you link to this library. But I can only do this if you have a" + echo "*** shared version of the library, which you do not appear to have" + echo "*** because I did check the linker path looking for a file starting" + if test -z "$potlib" ; then + $ECHO "*** with $libname but no candidates were found. (...for regex pattern test)" + else + $ECHO "*** with $libname and none of the candidates passed a file format test" + $ECHO "*** using a regex pattern. Last file checked: $potlib" + fi + fi + ;; + *) + # Add a -L argument. + func_append newdeplibs " $a_deplib" + ;; + esac + done # Gone through all deplibs. + ;; + none | unknown | *) + newdeplibs="" + tmp_deplibs=`$ECHO " $deplibs" | $SED 's/ -lc$//; s/ -[LR][^ ]*//g'` + if test "X$allow_libtool_libs_with_static_runtimes" = "Xyes" ; then + for i in $predeps $postdeps ; do + # can't use Xsed below, because $i might contain '/' + tmp_deplibs=`$ECHO " $tmp_deplibs" | $SED "s,$i,,"` + done + fi + case $tmp_deplibs in + *[!\ \ ]*) + echo + if test "X$deplibs_check_method" = "Xnone"; then + echo "*** Warning: inter-library dependencies are not supported in this platform." + else + echo "*** Warning: inter-library dependencies are not known to be supported." + fi + echo "*** All declared inter-library dependencies are being dropped." + droppeddeps=yes + ;; + esac + ;; + esac + versuffix=$versuffix_save + major=$major_save + release=$release_save + libname=$libname_save + name=$name_save + + case $host in + *-*-rhapsody* | *-*-darwin1.[012]) + # On Rhapsody replace the C library with the System framework + newdeplibs=`$ECHO " $newdeplibs" | $SED 's/ -lc / System.ltframework /'` + ;; + esac + + if test "$droppeddeps" = yes; then + if test "$module" = yes; then + echo + echo "*** Warning: libtool could not satisfy all declared inter-library" + $ECHO "*** dependencies of module $libname. Therefore, libtool will create" + echo "*** a static module, that should work as long as the dlopening" + echo "*** application is linked with the -dlopen flag." + if test -z "$global_symbol_pipe"; then + echo + echo "*** However, this would only work if libtool was able to extract symbol" + echo "*** lists from a program, using \`nm' or equivalent, but libtool could" + echo "*** not find such a program. So, this module is probably useless." + echo "*** \`nm' from GNU binutils and a full rebuild may help." + fi + if test "$build_old_libs" = no; then + oldlibs="$output_objdir/$libname.$libext" + build_libtool_libs=module + build_old_libs=yes + else + build_libtool_libs=no + fi + else + echo "*** The inter-library dependencies that have been dropped here will be" + echo "*** automatically added whenever a program is linked with this library" + echo "*** or is declared to -dlopen it." + + if test "$allow_undefined" = no; then + echo + echo "*** Since this library must not contain undefined symbols," + echo "*** because either the platform does not support them or" + echo "*** it was explicitly requested with -no-undefined," + echo "*** libtool will only create a static version of it." + if test "$build_old_libs" = no; then + oldlibs="$output_objdir/$libname.$libext" + build_libtool_libs=module + build_old_libs=yes + else + build_libtool_libs=no + fi + fi + fi + fi + # Done checking deplibs! + deplibs=$newdeplibs + fi + # Time to change all our "foo.ltframework" stuff back to "-framework foo" + case $host in + *-*-darwin*) + newdeplibs=`$ECHO " $newdeplibs" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + new_inherited_linker_flags=`$ECHO " $new_inherited_linker_flags" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + deplibs=`$ECHO " $deplibs" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + ;; + esac + + # move library search paths that coincide with paths to not yet + # installed libraries to the beginning of the library search list + new_libs= + for path in $notinst_path; do + case " $new_libs " in + *" -L$path/$objdir "*) ;; + *) + case " $deplibs " in + *" -L$path/$objdir "*) + func_append new_libs " -L$path/$objdir" ;; + esac + ;; + esac + done + for deplib in $deplibs; do + case $deplib in + -L*) + case " $new_libs " in + *" $deplib "*) ;; + *) func_append new_libs " $deplib" ;; + esac + ;; + *) func_append new_libs " $deplib" ;; + esac + done + deplibs="$new_libs" + + # All the library-specific variables (install_libdir is set above). + library_names= + old_library= + dlname= + + # Test again, we may have decided not to build it any more + if test "$build_libtool_libs" = yes; then + # Remove ${wl} instances when linking with ld. + # FIXME: should test the right _cmds variable. + case $archive_cmds in + *\$LD\ *) wl= ;; + esac + if test "$hardcode_into_libs" = yes; then + # Hardcode the library paths + hardcode_libdirs= + dep_rpath= + rpath="$finalize_rpath" + test "$opt_mode" != relink && rpath="$compile_rpath$rpath" + for libdir in $rpath; do + if test -n "$hardcode_libdir_flag_spec"; then + if test -n "$hardcode_libdir_separator"; then + func_replace_sysroot "$libdir" + libdir=$func_replace_sysroot_result + if test -z "$hardcode_libdirs"; then + hardcode_libdirs="$libdir" + else + # Just accumulate the unique libdirs. + case $hardcode_libdir_separator$hardcode_libdirs$hardcode_libdir_separator in + *"$hardcode_libdir_separator$libdir$hardcode_libdir_separator"*) + ;; + *) + func_append hardcode_libdirs "$hardcode_libdir_separator$libdir" + ;; + esac + fi + else + eval flag=\"$hardcode_libdir_flag_spec\" + func_append dep_rpath " $flag" + fi + elif test -n "$runpath_var"; then + case "$perm_rpath " in + *" $libdir "*) ;; + *) func_append perm_rpath " $libdir" ;; + esac + fi + done + # Substitute the hardcoded libdirs into the rpath. + if test -n "$hardcode_libdir_separator" && + test -n "$hardcode_libdirs"; then + libdir="$hardcode_libdirs" + eval "dep_rpath=\"$hardcode_libdir_flag_spec\"" + fi + if test -n "$runpath_var" && test -n "$perm_rpath"; then + # We should set the runpath_var. + rpath= + for dir in $perm_rpath; do + func_append rpath "$dir:" + done + eval "$runpath_var='$rpath\$$runpath_var'; export $runpath_var" + fi + test -n "$dep_rpath" && deplibs="$dep_rpath $deplibs" + fi + + shlibpath="$finalize_shlibpath" + test "$opt_mode" != relink && shlibpath="$compile_shlibpath$shlibpath" + if test -n "$shlibpath"; then + eval "$shlibpath_var='$shlibpath\$$shlibpath_var'; export $shlibpath_var" + fi + + # Get the real and link names of the library. + eval shared_ext=\"$shrext_cmds\" + eval library_names=\"$library_names_spec\" + set dummy $library_names + shift + realname="$1" + shift + + if test -n "$soname_spec"; then + eval soname=\"$soname_spec\" + else + soname="$realname" + fi + if test -z "$dlname"; then + dlname=$soname + fi + + lib="$output_objdir/$realname" + linknames= + for link + do + func_append linknames " $link" + done + + # Use standard objects if they are pic + test -z "$pic_flag" && libobjs=`$ECHO "$libobjs" | $SP2NL | $SED "$lo2o" | $NL2SP` + test "X$libobjs" = "X " && libobjs= + + delfiles= + if test -n "$export_symbols" && test -n "$include_expsyms"; then + $opt_dry_run || cp "$export_symbols" "$output_objdir/$libname.uexp" + export_symbols="$output_objdir/$libname.uexp" + func_append delfiles " $export_symbols" + fi + + orig_export_symbols= + case $host_os in + cygwin* | mingw* | cegcc*) + if test -n "$export_symbols" && test -z "$export_symbols_regex"; then + # exporting using user supplied symfile + if test "x`$SED 1q $export_symbols`" != xEXPORTS; then + # and it's NOT already a .def file. Must figure out + # which of the given symbols are data symbols and tag + # them as such. So, trigger use of export_symbols_cmds. + # export_symbols gets reassigned inside the "prepare + # the list of exported symbols" if statement, so the + # include_expsyms logic still works. + orig_export_symbols="$export_symbols" + export_symbols= + always_export_symbols=yes + fi + fi + ;; + esac + + # Prepare the list of exported symbols + if test -z "$export_symbols"; then + if test "$always_export_symbols" = yes || test -n "$export_symbols_regex"; then + func_verbose "generating symbol list for \`$libname.la'" + export_symbols="$output_objdir/$libname.exp" + $opt_dry_run || $RM $export_symbols + cmds=$export_symbols_cmds + save_ifs="$IFS"; IFS='~' + for cmd1 in $cmds; do + IFS="$save_ifs" + # Take the normal branch if the nm_file_list_spec branch + # doesn't work or if tool conversion is not needed. + case $nm_file_list_spec~$to_tool_file_cmd in + *~func_convert_file_noop | *~func_convert_file_msys_to_w32 | ~*) + try_normal_branch=yes + eval cmd=\"$cmd1\" + func_len " $cmd" + len=$func_len_result + ;; + *) + try_normal_branch=no + ;; + esac + if test "$try_normal_branch" = yes \ + && { test "$len" -lt "$max_cmd_len" \ + || test "$max_cmd_len" -le -1; } + then + func_show_eval "$cmd" 'exit $?' + skipped_export=false + elif test -n "$nm_file_list_spec"; then + func_basename "$output" + output_la=$func_basename_result + save_libobjs=$libobjs + save_output=$output + output=${output_objdir}/${output_la}.nm + func_to_tool_file "$output" + libobjs=$nm_file_list_spec$func_to_tool_file_result + func_append delfiles " $output" + func_verbose "creating $NM input file list: $output" + for obj in $save_libobjs; do + func_to_tool_file "$obj" + $ECHO "$func_to_tool_file_result" + done > "$output" + eval cmd=\"$cmd1\" + func_show_eval "$cmd" 'exit $?' + output=$save_output + libobjs=$save_libobjs + skipped_export=false + else + # The command line is too long to execute in one step. + func_verbose "using reloadable object file for export list..." + skipped_export=: + # Break out early, otherwise skipped_export may be + # set to false by a later but shorter cmd. + break + fi + done + IFS="$save_ifs" + if test -n "$export_symbols_regex" && test "X$skipped_export" != "X:"; then + func_show_eval '$EGREP -e "$export_symbols_regex" "$export_symbols" > "${export_symbols}T"' + func_show_eval '$MV "${export_symbols}T" "$export_symbols"' + fi + fi + fi + + if test -n "$export_symbols" && test -n "$include_expsyms"; then + tmp_export_symbols="$export_symbols" + test -n "$orig_export_symbols" && tmp_export_symbols="$orig_export_symbols" + $opt_dry_run || eval '$ECHO "$include_expsyms" | $SP2NL >> "$tmp_export_symbols"' + fi + + if test "X$skipped_export" != "X:" && test -n "$orig_export_symbols"; then + # The given exports_symbols file has to be filtered, so filter it. + func_verbose "filter symbol list for \`$libname.la' to tag DATA exports" + # FIXME: $output_objdir/$libname.filter potentially contains lots of + # 's' commands which not all seds can handle. GNU sed should be fine + # though. Also, the filter scales superlinearly with the number of + # global variables. join(1) would be nice here, but unfortunately + # isn't a blessed tool. + $opt_dry_run || $SED -e '/[ ,]DATA/!d;s,\(.*\)\([ \,].*\),s|^\1$|\1\2|,' < $export_symbols > $output_objdir/$libname.filter + func_append delfiles " $export_symbols $output_objdir/$libname.filter" + export_symbols=$output_objdir/$libname.def + $opt_dry_run || $SED -f $output_objdir/$libname.filter < $orig_export_symbols > $export_symbols + fi + + tmp_deplibs= + for test_deplib in $deplibs; do + case " $convenience " in + *" $test_deplib "*) ;; + *) + func_append tmp_deplibs " $test_deplib" + ;; + esac + done + deplibs="$tmp_deplibs" + + if test -n "$convenience"; then + if test -n "$whole_archive_flag_spec" && + test "$compiler_needs_object" = yes && + test -z "$libobjs"; then + # extract the archives, so we have objects to list. + # TODO: could optimize this to just extract one archive. + whole_archive_flag_spec= + fi + if test -n "$whole_archive_flag_spec"; then + save_libobjs=$libobjs + eval libobjs=\"\$libobjs $whole_archive_flag_spec\" + test "X$libobjs" = "X " && libobjs= + else + gentop="$output_objdir/${outputname}x" + func_append generated " $gentop" + + func_extract_archives $gentop $convenience + func_append libobjs " $func_extract_archives_result" + test "X$libobjs" = "X " && libobjs= + fi + fi + + if test "$thread_safe" = yes && test -n "$thread_safe_flag_spec"; then + eval flag=\"$thread_safe_flag_spec\" + func_append linker_flags " $flag" + fi + + # Make a backup of the uninstalled library when relinking + if test "$opt_mode" = relink; then + $opt_dry_run || eval '(cd $output_objdir && $RM ${realname}U && $MV $realname ${realname}U)' || exit $? + fi + + # Do each of the archive commands. + if test "$module" = yes && test -n "$module_cmds" ; then + if test -n "$export_symbols" && test -n "$module_expsym_cmds"; then + eval test_cmds=\"$module_expsym_cmds\" + cmds=$module_expsym_cmds + else + eval test_cmds=\"$module_cmds\" + cmds=$module_cmds + fi + else + if test -n "$export_symbols" && test -n "$archive_expsym_cmds"; then + eval test_cmds=\"$archive_expsym_cmds\" + cmds=$archive_expsym_cmds + else + eval test_cmds=\"$archive_cmds\" + cmds=$archive_cmds + fi + fi + + if test "X$skipped_export" != "X:" && + func_len " $test_cmds" && + len=$func_len_result && + test "$len" -lt "$max_cmd_len" || test "$max_cmd_len" -le -1; then + : + else + # The command line is too long to link in one step, link piecewise + # or, if using GNU ld and skipped_export is not :, use a linker + # script. + + # Save the value of $output and $libobjs because we want to + # use them later. If we have whole_archive_flag_spec, we + # want to use save_libobjs as it was before + # whole_archive_flag_spec was expanded, because we can't + # assume the linker understands whole_archive_flag_spec. + # This may have to be revisited, in case too many + # convenience libraries get linked in and end up exceeding + # the spec. + if test -z "$convenience" || test -z "$whole_archive_flag_spec"; then + save_libobjs=$libobjs + fi + save_output=$output + func_basename "$output" + output_la=$func_basename_result + + # Clear the reloadable object creation command queue and + # initialize k to one. + test_cmds= + concat_cmds= + objlist= + last_robj= + k=1 + + if test -n "$save_libobjs" && test "X$skipped_export" != "X:" && test "$with_gnu_ld" = yes; then + output=${output_objdir}/${output_la}.lnkscript + func_verbose "creating GNU ld script: $output" + echo 'INPUT (' > $output + for obj in $save_libobjs + do + func_to_tool_file "$obj" + $ECHO "$func_to_tool_file_result" >> $output + done + echo ')' >> $output + func_append delfiles " $output" + func_to_tool_file "$output" + output=$func_to_tool_file_result + elif test -n "$save_libobjs" && test "X$skipped_export" != "X:" && test "X$file_list_spec" != X; then + output=${output_objdir}/${output_la}.lnk + func_verbose "creating linker input file list: $output" + : > $output + set x $save_libobjs + shift + firstobj= + if test "$compiler_needs_object" = yes; then + firstobj="$1 " + shift + fi + for obj + do + func_to_tool_file "$obj" + $ECHO "$func_to_tool_file_result" >> $output + done + func_append delfiles " $output" + func_to_tool_file "$output" + output=$firstobj\"$file_list_spec$func_to_tool_file_result\" + else + if test -n "$save_libobjs"; then + func_verbose "creating reloadable object files..." + output=$output_objdir/$output_la-${k}.$objext + eval test_cmds=\"$reload_cmds\" + func_len " $test_cmds" + len0=$func_len_result + len=$len0 + + # Loop over the list of objects to be linked. + for obj in $save_libobjs + do + func_len " $obj" + func_arith $len + $func_len_result + len=$func_arith_result + if test "X$objlist" = X || + test "$len" -lt "$max_cmd_len"; then + func_append objlist " $obj" + else + # The command $test_cmds is almost too long, add a + # command to the queue. + if test "$k" -eq 1 ; then + # The first file doesn't have a previous command to add. + reload_objs=$objlist + eval concat_cmds=\"$reload_cmds\" + else + # All subsequent reloadable object files will link in + # the last one created. + reload_objs="$objlist $last_robj" + eval concat_cmds=\"\$concat_cmds~$reload_cmds~\$RM $last_robj\" + fi + last_robj=$output_objdir/$output_la-${k}.$objext + func_arith $k + 1 + k=$func_arith_result + output=$output_objdir/$output_la-${k}.$objext + objlist=" $obj" + func_len " $last_robj" + func_arith $len0 + $func_len_result + len=$func_arith_result + fi + done + # Handle the remaining objects by creating one last + # reloadable object file. All subsequent reloadable object + # files will link in the last one created. + test -z "$concat_cmds" || concat_cmds=$concat_cmds~ + reload_objs="$objlist $last_robj" + eval concat_cmds=\"\${concat_cmds}$reload_cmds\" + if test -n "$last_robj"; then + eval concat_cmds=\"\${concat_cmds}~\$RM $last_robj\" + fi + func_append delfiles " $output" + + else + output= + fi + + if ${skipped_export-false}; then + func_verbose "generating symbol list for \`$libname.la'" + export_symbols="$output_objdir/$libname.exp" + $opt_dry_run || $RM $export_symbols + libobjs=$output + # Append the command to create the export file. + test -z "$concat_cmds" || concat_cmds=$concat_cmds~ + eval concat_cmds=\"\$concat_cmds$export_symbols_cmds\" + if test -n "$last_robj"; then + eval concat_cmds=\"\$concat_cmds~\$RM $last_robj\" + fi + fi + + test -n "$save_libobjs" && + func_verbose "creating a temporary reloadable object file: $output" + + # Loop through the commands generated above and execute them. + save_ifs="$IFS"; IFS='~' + for cmd in $concat_cmds; do + IFS="$save_ifs" + $opt_silent || { + func_quote_for_expand "$cmd" + eval "func_echo $func_quote_for_expand_result" + } + $opt_dry_run || eval "$cmd" || { + lt_exit=$? + + # Restore the uninstalled library and exit + if test "$opt_mode" = relink; then + ( cd "$output_objdir" && \ + $RM "${realname}T" && \ + $MV "${realname}U" "$realname" ) + fi + + exit $lt_exit + } + done + IFS="$save_ifs" + + if test -n "$export_symbols_regex" && ${skipped_export-false}; then + func_show_eval '$EGREP -e "$export_symbols_regex" "$export_symbols" > "${export_symbols}T"' + func_show_eval '$MV "${export_symbols}T" "$export_symbols"' + fi + fi + + if ${skipped_export-false}; then + if test -n "$export_symbols" && test -n "$include_expsyms"; then + tmp_export_symbols="$export_symbols" + test -n "$orig_export_symbols" && tmp_export_symbols="$orig_export_symbols" + $opt_dry_run || eval '$ECHO "$include_expsyms" | $SP2NL >> "$tmp_export_symbols"' + fi + + if test -n "$orig_export_symbols"; then + # The given exports_symbols file has to be filtered, so filter it. + func_verbose "filter symbol list for \`$libname.la' to tag DATA exports" + # FIXME: $output_objdir/$libname.filter potentially contains lots of + # 's' commands which not all seds can handle. GNU sed should be fine + # though. Also, the filter scales superlinearly with the number of + # global variables. join(1) would be nice here, but unfortunately + # isn't a blessed tool. + $opt_dry_run || $SED -e '/[ ,]DATA/!d;s,\(.*\)\([ \,].*\),s|^\1$|\1\2|,' < $export_symbols > $output_objdir/$libname.filter + func_append delfiles " $export_symbols $output_objdir/$libname.filter" + export_symbols=$output_objdir/$libname.def + $opt_dry_run || $SED -f $output_objdir/$libname.filter < $orig_export_symbols > $export_symbols + fi + fi + + libobjs=$output + # Restore the value of output. + output=$save_output + + if test -n "$convenience" && test -n "$whole_archive_flag_spec"; then + eval libobjs=\"\$libobjs $whole_archive_flag_spec\" + test "X$libobjs" = "X " && libobjs= + fi + # Expand the library linking commands again to reset the + # value of $libobjs for piecewise linking. + + # Do each of the archive commands. + if test "$module" = yes && test -n "$module_cmds" ; then + if test -n "$export_symbols" && test -n "$module_expsym_cmds"; then + cmds=$module_expsym_cmds + else + cmds=$module_cmds + fi + else + if test -n "$export_symbols" && test -n "$archive_expsym_cmds"; then + cmds=$archive_expsym_cmds + else + cmds=$archive_cmds + fi + fi + fi + + if test -n "$delfiles"; then + # Append the command to remove temporary files to $cmds. + eval cmds=\"\$cmds~\$RM $delfiles\" + fi + + # Add any objects from preloaded convenience libraries + if test -n "$dlprefiles"; then + gentop="$output_objdir/${outputname}x" + func_append generated " $gentop" + + func_extract_archives $gentop $dlprefiles + func_append libobjs " $func_extract_archives_result" + test "X$libobjs" = "X " && libobjs= + fi + + save_ifs="$IFS"; IFS='~' + for cmd in $cmds; do + IFS="$save_ifs" + eval cmd=\"$cmd\" + $opt_silent || { + func_quote_for_expand "$cmd" + eval "func_echo $func_quote_for_expand_result" + } + $opt_dry_run || eval "$cmd" || { + lt_exit=$? + + # Restore the uninstalled library and exit + if test "$opt_mode" = relink; then + ( cd "$output_objdir" && \ + $RM "${realname}T" && \ + $MV "${realname}U" "$realname" ) + fi + + exit $lt_exit + } + done + IFS="$save_ifs" + + # Restore the uninstalled library and exit + if test "$opt_mode" = relink; then + $opt_dry_run || eval '(cd $output_objdir && $RM ${realname}T && $MV $realname ${realname}T && $MV ${realname}U $realname)' || exit $? + + if test -n "$convenience"; then + if test -z "$whole_archive_flag_spec"; then + func_show_eval '${RM}r "$gentop"' + fi + fi + + exit $EXIT_SUCCESS + fi + + # Create links to the real library. + for linkname in $linknames; do + if test "$realname" != "$linkname"; then + func_show_eval '(cd "$output_objdir" && $RM "$linkname" && $LN_S "$realname" "$linkname")' 'exit $?' + fi + done + + # If -module or -export-dynamic was specified, set the dlname. + if test "$module" = yes || test "$export_dynamic" = yes; then + # On all known operating systems, these are identical. + dlname="$soname" + fi + fi + ;; + + obj) + if test -n "$dlfiles$dlprefiles" || test "$dlself" != no; then + func_warning "\`-dlopen' is ignored for objects" + fi + + case " $deplibs" in + *\ -l* | *\ -L*) + func_warning "\`-l' and \`-L' are ignored for objects" ;; + esac + + test -n "$rpath" && \ + func_warning "\`-rpath' is ignored for objects" + + test -n "$xrpath" && \ + func_warning "\`-R' is ignored for objects" + + test -n "$vinfo" && \ + func_warning "\`-version-info' is ignored for objects" + + test -n "$release" && \ + func_warning "\`-release' is ignored for objects" + + case $output in + *.lo) + test -n "$objs$old_deplibs" && \ + func_fatal_error "cannot build library object \`$output' from non-libtool objects" + + libobj=$output + func_lo2o "$libobj" + obj=$func_lo2o_result + ;; + *) + libobj= + obj="$output" + ;; + esac + + # Delete the old objects. + $opt_dry_run || $RM $obj $libobj + + # Objects from convenience libraries. This assumes + # single-version convenience libraries. Whenever we create + # different ones for PIC/non-PIC, this we'll have to duplicate + # the extraction. + reload_conv_objs= + gentop= + # reload_cmds runs $LD directly, so let us get rid of + # -Wl from whole_archive_flag_spec and hope we can get by with + # turning comma into space.. + wl= + + if test -n "$convenience"; then + if test -n "$whole_archive_flag_spec"; then + eval tmp_whole_archive_flags=\"$whole_archive_flag_spec\" + reload_conv_objs=$reload_objs\ `$ECHO "$tmp_whole_archive_flags" | $SED 's|,| |g'` + else + gentop="$output_objdir/${obj}x" + func_append generated " $gentop" + + func_extract_archives $gentop $convenience + reload_conv_objs="$reload_objs $func_extract_archives_result" + fi + fi + + # If we're not building shared, we need to use non_pic_objs + test "$build_libtool_libs" != yes && libobjs="$non_pic_objects" + + # Create the old-style object. + reload_objs="$objs$old_deplibs "`$ECHO "$libobjs" | $SP2NL | $SED "/\.${libext}$/d; /\.lib$/d; $lo2o" | $NL2SP`" $reload_conv_objs" ### testsuite: skip nested quoting test + + output="$obj" + func_execute_cmds "$reload_cmds" 'exit $?' + + # Exit if we aren't doing a library object file. + if test -z "$libobj"; then + if test -n "$gentop"; then + func_show_eval '${RM}r "$gentop"' + fi + + exit $EXIT_SUCCESS + fi + + if test "$build_libtool_libs" != yes; then + if test -n "$gentop"; then + func_show_eval '${RM}r "$gentop"' + fi + + # Create an invalid libtool object if no PIC, so that we don't + # accidentally link it into a program. + # $show "echo timestamp > $libobj" + # $opt_dry_run || eval "echo timestamp > $libobj" || exit $? + exit $EXIT_SUCCESS + fi + + if test -n "$pic_flag" || test "$pic_mode" != default; then + # Only do commands if we really have different PIC objects. + reload_objs="$libobjs $reload_conv_objs" + output="$libobj" + func_execute_cmds "$reload_cmds" 'exit $?' + fi + + if test -n "$gentop"; then + func_show_eval '${RM}r "$gentop"' + fi + + exit $EXIT_SUCCESS + ;; + + prog) + case $host in + *cygwin*) func_stripname '' '.exe' "$output" + output=$func_stripname_result.exe;; + esac + test -n "$vinfo" && \ + func_warning "\`-version-info' is ignored for programs" + + test -n "$release" && \ + func_warning "\`-release' is ignored for programs" + + test "$preload" = yes \ + && test "$dlopen_support" = unknown \ + && test "$dlopen_self" = unknown \ + && test "$dlopen_self_static" = unknown && \ + func_warning "\`LT_INIT([dlopen])' not used. Assuming no dlopen support." + + case $host in + *-*-rhapsody* | *-*-darwin1.[012]) + # On Rhapsody replace the C library is the System framework + compile_deplibs=`$ECHO " $compile_deplibs" | $SED 's/ -lc / System.ltframework /'` + finalize_deplibs=`$ECHO " $finalize_deplibs" | $SED 's/ -lc / System.ltframework /'` + ;; + esac + + case $host in + *-*-darwin*) + # Don't allow lazy linking, it breaks C++ global constructors + # But is supposedly fixed on 10.4 or later (yay!). + if test "$tagname" = CXX ; then + case ${MACOSX_DEPLOYMENT_TARGET-10.0} in + 10.[0123]) + func_append compile_command " ${wl}-bind_at_load" + func_append finalize_command " ${wl}-bind_at_load" + ;; + esac + fi + # Time to change all our "foo.ltframework" stuff back to "-framework foo" + compile_deplibs=`$ECHO " $compile_deplibs" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + finalize_deplibs=`$ECHO " $finalize_deplibs" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + ;; + esac + + + # move library search paths that coincide with paths to not yet + # installed libraries to the beginning of the library search list + new_libs= + for path in $notinst_path; do + case " $new_libs " in + *" -L$path/$objdir "*) ;; + *) + case " $compile_deplibs " in + *" -L$path/$objdir "*) + func_append new_libs " -L$path/$objdir" ;; + esac + ;; + esac + done + for deplib in $compile_deplibs; do + case $deplib in + -L*) + case " $new_libs " in + *" $deplib "*) ;; + *) func_append new_libs " $deplib" ;; + esac + ;; + *) func_append new_libs " $deplib" ;; + esac + done + compile_deplibs="$new_libs" + + + func_append compile_command " $compile_deplibs" + func_append finalize_command " $finalize_deplibs" + + if test -n "$rpath$xrpath"; then + # If the user specified any rpath flags, then add them. + for libdir in $rpath $xrpath; do + # This is the magic to use -rpath. + case "$finalize_rpath " in + *" $libdir "*) ;; + *) func_append finalize_rpath " $libdir" ;; + esac + done + fi + + # Now hardcode the library paths + rpath= + hardcode_libdirs= + for libdir in $compile_rpath $finalize_rpath; do + if test -n "$hardcode_libdir_flag_spec"; then + if test -n "$hardcode_libdir_separator"; then + if test -z "$hardcode_libdirs"; then + hardcode_libdirs="$libdir" + else + # Just accumulate the unique libdirs. + case $hardcode_libdir_separator$hardcode_libdirs$hardcode_libdir_separator in + *"$hardcode_libdir_separator$libdir$hardcode_libdir_separator"*) + ;; + *) + func_append hardcode_libdirs "$hardcode_libdir_separator$libdir" + ;; + esac + fi + else + eval flag=\"$hardcode_libdir_flag_spec\" + func_append rpath " $flag" + fi + elif test -n "$runpath_var"; then + case "$perm_rpath " in + *" $libdir "*) ;; + *) func_append perm_rpath " $libdir" ;; + esac + fi + case $host in + *-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-os2* | *-cegcc*) + testbindir=`${ECHO} "$libdir" | ${SED} -e 's*/lib$*/bin*'` + case :$dllsearchpath: in + *":$libdir:"*) ;; + ::) dllsearchpath=$libdir;; + *) func_append dllsearchpath ":$libdir";; + esac + case :$dllsearchpath: in + *":$testbindir:"*) ;; + ::) dllsearchpath=$testbindir;; + *) func_append dllsearchpath ":$testbindir";; + esac + ;; + esac + done + # Substitute the hardcoded libdirs into the rpath. + if test -n "$hardcode_libdir_separator" && + test -n "$hardcode_libdirs"; then + libdir="$hardcode_libdirs" + eval rpath=\" $hardcode_libdir_flag_spec\" + fi + compile_rpath="$rpath" + + rpath= + hardcode_libdirs= + for libdir in $finalize_rpath; do + if test -n "$hardcode_libdir_flag_spec"; then + if test -n "$hardcode_libdir_separator"; then + if test -z "$hardcode_libdirs"; then + hardcode_libdirs="$libdir" + else + # Just accumulate the unique libdirs. + case $hardcode_libdir_separator$hardcode_libdirs$hardcode_libdir_separator in + *"$hardcode_libdir_separator$libdir$hardcode_libdir_separator"*) + ;; + *) + func_append hardcode_libdirs "$hardcode_libdir_separator$libdir" + ;; + esac + fi + else + eval flag=\"$hardcode_libdir_flag_spec\" + func_append rpath " $flag" + fi + elif test -n "$runpath_var"; then + case "$finalize_perm_rpath " in + *" $libdir "*) ;; + *) func_append finalize_perm_rpath " $libdir" ;; + esac + fi + done + # Substitute the hardcoded libdirs into the rpath. + if test -n "$hardcode_libdir_separator" && + test -n "$hardcode_libdirs"; then + libdir="$hardcode_libdirs" + eval rpath=\" $hardcode_libdir_flag_spec\" + fi + finalize_rpath="$rpath" + + if test -n "$libobjs" && test "$build_old_libs" = yes; then + # Transform all the library objects into standard objects. + compile_command=`$ECHO "$compile_command" | $SP2NL | $SED "$lo2o" | $NL2SP` + finalize_command=`$ECHO "$finalize_command" | $SP2NL | $SED "$lo2o" | $NL2SP` + fi + + func_generate_dlsyms "$outputname" "@PROGRAM@" "no" + + # template prelinking step + if test -n "$prelink_cmds"; then + func_execute_cmds "$prelink_cmds" 'exit $?' + fi + + wrappers_required=yes + case $host in + *cegcc* | *mingw32ce*) + # Disable wrappers for cegcc and mingw32ce hosts, we are cross compiling anyway. + wrappers_required=no + ;; + *cygwin* | *mingw* ) + if test "$build_libtool_libs" != yes; then + wrappers_required=no + fi + ;; + *) + if test "$need_relink" = no || test "$build_libtool_libs" != yes; then + wrappers_required=no + fi + ;; + esac + if test "$wrappers_required" = no; then + # Replace the output file specification. + compile_command=`$ECHO "$compile_command" | $SED 's%@OUTPUT@%'"$output"'%g'` + link_command="$compile_command$compile_rpath" + + # We have no uninstalled library dependencies, so finalize right now. + exit_status=0 + func_show_eval "$link_command" 'exit_status=$?' + + if test -n "$postlink_cmds"; then + func_to_tool_file "$output" + postlink_cmds=`func_echo_all "$postlink_cmds" | $SED -e 's%@OUTPUT@%'"$output"'%g' -e 's%@TOOL_OUTPUT@%'"$func_to_tool_file_result"'%g'` + func_execute_cmds "$postlink_cmds" 'exit $?' + fi + + # Delete the generated files. + if test -f "$output_objdir/${outputname}S.${objext}"; then + func_show_eval '$RM "$output_objdir/${outputname}S.${objext}"' + fi + + exit $exit_status + fi + + if test -n "$compile_shlibpath$finalize_shlibpath"; then + compile_command="$shlibpath_var=\"$compile_shlibpath$finalize_shlibpath\$$shlibpath_var\" $compile_command" + fi + if test -n "$finalize_shlibpath"; then + finalize_command="$shlibpath_var=\"$finalize_shlibpath\$$shlibpath_var\" $finalize_command" + fi + + compile_var= + finalize_var= + if test -n "$runpath_var"; then + if test -n "$perm_rpath"; then + # We should set the runpath_var. + rpath= + for dir in $perm_rpath; do + func_append rpath "$dir:" + done + compile_var="$runpath_var=\"$rpath\$$runpath_var\" " + fi + if test -n "$finalize_perm_rpath"; then + # We should set the runpath_var. + rpath= + for dir in $finalize_perm_rpath; do + func_append rpath "$dir:" + done + finalize_var="$runpath_var=\"$rpath\$$runpath_var\" " + fi + fi + + if test "$no_install" = yes; then + # We don't need to create a wrapper script. + link_command="$compile_var$compile_command$compile_rpath" + # Replace the output file specification. + link_command=`$ECHO "$link_command" | $SED 's%@OUTPUT@%'"$output"'%g'` + # Delete the old output file. + $opt_dry_run || $RM $output + # Link the executable and exit + func_show_eval "$link_command" 'exit $?' + + if test -n "$postlink_cmds"; then + func_to_tool_file "$output" + postlink_cmds=`func_echo_all "$postlink_cmds" | $SED -e 's%@OUTPUT@%'"$output"'%g' -e 's%@TOOL_OUTPUT@%'"$func_to_tool_file_result"'%g'` + func_execute_cmds "$postlink_cmds" 'exit $?' + fi + + exit $EXIT_SUCCESS + fi + + if test "$hardcode_action" = relink; then + # Fast installation is not supported + link_command="$compile_var$compile_command$compile_rpath" + relink_command="$finalize_var$finalize_command$finalize_rpath" + + func_warning "this platform does not like uninstalled shared libraries" + func_warning "\`$output' will be relinked during installation" + else + if test "$fast_install" != no; then + link_command="$finalize_var$compile_command$finalize_rpath" + if test "$fast_install" = yes; then + relink_command=`$ECHO "$compile_var$compile_command$compile_rpath" | $SED 's%@OUTPUT@%\$progdir/\$file%g'` + else + # fast_install is set to needless + relink_command= + fi + else + link_command="$compile_var$compile_command$compile_rpath" + relink_command="$finalize_var$finalize_command$finalize_rpath" + fi + fi + + # Replace the output file specification. + link_command=`$ECHO "$link_command" | $SED 's%@OUTPUT@%'"$output_objdir/$outputname"'%g'` + + # Delete the old output files. + $opt_dry_run || $RM $output $output_objdir/$outputname $output_objdir/lt-$outputname + + func_show_eval "$link_command" 'exit $?' + + if test -n "$postlink_cmds"; then + func_to_tool_file "$output_objdir/$outputname" + postlink_cmds=`func_echo_all "$postlink_cmds" | $SED -e 's%@OUTPUT@%'"$output_objdir/$outputname"'%g' -e 's%@TOOL_OUTPUT@%'"$func_to_tool_file_result"'%g'` + func_execute_cmds "$postlink_cmds" 'exit $?' + fi + + # Now create the wrapper script. + func_verbose "creating $output" + + # Quote the relink command for shipping. + if test -n "$relink_command"; then + # Preserve any variables that may affect compiler behavior + for var in $variables_saved_for_relink; do + if eval test -z \"\${$var+set}\"; then + relink_command="{ test -z \"\${$var+set}\" || $lt_unset $var || { $var=; export $var; }; }; $relink_command" + elif eval var_value=\$$var; test -z "$var_value"; then + relink_command="$var=; export $var; $relink_command" + else + func_quote_for_eval "$var_value" + relink_command="$var=$func_quote_for_eval_result; export $var; $relink_command" + fi + done + relink_command="(cd `pwd`; $relink_command)" + relink_command=`$ECHO "$relink_command" | $SED "$sed_quote_subst"` + fi + + # Only actually do things if not in dry run mode. + $opt_dry_run || { + # win32 will think the script is a binary if it has + # a .exe suffix, so we strip it off here. + case $output in + *.exe) func_stripname '' '.exe' "$output" + output=$func_stripname_result ;; + esac + # test for cygwin because mv fails w/o .exe extensions + case $host in + *cygwin*) + exeext=.exe + func_stripname '' '.exe' "$outputname" + outputname=$func_stripname_result ;; + *) exeext= ;; + esac + case $host in + *cygwin* | *mingw* ) + func_dirname_and_basename "$output" "" "." + output_name=$func_basename_result + output_path=$func_dirname_result + cwrappersource="$output_path/$objdir/lt-$output_name.c" + cwrapper="$output_path/$output_name.exe" + $RM $cwrappersource $cwrapper + trap "$RM $cwrappersource $cwrapper; exit $EXIT_FAILURE" 1 2 15 + + func_emit_cwrapperexe_src > $cwrappersource + + # The wrapper executable is built using the $host compiler, + # because it contains $host paths and files. If cross- + # compiling, it, like the target executable, must be + # executed on the $host or under an emulation environment. + $opt_dry_run || { + $LTCC $LTCFLAGS -o $cwrapper $cwrappersource + $STRIP $cwrapper + } + + # Now, create the wrapper script for func_source use: + func_ltwrapper_scriptname $cwrapper + $RM $func_ltwrapper_scriptname_result + trap "$RM $func_ltwrapper_scriptname_result; exit $EXIT_FAILURE" 1 2 15 + $opt_dry_run || { + # note: this script will not be executed, so do not chmod. + if test "x$build" = "x$host" ; then + $cwrapper --lt-dump-script > $func_ltwrapper_scriptname_result + else + func_emit_wrapper no > $func_ltwrapper_scriptname_result + fi + } + ;; + * ) + $RM $output + trap "$RM $output; exit $EXIT_FAILURE" 1 2 15 + + func_emit_wrapper no > $output + chmod +x $output + ;; + esac + } + exit $EXIT_SUCCESS + ;; + esac + + # See if we need to build an old-fashioned archive. + for oldlib in $oldlibs; do + + if test "$build_libtool_libs" = convenience; then + oldobjs="$libobjs_save $symfileobj" + addlibs="$convenience" + build_libtool_libs=no + else + if test "$build_libtool_libs" = module; then + oldobjs="$libobjs_save" + build_libtool_libs=no + else + oldobjs="$old_deplibs $non_pic_objects" + if test "$preload" = yes && test -f "$symfileobj"; then + func_append oldobjs " $symfileobj" + fi + fi + addlibs="$old_convenience" + fi + + if test -n "$addlibs"; then + gentop="$output_objdir/${outputname}x" + func_append generated " $gentop" + + func_extract_archives $gentop $addlibs + func_append oldobjs " $func_extract_archives_result" + fi + + # Do each command in the archive commands. + if test -n "$old_archive_from_new_cmds" && test "$build_libtool_libs" = yes; then + cmds=$old_archive_from_new_cmds + else + + # Add any objects from preloaded convenience libraries + if test -n "$dlprefiles"; then + gentop="$output_objdir/${outputname}x" + func_append generated " $gentop" + + func_extract_archives $gentop $dlprefiles + func_append oldobjs " $func_extract_archives_result" + fi + + # POSIX demands no paths to be encoded in archives. We have + # to avoid creating archives with duplicate basenames if we + # might have to extract them afterwards, e.g., when creating a + # static archive out of a convenience library, or when linking + # the entirety of a libtool archive into another (currently + # not supported by libtool). + if (for obj in $oldobjs + do + func_basename "$obj" + $ECHO "$func_basename_result" + done | sort | sort -uc >/dev/null 2>&1); then + : + else + echo "copying selected object files to avoid basename conflicts..." + gentop="$output_objdir/${outputname}x" + func_append generated " $gentop" + func_mkdir_p "$gentop" + save_oldobjs=$oldobjs + oldobjs= + counter=1 + for obj in $save_oldobjs + do + func_basename "$obj" + objbase="$func_basename_result" + case " $oldobjs " in + " ") oldobjs=$obj ;; + *[\ /]"$objbase "*) + while :; do + # Make sure we don't pick an alternate name that also + # overlaps. + newobj=lt$counter-$objbase + func_arith $counter + 1 + counter=$func_arith_result + case " $oldobjs " in + *[\ /]"$newobj "*) ;; + *) if test ! -f "$gentop/$newobj"; then break; fi ;; + esac + done + func_show_eval "ln $obj $gentop/$newobj || cp $obj $gentop/$newobj" + func_append oldobjs " $gentop/$newobj" + ;; + *) func_append oldobjs " $obj" ;; + esac + done + fi + func_to_tool_file "$oldlib" func_convert_file_msys_to_w32 + tool_oldlib=$func_to_tool_file_result + eval cmds=\"$old_archive_cmds\" + + func_len " $cmds" + len=$func_len_result + if test "$len" -lt "$max_cmd_len" || test "$max_cmd_len" -le -1; then + cmds=$old_archive_cmds + elif test -n "$archiver_list_spec"; then + func_verbose "using command file archive linking..." + for obj in $oldobjs + do + func_to_tool_file "$obj" + $ECHO "$func_to_tool_file_result" + done > $output_objdir/$libname.libcmd + func_to_tool_file "$output_objdir/$libname.libcmd" + oldobjs=" $archiver_list_spec$func_to_tool_file_result" + cmds=$old_archive_cmds + else + # the command line is too long to link in one step, link in parts + func_verbose "using piecewise archive linking..." + save_RANLIB=$RANLIB + RANLIB=: + objlist= + concat_cmds= + save_oldobjs=$oldobjs + oldobjs= + # Is there a better way of finding the last object in the list? + for obj in $save_oldobjs + do + last_oldobj=$obj + done + eval test_cmds=\"$old_archive_cmds\" + func_len " $test_cmds" + len0=$func_len_result + len=$len0 + for obj in $save_oldobjs + do + func_len " $obj" + func_arith $len + $func_len_result + len=$func_arith_result + func_append objlist " $obj" + if test "$len" -lt "$max_cmd_len"; then + : + else + # the above command should be used before it gets too long + oldobjs=$objlist + if test "$obj" = "$last_oldobj" ; then + RANLIB=$save_RANLIB + fi + test -z "$concat_cmds" || concat_cmds=$concat_cmds~ + eval concat_cmds=\"\${concat_cmds}$old_archive_cmds\" + objlist= + len=$len0 + fi + done + RANLIB=$save_RANLIB + oldobjs=$objlist + if test "X$oldobjs" = "X" ; then + eval cmds=\"\$concat_cmds\" + else + eval cmds=\"\$concat_cmds~\$old_archive_cmds\" + fi + fi + fi + func_execute_cmds "$cmds" 'exit $?' + done + + test -n "$generated" && \ + func_show_eval "${RM}r$generated" + + # Now create the libtool archive. + case $output in + *.la) + old_library= + test "$build_old_libs" = yes && old_library="$libname.$libext" + func_verbose "creating $output" + + # Preserve any variables that may affect compiler behavior + for var in $variables_saved_for_relink; do + if eval test -z \"\${$var+set}\"; then + relink_command="{ test -z \"\${$var+set}\" || $lt_unset $var || { $var=; export $var; }; }; $relink_command" + elif eval var_value=\$$var; test -z "$var_value"; then + relink_command="$var=; export $var; $relink_command" + else + func_quote_for_eval "$var_value" + relink_command="$var=$func_quote_for_eval_result; export $var; $relink_command" + fi + done + # Quote the link command for shipping. + relink_command="(cd `pwd`; $SHELL $progpath $preserve_args --mode=relink $libtool_args @inst_prefix_dir@)" + relink_command=`$ECHO "$relink_command" | $SED "$sed_quote_subst"` + if test "$hardcode_automatic" = yes ; then + relink_command= + fi + + # Only create the output if not a dry run. + $opt_dry_run || { + for installed in no yes; do + if test "$installed" = yes; then + if test -z "$install_libdir"; then + break + fi + output="$output_objdir/$outputname"i + # Replace all uninstalled libtool libraries with the installed ones + newdependency_libs= + for deplib in $dependency_libs; do + case $deplib in + *.la) + func_basename "$deplib" + name="$func_basename_result" + func_resolve_sysroot "$deplib" + eval libdir=`${SED} -n -e 's/^libdir=\(.*\)$/\1/p' $func_resolve_sysroot_result` + test -z "$libdir" && \ + func_fatal_error "\`$deplib' is not a valid libtool archive" + func_append newdependency_libs " ${lt_sysroot:+=}$libdir/$name" + ;; + -L*) + func_stripname -L '' "$deplib" + func_replace_sysroot "$func_stripname_result" + func_append newdependency_libs " -L$func_replace_sysroot_result" + ;; + -R*) + func_stripname -R '' "$deplib" + func_replace_sysroot "$func_stripname_result" + func_append newdependency_libs " -R$func_replace_sysroot_result" + ;; + *) func_append newdependency_libs " $deplib" ;; + esac + done + dependency_libs="$newdependency_libs" + newdlfiles= + + for lib in $dlfiles; do + case $lib in + *.la) + func_basename "$lib" + name="$func_basename_result" + eval libdir=`${SED} -n -e 's/^libdir=\(.*\)$/\1/p' $lib` + test -z "$libdir" && \ + func_fatal_error "\`$lib' is not a valid libtool archive" + func_append newdlfiles " ${lt_sysroot:+=}$libdir/$name" + ;; + *) func_append newdlfiles " $lib" ;; + esac + done + dlfiles="$newdlfiles" + newdlprefiles= + for lib in $dlprefiles; do + case $lib in + *.la) + # Only pass preopened files to the pseudo-archive (for + # eventual linking with the app. that links it) if we + # didn't already link the preopened objects directly into + # the library: + func_basename "$lib" + name="$func_basename_result" + eval libdir=`${SED} -n -e 's/^libdir=\(.*\)$/\1/p' $lib` + test -z "$libdir" && \ + func_fatal_error "\`$lib' is not a valid libtool archive" + func_append newdlprefiles " ${lt_sysroot:+=}$libdir/$name" + ;; + esac + done + dlprefiles="$newdlprefiles" + else + newdlfiles= + for lib in $dlfiles; do + case $lib in + [\\/]* | [A-Za-z]:[\\/]*) abs="$lib" ;; + *) abs=`pwd`"/$lib" ;; + esac + func_append newdlfiles " $abs" + done + dlfiles="$newdlfiles" + newdlprefiles= + for lib in $dlprefiles; do + case $lib in + [\\/]* | [A-Za-z]:[\\/]*) abs="$lib" ;; + *) abs=`pwd`"/$lib" ;; + esac + func_append newdlprefiles " $abs" + done + dlprefiles="$newdlprefiles" + fi + $RM $output + # place dlname in correct position for cygwin + # In fact, it would be nice if we could use this code for all target + # systems that can't hard-code library paths into their executables + # and that have no shared library path variable independent of PATH, + # but it turns out we can't easily determine that from inspecting + # libtool variables, so we have to hard-code the OSs to which it + # applies here; at the moment, that means platforms that use the PE + # object format with DLL files. See the long comment at the top of + # tests/bindir.at for full details. + tdlname=$dlname + case $host,$output,$installed,$module,$dlname in + *cygwin*,*lai,yes,no,*.dll | *mingw*,*lai,yes,no,*.dll | *cegcc*,*lai,yes,no,*.dll) + # If a -bindir argument was supplied, place the dll there. + if test "x$bindir" != x ; + then + func_relative_path "$install_libdir" "$bindir" + tdlname=$func_relative_path_result$dlname + else + # Otherwise fall back on heuristic. + tdlname=../bin/$dlname + fi + ;; + esac + $ECHO > $output "\ +# $outputname - a libtool library file +# Generated by $PROGRAM (GNU $PACKAGE$TIMESTAMP) $VERSION +# +# Please DO NOT delete this file! +# It is necessary for linking the library. + +# The name that we can dlopen(3). +dlname='$tdlname' + +# Names of this library. +library_names='$library_names' + +# The name of the static archive. +old_library='$old_library' + +# Linker flags that can not go in dependency_libs. +inherited_linker_flags='$new_inherited_linker_flags' + +# Libraries that this one depends upon. +dependency_libs='$dependency_libs' + +# Names of additional weak libraries provided by this library +weak_library_names='$weak_libs' + +# Version information for $libname. +current=$current +age=$age +revision=$revision + +# Is this an already installed library? +installed=$installed + +# Should we warn about portability when linking against -modules? +shouldnotlink=$module + +# Files to dlopen/dlpreopen +dlopen='$dlfiles' +dlpreopen='$dlprefiles' + +# Directory that this library needs to be installed in: +libdir='$install_libdir'" + if test "$installed" = no && test "$need_relink" = yes; then + $ECHO >> $output "\ +relink_command=\"$relink_command\"" + fi + done + } + + # Do a symbolic link so that the libtool archive can be found in + # LD_LIBRARY_PATH before the program is installed. + func_show_eval '( cd "$output_objdir" && $RM "$outputname" && $LN_S "../$outputname" "$outputname" )' 'exit $?' + ;; + esac + exit $EXIT_SUCCESS +} + +{ test "$opt_mode" = link || test "$opt_mode" = relink; } && + func_mode_link ${1+"$@"} + + +# func_mode_uninstall arg... +func_mode_uninstall () +{ + $opt_debug + RM="$nonopt" + files= + rmforce= + exit_status=0 + + # This variable tells wrapper scripts just to set variables rather + # than running their programs. + libtool_install_magic="$magic" + + for arg + do + case $arg in + -f) func_append RM " $arg"; rmforce=yes ;; + -*) func_append RM " $arg" ;; + *) func_append files " $arg" ;; + esac + done + + test -z "$RM" && \ + func_fatal_help "you must specify an RM program" + + rmdirs= + + for file in $files; do + func_dirname "$file" "" "." + dir="$func_dirname_result" + if test "X$dir" = X.; then + odir="$objdir" + else + odir="$dir/$objdir" + fi + func_basename "$file" + name="$func_basename_result" + test "$opt_mode" = uninstall && odir="$dir" + + # Remember odir for removal later, being careful to avoid duplicates + if test "$opt_mode" = clean; then + case " $rmdirs " in + *" $odir "*) ;; + *) func_append rmdirs " $odir" ;; + esac + fi + + # Don't error if the file doesn't exist and rm -f was used. + if { test -L "$file"; } >/dev/null 2>&1 || + { test -h "$file"; } >/dev/null 2>&1 || + test -f "$file"; then + : + elif test -d "$file"; then + exit_status=1 + continue + elif test "$rmforce" = yes; then + continue + fi + + rmfiles="$file" + + case $name in + *.la) + # Possibly a libtool archive, so verify it. + if func_lalib_p "$file"; then + func_source $dir/$name + + # Delete the libtool libraries and symlinks. + for n in $library_names; do + func_append rmfiles " $odir/$n" + done + test -n "$old_library" && func_append rmfiles " $odir/$old_library" + + case "$opt_mode" in + clean) + case " $library_names " in + *" $dlname "*) ;; + *) test -n "$dlname" && func_append rmfiles " $odir/$dlname" ;; + esac + test -n "$libdir" && func_append rmfiles " $odir/$name $odir/${name}i" + ;; + uninstall) + if test -n "$library_names"; then + # Do each command in the postuninstall commands. + func_execute_cmds "$postuninstall_cmds" 'test "$rmforce" = yes || exit_status=1' + fi + + if test -n "$old_library"; then + # Do each command in the old_postuninstall commands. + func_execute_cmds "$old_postuninstall_cmds" 'test "$rmforce" = yes || exit_status=1' + fi + # FIXME: should reinstall the best remaining shared library. + ;; + esac + fi + ;; + + *.lo) + # Possibly a libtool object, so verify it. + if func_lalib_p "$file"; then + + # Read the .lo file + func_source $dir/$name + + # Add PIC object to the list of files to remove. + if test -n "$pic_object" && + test "$pic_object" != none; then + func_append rmfiles " $dir/$pic_object" + fi + + # Add non-PIC object to the list of files to remove. + if test -n "$non_pic_object" && + test "$non_pic_object" != none; then + func_append rmfiles " $dir/$non_pic_object" + fi + fi + ;; + + *) + if test "$opt_mode" = clean ; then + noexename=$name + case $file in + *.exe) + func_stripname '' '.exe' "$file" + file=$func_stripname_result + func_stripname '' '.exe' "$name" + noexename=$func_stripname_result + # $file with .exe has already been added to rmfiles, + # add $file without .exe + func_append rmfiles " $file" + ;; + esac + # Do a test to see if this is a libtool program. + if func_ltwrapper_p "$file"; then + if func_ltwrapper_executable_p "$file"; then + func_ltwrapper_scriptname "$file" + relink_command= + func_source $func_ltwrapper_scriptname_result + func_append rmfiles " $func_ltwrapper_scriptname_result" + else + relink_command= + func_source $dir/$noexename + fi + + # note $name still contains .exe if it was in $file originally + # as does the version of $file that was added into $rmfiles + func_append rmfiles " $odir/$name $odir/${name}S.${objext}" + if test "$fast_install" = yes && test -n "$relink_command"; then + func_append rmfiles " $odir/lt-$name" + fi + if test "X$noexename" != "X$name" ; then + func_append rmfiles " $odir/lt-${noexename}.c" + fi + fi + fi + ;; + esac + func_show_eval "$RM $rmfiles" 'exit_status=1' + done + + # Try to remove the ${objdir}s in the directories where we deleted files + for dir in $rmdirs; do + if test -d "$dir"; then + func_show_eval "rmdir $dir >/dev/null 2>&1" + fi + done + + exit $exit_status +} + +{ test "$opt_mode" = uninstall || test "$opt_mode" = clean; } && + func_mode_uninstall ${1+"$@"} + +test -z "$opt_mode" && { + help="$generic_help" + func_fatal_help "you must specify a MODE" +} + +test -z "$exec_cmd" && \ + func_fatal_help "invalid operation mode \`$opt_mode'" + +if test -n "$exec_cmd"; then + eval exec "$exec_cmd" + exit $EXIT_FAILURE +fi + +exit $exit_status + + +# The TAGs below are defined such that we never get into a situation +# in which we disable both kinds of libraries. Given conflicting +# choices, we go for a static library, that is the most portable, +# since we can't tell whether shared libraries were disabled because +# the user asked for that or because the platform doesn't support +# them. This is particularly important on AIX, because we don't +# support having both static and shared libraries enabled at the same +# time on that platform, so we default to a shared-only configuration. +# If a disable-shared tag is given, we'll fallback to a static-only +# configuration. But we'll never go from static-only to shared-only. + +# ### BEGIN LIBTOOL TAG CONFIG: disable-shared +build_libtool_libs=no +build_old_libs=yes +# ### END LIBTOOL TAG CONFIG: disable-shared + +# ### BEGIN LIBTOOL TAG CONFIG: disable-static +build_old_libs=`case $build_libtool_libs in yes) echo no;; *) echo yes;; esac` +# ### END LIBTOOL TAG CONFIG: disable-static + +# Local Variables: +# mode:shell-script +# sh-indentation:2 +# End: +# vi:sw=2 + diff --git a/libconfig-1.4.9/aux-build/missing b/libconfig-1.4.9/aux-build/missing new file mode 100755 index 0000000000000000000000000000000000000000..28055d2ae6f2a2c584afcd769d7881e11f62ecd9 --- /dev/null +++ b/libconfig-1.4.9/aux-build/missing @@ -0,0 +1,376 @@ +#! /bin/sh +# Common stub for a few missing GNU programs while installing. + +scriptversion=2009-04-28.21; # UTC + +# Copyright (C) 1996, 1997, 1999, 2000, 2002, 2003, 2004, 2005, 2006, +# 2008, 2009 Free Software Foundation, Inc. +# Originally by Fran,cois Pinard , 1996. + +# This program is free software; you can redistribute it and/or modify +# it under the terms of the GNU General Public License as published by +# the Free Software Foundation; either version 2, or (at your option) +# any later version. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY; without even the implied warranty of +# MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +# GNU General Public License for more details. + +# You should have received a copy of the GNU General Public License +# along with this program. If not, see . + +# As a special exception to the GNU General Public License, if you +# distribute this file as part of a program that contains a +# configuration script generated by Autoconf, you may include it under +# the same distribution terms that you use for the rest of that program. + +if test $# -eq 0; then + echo 1>&2 "Try \`$0 --help' for more information" + exit 1 +fi + +run=: +sed_output='s/.* --output[ =]\([^ ]*\).*/\1/p' +sed_minuso='s/.* -o \([^ ]*\).*/\1/p' + +# In the cases where this matters, `missing' is being run in the +# srcdir already. +if test -f configure.ac; then + configure_ac=configure.ac +else + configure_ac=configure.in +fi + +msg="missing on your system" + +case $1 in +--run) + # Try to run requested program, and just exit if it succeeds. + run= + shift + "$@" && exit 0 + # Exit code 63 means version mismatch. This often happens + # when the user try to use an ancient version of a tool on + # a file that requires a minimum version. In this case we + # we should proceed has if the program had been absent, or + # if --run hadn't been passed. + if test $? = 63; then + run=: + msg="probably too old" + fi + ;; + + -h|--h|--he|--hel|--help) + echo "\ +$0 [OPTION]... PROGRAM [ARGUMENT]... + +Handle \`PROGRAM [ARGUMENT]...' for when PROGRAM is missing, or return an +error status if there is no known handling for PROGRAM. + +Options: + -h, --help display this help and exit + -v, --version output version information and exit + --run try to run the given command, and emulate it if it fails + +Supported PROGRAM values: + aclocal touch file \`aclocal.m4' + autoconf touch file \`configure' + autoheader touch file \`config.h.in' + autom4te touch the output file, or create a stub one + automake touch all \`Makefile.in' files + bison create \`y.tab.[ch]', if possible, from existing .[ch] + flex create \`lex.yy.c', if possible, from existing .c + help2man touch the output file + lex create \`lex.yy.c', if possible, from existing .c + makeinfo touch the output file + tar try tar, gnutar, gtar, then tar without non-portable flags + yacc create \`y.tab.[ch]', if possible, from existing .[ch] + +Version suffixes to PROGRAM as well as the prefixes \`gnu-', \`gnu', and +\`g' are ignored when checking the name. + +Send bug reports to ." + exit $? + ;; + + -v|--v|--ve|--ver|--vers|--versi|--versio|--version) + echo "missing $scriptversion (GNU Automake)" + exit $? + ;; + + -*) + echo 1>&2 "$0: Unknown \`$1' option" + echo 1>&2 "Try \`$0 --help' for more information" + exit 1 + ;; + +esac + +# normalize program name to check for. +program=`echo "$1" | sed ' + s/^gnu-//; t + s/^gnu//; t + s/^g//; t'` + +# Now exit if we have it, but it failed. Also exit now if we +# don't have it and --version was passed (most likely to detect +# the program). This is about non-GNU programs, so use $1 not +# $program. +case $1 in + lex*|yacc*) + # Not GNU programs, they don't have --version. + ;; + + tar*) + if test -n "$run"; then + echo 1>&2 "ERROR: \`tar' requires --run" + exit 1 + elif test "x$2" = "x--version" || test "x$2" = "x--help"; then + exit 1 + fi + ;; + + *) + if test -z "$run" && ($1 --version) > /dev/null 2>&1; then + # We have it, but it failed. + exit 1 + elif test "x$2" = "x--version" || test "x$2" = "x--help"; then + # Could not run --version or --help. This is probably someone + # running `$TOOL --version' or `$TOOL --help' to check whether + # $TOOL exists and not knowing $TOOL uses missing. + exit 1 + fi + ;; +esac + +# If it does not exist, or fails to run (possibly an outdated version), +# try to emulate it. +case $program in + aclocal*) + echo 1>&2 "\ +WARNING: \`$1' is $msg. You should only need it if + you modified \`acinclude.m4' or \`${configure_ac}'. You might want + to install the \`Automake' and \`Perl' packages. Grab them from + any GNU archive site." + touch aclocal.m4 + ;; + + autoconf*) + echo 1>&2 "\ +WARNING: \`$1' is $msg. You should only need it if + you modified \`${configure_ac}'. You might want to install the + \`Autoconf' and \`GNU m4' packages. Grab them from any GNU + archive site." + touch configure + ;; + + autoheader*) + echo 1>&2 "\ +WARNING: \`$1' is $msg. You should only need it if + you modified \`acconfig.h' or \`${configure_ac}'. You might want + to install the \`Autoconf' and \`GNU m4' packages. Grab them + from any GNU archive site." + files=`sed -n 's/^[ ]*A[CM]_CONFIG_HEADER(\([^)]*\)).*/\1/p' ${configure_ac}` + test -z "$files" && files="config.h" + touch_files= + for f in $files; do + case $f in + *:*) touch_files="$touch_files "`echo "$f" | + sed -e 's/^[^:]*://' -e 's/:.*//'`;; + *) touch_files="$touch_files $f.in";; + esac + done + touch $touch_files + ;; + + automake*) + echo 1>&2 "\ +WARNING: \`$1' is $msg. You should only need it if + you modified \`Makefile.am', \`acinclude.m4' or \`${configure_ac}'. + You might want to install the \`Automake' and \`Perl' packages. + Grab them from any GNU archive site." + find . -type f -name Makefile.am -print | + sed 's/\.am$/.in/' | + while read f; do touch "$f"; done + ;; + + autom4te*) + echo 1>&2 "\ +WARNING: \`$1' is needed, but is $msg. + You might have modified some files without having the + proper tools for further handling them. + You can get \`$1' as part of \`Autoconf' from any GNU + archive site." + + file=`echo "$*" | sed -n "$sed_output"` + test -z "$file" && file=`echo "$*" | sed -n "$sed_minuso"` + if test -f "$file"; then + touch $file + else + test -z "$file" || exec >$file + echo "#! /bin/sh" + echo "# Created by GNU Automake missing as a replacement of" + echo "# $ $@" + echo "exit 0" + chmod +x $file + exit 1 + fi + ;; + + bison*|yacc*) + echo 1>&2 "\ +WARNING: \`$1' $msg. You should only need it if + you modified a \`.y' file. You may need the \`Bison' package + in order for those modifications to take effect. You can get + \`Bison' from any GNU archive site." + rm -f y.tab.c y.tab.h + if test $# -ne 1; then + eval LASTARG="\${$#}" + case $LASTARG in + *.y) + SRCFILE=`echo "$LASTARG" | sed 's/y$/c/'` + if test -f "$SRCFILE"; then + cp "$SRCFILE" y.tab.c + fi + SRCFILE=`echo "$LASTARG" | sed 's/y$/h/'` + if test -f "$SRCFILE"; then + cp "$SRCFILE" y.tab.h + fi + ;; + esac + fi + if test ! -f y.tab.h; then + echo >y.tab.h + fi + if test ! -f y.tab.c; then + echo 'main() { return 0; }' >y.tab.c + fi + ;; + + lex*|flex*) + echo 1>&2 "\ +WARNING: \`$1' is $msg. You should only need it if + you modified a \`.l' file. You may need the \`Flex' package + in order for those modifications to take effect. You can get + \`Flex' from any GNU archive site." + rm -f lex.yy.c + if test $# -ne 1; then + eval LASTARG="\${$#}" + case $LASTARG in + *.l) + SRCFILE=`echo "$LASTARG" | sed 's/l$/c/'` + if test -f "$SRCFILE"; then + cp "$SRCFILE" lex.yy.c + fi + ;; + esac + fi + if test ! -f lex.yy.c; then + echo 'main() { return 0; }' >lex.yy.c + fi + ;; + + help2man*) + echo 1>&2 "\ +WARNING: \`$1' is $msg. You should only need it if + you modified a dependency of a manual page. You may need the + \`Help2man' package in order for those modifications to take + effect. You can get \`Help2man' from any GNU archive site." + + file=`echo "$*" | sed -n "$sed_output"` + test -z "$file" && file=`echo "$*" | sed -n "$sed_minuso"` + if test -f "$file"; then + touch $file + else + test -z "$file" || exec >$file + echo ".ab help2man is required to generate this page" + exit $? + fi + ;; + + makeinfo*) + echo 1>&2 "\ +WARNING: \`$1' is $msg. You should only need it if + you modified a \`.texi' or \`.texinfo' file, or any other file + indirectly affecting the aspect of the manual. The spurious + call might also be the consequence of using a buggy \`make' (AIX, + DU, IRIX). You might want to install the \`Texinfo' package or + the \`GNU make' package. Grab either from any GNU archive site." + # The file to touch is that specified with -o ... + file=`echo "$*" | sed -n "$sed_output"` + test -z "$file" && file=`echo "$*" | sed -n "$sed_minuso"` + if test -z "$file"; then + # ... or it is the one specified with @setfilename ... + infile=`echo "$*" | sed 's/.* \([^ ]*\) *$/\1/'` + file=`sed -n ' + /^@setfilename/{ + s/.* \([^ ]*\) *$/\1/ + p + q + }' $infile` + # ... or it is derived from the source name (dir/f.texi becomes f.info) + test -z "$file" && file=`echo "$infile" | sed 's,.*/,,;s,.[^.]*$,,'`.info + fi + # If the file does not exist, the user really needs makeinfo; + # let's fail without touching anything. + test -f $file || exit 1 + touch $file + ;; + + tar*) + shift + + # We have already tried tar in the generic part. + # Look for gnutar/gtar before invocation to avoid ugly error + # messages. + if (gnutar --version > /dev/null 2>&1); then + gnutar "$@" && exit 0 + fi + if (gtar --version > /dev/null 2>&1); then + gtar "$@" && exit 0 + fi + firstarg="$1" + if shift; then + case $firstarg in + *o*) + firstarg=`echo "$firstarg" | sed s/o//` + tar "$firstarg" "$@" && exit 0 + ;; + esac + case $firstarg in + *h*) + firstarg=`echo "$firstarg" | sed s/h//` + tar "$firstarg" "$@" && exit 0 + ;; + esac + fi + + echo 1>&2 "\ +WARNING: I can't seem to be able to run \`tar' with the given arguments. + You may want to install GNU tar or Free paxutils, or check the + command line arguments." + exit 1 + ;; + + *) + echo 1>&2 "\ +WARNING: \`$1' is needed, and is $msg. + You might have modified some files without having the + proper tools for further handling them. Check the \`README' file, + it often tells you about the needed prerequisites for installing + this package. You may also peek at any GNU archive site, in case + some other package would contain this missing \`$1' program." + exit 1 + ;; +esac + +exit 0 + +# Local variables: +# eval: (add-hook 'write-file-hooks 'time-stamp) +# time-stamp-start: "scriptversion=" +# time-stamp-format: "%:y-%02m-%02d.%02H" +# time-stamp-time-zone: "UTC" +# time-stamp-end: "; # UTC" +# End: diff --git a/libconfig-1.4.9/aux-build/mkinstalldirs b/libconfig-1.4.9/aux-build/mkinstalldirs new file mode 100755 index 0000000000000000000000000000000000000000..4191a45dbd72ecd24c25b45a53e94ea0a4b5baf7 --- /dev/null +++ b/libconfig-1.4.9/aux-build/mkinstalldirs @@ -0,0 +1,162 @@ +#! /bin/sh +# mkinstalldirs --- make directory hierarchy + +scriptversion=2009-04-28.21; # UTC + +# Original author: Noah Friedman +# Created: 1993-05-16 +# Public domain. +# +# This file is maintained in Automake, please report +# bugs to or send patches to +# . + +nl=' +' +IFS=" "" $nl" +errstatus=0 +dirmode= + +usage="\ +Usage: mkinstalldirs [-h] [--help] [--version] [-m MODE] DIR ... + +Create each directory DIR (with mode MODE, if specified), including all +leading file name components. + +Report bugs to ." + +# process command line arguments +while test $# -gt 0 ; do + case $1 in + -h | --help | --h*) # -h for help + echo "$usage" + exit $? + ;; + -m) # -m PERM arg + shift + test $# -eq 0 && { echo "$usage" 1>&2; exit 1; } + dirmode=$1 + shift + ;; + --version) + echo "$0 $scriptversion" + exit $? + ;; + --) # stop option processing + shift + break + ;; + -*) # unknown option + echo "$usage" 1>&2 + exit 1 + ;; + *) # first non-opt arg + break + ;; + esac +done + +for file +do + if test -d "$file"; then + shift + else + break + fi +done + +case $# in + 0) exit 0 ;; +esac + +# Solaris 8's mkdir -p isn't thread-safe. If you mkdir -p a/b and +# mkdir -p a/c at the same time, both will detect that a is missing, +# one will create a, then the other will try to create a and die with +# a "File exists" error. This is a problem when calling mkinstalldirs +# from a parallel make. We use --version in the probe to restrict +# ourselves to GNU mkdir, which is thread-safe. +case $dirmode in + '') + if mkdir -p --version . >/dev/null 2>&1 && test ! -d ./--version; then + echo "mkdir -p -- $*" + exec mkdir -p -- "$@" + else + # On NextStep and OpenStep, the `mkdir' command does not + # recognize any option. It will interpret all options as + # directories to create, and then abort because `.' already + # exists. + test -d ./-p && rmdir ./-p + test -d ./--version && rmdir ./--version + fi + ;; + *) + if mkdir -m "$dirmode" -p --version . >/dev/null 2>&1 && + test ! -d ./--version; then + echo "mkdir -m $dirmode -p -- $*" + exec mkdir -m "$dirmode" -p -- "$@" + else + # Clean up after NextStep and OpenStep mkdir. + for d in ./-m ./-p ./--version "./$dirmode"; + do + test -d $d && rmdir $d + done + fi + ;; +esac + +for file +do + case $file in + /*) pathcomp=/ ;; + *) pathcomp= ;; + esac + oIFS=$IFS + IFS=/ + set fnord $file + shift + IFS=$oIFS + + for d + do + test "x$d" = x && continue + + pathcomp=$pathcomp$d + case $pathcomp in + -*) pathcomp=./$pathcomp ;; + esac + + if test ! -d "$pathcomp"; then + echo "mkdir $pathcomp" + + mkdir "$pathcomp" || lasterr=$? + + if test ! -d "$pathcomp"; then + errstatus=$lasterr + else + if test ! -z "$dirmode"; then + echo "chmod $dirmode $pathcomp" + lasterr= + chmod "$dirmode" "$pathcomp" || lasterr=$? + + if test ! -z "$lasterr"; then + errstatus=$lasterr + fi + fi + fi + fi + + pathcomp=$pathcomp/ + done +done + +exit $errstatus + +# Local Variables: +# mode: shell-script +# sh-indentation: 2 +# eval: (add-hook 'write-file-hooks 'time-stamp) +# time-stamp-start: "scriptversion=" +# time-stamp-format: "%:y-%02m-%02d.%02H" +# time-stamp-time-zone: "UTC" +# time-stamp-end: "; # UTC" +# End: diff --git a/libconfig-1.4.9/aux-build/texinfo.tex b/libconfig-1.4.9/aux-build/texinfo.tex new file mode 100644 index 0000000000000000000000000000000000000000..91408263bc9c8ab0ad735c0974872d2f1cf58dc0 --- /dev/null +++ b/libconfig-1.4.9/aux-build/texinfo.tex @@ -0,0 +1,9291 @@ +% texinfo.tex -- TeX macros to handle Texinfo files. +% +% Load plain if necessary, i.e., if running under initex. +\expandafter\ifx\csname fmtname\endcsname\relax\input plain\fi +% +\def\texinfoversion{2009-08-14.15} +% +% Copyright 1985, 1986, 1988, 1990, 1991, 1992, 1993, 1994, 1995, +% 1996, 1997, 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, +% 2007, 2008, 2009 Free Software Foundation, Inc. +% +% This texinfo.tex file is free software: you can redistribute it and/or +% modify it under the terms of the GNU General Public License as +% published by the Free Software Foundation, either version 3 of the +% License, or (at your option) any later version. +% +% This texinfo.tex file is distributed in the hope that it will be +% useful, but WITHOUT ANY WARRANTY; without even the implied warranty +% of MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU +% General Public License for more details. +% +% You should have received a copy of the GNU General Public License +% along with this program. If not, see . +% +% As a special exception, when this file is read by TeX when processing +% a Texinfo source document, you may use the result without +% restriction. (This has been our intent since Texinfo was invented.) +% +% Please try the latest version of texinfo.tex before submitting bug +% reports; you can get the latest version from: +% http://www.gnu.org/software/texinfo/ (the Texinfo home page), or +% ftp://tug.org/tex/texinfo.tex +% (and all CTAN mirrors, see http://www.ctan.org). +% The texinfo.tex in any given distribution could well be out +% of date, so if that's what you're using, please check. +% +% Send bug reports to bug-texinfo@gnu.org. Please include including a +% complete document in each bug report with which we can reproduce the +% problem. Patches are, of course, greatly appreciated. +% +% To process a Texinfo manual with TeX, it's most reliable to use the +% texi2dvi shell script that comes with the distribution. For a simple +% manual foo.texi, however, you can get away with this: +% tex foo.texi +% texindex foo.?? +% tex foo.texi +% tex foo.texi +% dvips foo.dvi -o # or whatever; this makes foo.ps. +% The extra TeX runs get the cross-reference information correct. +% Sometimes one run after texindex suffices, and sometimes you need more +% than two; texi2dvi does it as many times as necessary. +% +% It is possible to adapt texinfo.tex for other languages, to some +% extent. You can get the existing language-specific files from the +% full Texinfo distribution. +% +% The GNU Texinfo home page is http://www.gnu.org/software/texinfo. + + +\message{Loading texinfo [version \texinfoversion]:} + +% If in a .fmt file, print the version number +% and turn on active characters that we couldn't do earlier because +% they might have appeared in the input file name. +\everyjob{\message{[Texinfo version \texinfoversion]}% + \catcode`+=\active \catcode`\_=\active} + + +\chardef\other=12 + +% We never want plain's \outer definition of \+ in Texinfo. +% For @tex, we can use \tabalign. +\let\+ = \relax + +% Save some plain tex macros whose names we will redefine. +\let\ptexb=\b +\let\ptexbullet=\bullet +\let\ptexc=\c +\let\ptexcomma=\, +\let\ptexdot=\. +\let\ptexdots=\dots +\let\ptexend=\end +\let\ptexequiv=\equiv +\let\ptexexclam=\! +\let\ptexfootnote=\footnote +\let\ptexgtr=> +\let\ptexhat=^ +\let\ptexi=\i +\let\ptexindent=\indent +\let\ptexinsert=\insert +\let\ptexlbrace=\{ +\let\ptexless=< +\let\ptexnewwrite\newwrite +\let\ptexnoindent=\noindent +\let\ptexplus=+ +\let\ptexrbrace=\} +\let\ptexslash=\/ +\let\ptexstar=\* +\let\ptext=\t +\let\ptextop=\top +{\catcode`\'=\active +\global\let\ptexquoteright'}% Math-mode def from plain.tex. +\let\ptexraggedright=\raggedright + +% If this character appears in an error message or help string, it +% starts a new line in the output. +\newlinechar = `^^J + +% Use TeX 3.0's \inputlineno to get the line number, for better error +% messages, but if we're using an old version of TeX, don't do anything. +% +\ifx\inputlineno\thisisundefined + \let\linenumber = \empty % Pre-3.0. +\else + \def\linenumber{l.\the\inputlineno:\space} +\fi + +% Set up fixed words for English if not already set. +\ifx\putwordAppendix\undefined \gdef\putwordAppendix{Appendix}\fi +\ifx\putwordChapter\undefined \gdef\putwordChapter{Chapter}\fi +\ifx\putwordfile\undefined \gdef\putwordfile{file}\fi +\ifx\putwordin\undefined \gdef\putwordin{in}\fi +\ifx\putwordIndexIsEmpty\undefined \gdef\putwordIndexIsEmpty{(Index is empty)}\fi +\ifx\putwordIndexNonexistent\undefined \gdef\putwordIndexNonexistent{(Index is nonexistent)}\fi +\ifx\putwordInfo\undefined \gdef\putwordInfo{Info}\fi +\ifx\putwordInstanceVariableof\undefined \gdef\putwordInstanceVariableof{Instance Variable of}\fi +\ifx\putwordMethodon\undefined \gdef\putwordMethodon{Method on}\fi +\ifx\putwordNoTitle\undefined \gdef\putwordNoTitle{No Title}\fi +\ifx\putwordof\undefined \gdef\putwordof{of}\fi +\ifx\putwordon\undefined \gdef\putwordon{on}\fi +\ifx\putwordpage\undefined \gdef\putwordpage{page}\fi +\ifx\putwordsection\undefined \gdef\putwordsection{section}\fi +\ifx\putwordSection\undefined \gdef\putwordSection{Section}\fi +\ifx\putwordsee\undefined \gdef\putwordsee{see}\fi +\ifx\putwordSee\undefined \gdef\putwordSee{See}\fi +\ifx\putwordShortTOC\undefined \gdef\putwordShortTOC{Short Contents}\fi +\ifx\putwordTOC\undefined \gdef\putwordTOC{Table of Contents}\fi +% +\ifx\putwordMJan\undefined \gdef\putwordMJan{January}\fi +\ifx\putwordMFeb\undefined \gdef\putwordMFeb{February}\fi +\ifx\putwordMMar\undefined \gdef\putwordMMar{March}\fi +\ifx\putwordMApr\undefined \gdef\putwordMApr{April}\fi +\ifx\putwordMMay\undefined \gdef\putwordMMay{May}\fi +\ifx\putwordMJun\undefined \gdef\putwordMJun{June}\fi +\ifx\putwordMJul\undefined \gdef\putwordMJul{July}\fi +\ifx\putwordMAug\undefined \gdef\putwordMAug{August}\fi +\ifx\putwordMSep\undefined \gdef\putwordMSep{September}\fi +\ifx\putwordMOct\undefined \gdef\putwordMOct{October}\fi +\ifx\putwordMNov\undefined \gdef\putwordMNov{November}\fi +\ifx\putwordMDec\undefined \gdef\putwordMDec{December}\fi +% +\ifx\putwordDefmac\undefined \gdef\putwordDefmac{Macro}\fi +\ifx\putwordDefspec\undefined \gdef\putwordDefspec{Special Form}\fi +\ifx\putwordDefvar\undefined \gdef\putwordDefvar{Variable}\fi +\ifx\putwordDefopt\undefined \gdef\putwordDefopt{User Option}\fi +\ifx\putwordDeffunc\undefined \gdef\putwordDeffunc{Function}\fi + +% Since the category of space is not known, we have to be careful. +\chardef\spacecat = 10 +\def\spaceisspace{\catcode`\ =\spacecat} + +% sometimes characters are active, so we need control sequences. +\chardef\colonChar = `\: +\chardef\commaChar = `\, +\chardef\dashChar = `\- +\chardef\dotChar = `\. +\chardef\exclamChar= `\! +\chardef\lquoteChar= `\` +\chardef\questChar = `\? +\chardef\rquoteChar= `\' +\chardef\semiChar = `\; +\chardef\underChar = `\_ + +% Ignore a token. +% +\def\gobble#1{} + +% The following is used inside several \edef's. +\def\makecsname#1{\expandafter\noexpand\csname#1\endcsname} + +% Hyphenation fixes. +\hyphenation{ + Flor-i-da Ghost-script Ghost-view Mac-OS Post-Script + ap-pen-dix bit-map bit-maps + data-base data-bases eshell fall-ing half-way long-est man-u-script + man-u-scripts mini-buf-fer mini-buf-fers over-view par-a-digm + par-a-digms rath-er rec-tan-gu-lar ro-bot-ics se-vere-ly set-up spa-ces + spell-ing spell-ings + stand-alone strong-est time-stamp time-stamps which-ever white-space + wide-spread wrap-around +} + +% Margin to add to right of even pages, to left of odd pages. +\newdimen\bindingoffset +\newdimen\normaloffset +\newdimen\pagewidth \newdimen\pageheight + +% For a final copy, take out the rectangles +% that mark overfull boxes (in case you have decided +% that the text looks ok even though it passes the margin). +% +\def\finalout{\overfullrule=0pt} + +% @| inserts a changebar to the left of the current line. It should +% surround any changed text. This approach does *not* work if the +% change spans more than two lines of output. To handle that, we would +% have adopt a much more difficult approach (putting marks into the main +% vertical list for the beginning and end of each change). +% +\def\|{% + % \vadjust can only be used in horizontal mode. + \leavevmode + % + % Append this vertical mode material after the current line in the output. + \vadjust{% + % We want to insert a rule with the height and depth of the current + % leading; that is exactly what \strutbox is supposed to record. + \vskip-\baselineskip + % + % \vadjust-items are inserted at the left edge of the type. So + % the \llap here moves out into the left-hand margin. + \llap{% + % + % For a thicker or thinner bar, change the `1pt'. + \vrule height\baselineskip width1pt + % + % This is the space between the bar and the text. + \hskip 12pt + }% + }% +} + +% Sometimes it is convenient to have everything in the transcript file +% and nothing on the terminal. We don't just call \tracingall here, +% since that produces some useless output on the terminal. We also make +% some effort to order the tracing commands to reduce output in the log +% file; cf. trace.sty in LaTeX. +% +\def\gloggingall{\begingroup \globaldefs = 1 \loggingall \endgroup}% +\def\loggingall{% + \tracingstats2 + \tracingpages1 + \tracinglostchars2 % 2 gives us more in etex + \tracingparagraphs1 + \tracingoutput1 + \tracingmacros2 + \tracingrestores1 + \showboxbreadth\maxdimen \showboxdepth\maxdimen + \ifx\eTeXversion\undefined\else % etex gives us more logging + \tracingscantokens1 + \tracingifs1 + \tracinggroups1 + \tracingnesting2 + \tracingassigns1 + \fi + \tracingcommands3 % 3 gives us more in etex + \errorcontextlines16 +}% + +% add check for \lastpenalty to plain's definitions. If the last thing +% we did was a \nobreak, we don't want to insert more space. +% +\def\smallbreak{\ifnum\lastpenalty<10000\par\ifdim\lastskip<\smallskipamount + \removelastskip\penalty-50\smallskip\fi\fi} +\def\medbreak{\ifnum\lastpenalty<10000\par\ifdim\lastskip<\medskipamount + \removelastskip\penalty-100\medskip\fi\fi} +\def\bigbreak{\ifnum\lastpenalty<10000\par\ifdim\lastskip<\bigskipamount + \removelastskip\penalty-200\bigskip\fi\fi} + +% For @cropmarks command. +% Do @cropmarks to get crop marks. +% +\newif\ifcropmarks +\let\cropmarks = \cropmarkstrue +% +% Dimensions to add cropmarks at corners. +% Added by P. A. MacKay, 12 Nov. 1986 +% +\newdimen\outerhsize \newdimen\outervsize % set by the paper size routines +\newdimen\cornerlong \cornerlong=1pc +\newdimen\cornerthick \cornerthick=.3pt +\newdimen\topandbottommargin \topandbottommargin=.75in + +% Output a mark which sets \thischapter, \thissection and \thiscolor. +% We dump everything together because we only have one kind of mark. +% This works because we only use \botmark / \topmark, not \firstmark. +% +% A mark contains a subexpression of the \ifcase ... \fi construct. +% \get*marks macros below extract the needed part using \ifcase. +% +% Another complication is to let the user choose whether \thischapter +% (\thissection) refers to the chapter (section) in effect at the top +% of a page, or that at the bottom of a page. The solution is +% described on page 260 of The TeXbook. It involves outputting two +% marks for the sectioning macros, one before the section break, and +% one after. I won't pretend I can describe this better than DEK... +\def\domark{% + \toks0=\expandafter{\lastchapterdefs}% + \toks2=\expandafter{\lastsectiondefs}% + \toks4=\expandafter{\prevchapterdefs}% + \toks6=\expandafter{\prevsectiondefs}% + \toks8=\expandafter{\lastcolordefs}% + \mark{% + \the\toks0 \the\toks2 + \noexpand\or \the\toks4 \the\toks6 + \noexpand\else \the\toks8 + }% +} +% \topmark doesn't work for the very first chapter (after the title +% page or the contents), so we use \firstmark there -- this gets us +% the mark with the chapter defs, unless the user sneaks in, e.g., +% @setcolor (or @url, or @link, etc.) between @contents and the very +% first @chapter. +\def\gettopheadingmarks{% + \ifcase0\topmark\fi + \ifx\thischapter\empty \ifcase0\firstmark\fi \fi +} +\def\getbottomheadingmarks{\ifcase1\botmark\fi} +\def\getcolormarks{\ifcase2\topmark\fi} + +% Avoid "undefined control sequence" errors. +\def\lastchapterdefs{} +\def\lastsectiondefs{} +\def\prevchapterdefs{} +\def\prevsectiondefs{} +\def\lastcolordefs{} + +% Main output routine. +\chardef\PAGE = 255 +\output = {\onepageout{\pagecontents\PAGE}} + +\newbox\headlinebox +\newbox\footlinebox + +% \onepageout takes a vbox as an argument. Note that \pagecontents +% does insertions, but you have to call it yourself. +\def\onepageout#1{% + \ifcropmarks \hoffset=0pt \else \hoffset=\normaloffset \fi + % + \ifodd\pageno \advance\hoffset by \bindingoffset + \else \advance\hoffset by -\bindingoffset\fi + % + % Do this outside of the \shipout so @code etc. will be expanded in + % the headline as they should be, not taken literally (outputting ''code). + \ifodd\pageno \getoddheadingmarks \else \getevenheadingmarks \fi + \setbox\headlinebox = \vbox{\let\hsize=\pagewidth \makeheadline}% + \ifodd\pageno \getoddfootingmarks \else \getevenfootingmarks \fi + \setbox\footlinebox = \vbox{\let\hsize=\pagewidth \makefootline}% + % + {% + % Have to do this stuff outside the \shipout because we want it to + % take effect in \write's, yet the group defined by the \vbox ends + % before the \shipout runs. + % + \indexdummies % don't expand commands in the output. + \normalturnoffactive % \ in index entries must not stay \, e.g., if + % the page break happens to be in the middle of an example. + % We don't want .vr (or whatever) entries like this: + % \entry{{\tt \indexbackslash }acronym}{32}{\code {\acronym}} + % "\acronym" won't work when it's read back in; + % it needs to be + % {\code {{\tt \backslashcurfont }acronym} + \shipout\vbox{% + % Do this early so pdf references go to the beginning of the page. + \ifpdfmakepagedest \pdfdest name{\the\pageno} xyz\fi + % + \ifcropmarks \vbox to \outervsize\bgroup + \hsize = \outerhsize + \vskip-\topandbottommargin + \vtop to0pt{% + \line{\ewtop\hfil\ewtop}% + \nointerlineskip + \line{% + \vbox{\moveleft\cornerthick\nstop}% + \hfill + \vbox{\moveright\cornerthick\nstop}% + }% + \vss}% + \vskip\topandbottommargin + \line\bgroup + \hfil % center the page within the outer (page) hsize. + \ifodd\pageno\hskip\bindingoffset\fi + \vbox\bgroup + \fi + % + \unvbox\headlinebox + \pagebody{#1}% + \ifdim\ht\footlinebox > 0pt + % Only leave this space if the footline is nonempty. + % (We lessened \vsize for it in \oddfootingyyy.) + % The \baselineskip=24pt in plain's \makefootline has no effect. + \vskip 24pt + \unvbox\footlinebox + \fi + % + \ifcropmarks + \egroup % end of \vbox\bgroup + \hfil\egroup % end of (centering) \line\bgroup + \vskip\topandbottommargin plus1fill minus1fill + \boxmaxdepth = \cornerthick + \vbox to0pt{\vss + \line{% + \vbox{\moveleft\cornerthick\nsbot}% + \hfill + \vbox{\moveright\cornerthick\nsbot}% + }% + \nointerlineskip + \line{\ewbot\hfil\ewbot}% + }% + \egroup % \vbox from first cropmarks clause + \fi + }% end of \shipout\vbox + }% end of group with \indexdummies + \advancepageno + \ifnum\outputpenalty>-20000 \else\dosupereject\fi +} + +\newinsert\margin \dimen\margin=\maxdimen + +\def\pagebody#1{\vbox to\pageheight{\boxmaxdepth=\maxdepth #1}} +{\catcode`\@ =11 +\gdef\pagecontents#1{\ifvoid\topins\else\unvbox\topins\fi +% marginal hacks, juha@viisa.uucp (Juha Takala) +\ifvoid\margin\else % marginal info is present + \rlap{\kern\hsize\vbox to\z@{\kern1pt\box\margin \vss}}\fi +\dimen@=\dp#1\relax \unvbox#1\relax +\ifvoid\footins\else\vskip\skip\footins\footnoterule \unvbox\footins\fi +\ifr@ggedbottom \kern-\dimen@ \vfil \fi} +} + +% Here are the rules for the cropmarks. Note that they are +% offset so that the space between them is truly \outerhsize or \outervsize +% (P. A. MacKay, 12 November, 1986) +% +\def\ewtop{\vrule height\cornerthick depth0pt width\cornerlong} +\def\nstop{\vbox + {\hrule height\cornerthick depth\cornerlong width\cornerthick}} +\def\ewbot{\vrule height0pt depth\cornerthick width\cornerlong} +\def\nsbot{\vbox + {\hrule height\cornerlong depth\cornerthick width\cornerthick}} + +% Parse an argument, then pass it to #1. The argument is the rest of +% the input line (except we remove a trailing comment). #1 should be a +% macro which expects an ordinary undelimited TeX argument. +% +\def\parsearg{\parseargusing{}} +\def\parseargusing#1#2{% + \def\argtorun{#2}% + \begingroup + \obeylines + \spaceisspace + #1% + \parseargline\empty% Insert the \empty token, see \finishparsearg below. +} + +{\obeylines % + \gdef\parseargline#1^^M{% + \endgroup % End of the group started in \parsearg. + \argremovecomment #1\comment\ArgTerm% + }% +} + +% First remove any @comment, then any @c comment. +\def\argremovecomment#1\comment#2\ArgTerm{\argremovec #1\c\ArgTerm} +\def\argremovec#1\c#2\ArgTerm{\argcheckspaces#1\^^M\ArgTerm} + +% Each occurrence of `\^^M' or `\^^M' is replaced by a single space. +% +% \argremovec might leave us with trailing space, e.g., +% @end itemize @c foo +% This space token undergoes the same procedure and is eventually removed +% by \finishparsearg. +% +\def\argcheckspaces#1\^^M{\argcheckspacesX#1\^^M \^^M} +\def\argcheckspacesX#1 \^^M{\argcheckspacesY#1\^^M} +\def\argcheckspacesY#1\^^M#2\^^M#3\ArgTerm{% + \def\temp{#3}% + \ifx\temp\empty + % Do not use \next, perhaps the caller of \parsearg uses it; reuse \temp: + \let\temp\finishparsearg + \else + \let\temp\argcheckspaces + \fi + % Put the space token in: + \temp#1 #3\ArgTerm +} + +% If a _delimited_ argument is enclosed in braces, they get stripped; so +% to get _exactly_ the rest of the line, we had to prevent such situation. +% We prepended an \empty token at the very beginning and we expand it now, +% just before passing the control to \argtorun. +% (Similarly, we have to think about #3 of \argcheckspacesY above: it is +% either the null string, or it ends with \^^M---thus there is no danger +% that a pair of braces would be stripped. +% +% But first, we have to remove the trailing space token. +% +\def\finishparsearg#1 \ArgTerm{\expandafter\argtorun\expandafter{#1}} + +% \parseargdef\foo{...} +% is roughly equivalent to +% \def\foo{\parsearg\Xfoo} +% \def\Xfoo#1{...} +% +% Actually, I use \csname\string\foo\endcsname, ie. \\foo, as it is my +% favourite TeX trick. --kasal, 16nov03 + +\def\parseargdef#1{% + \expandafter \doparseargdef \csname\string#1\endcsname #1% +} +\def\doparseargdef#1#2{% + \def#2{\parsearg#1}% + \def#1##1% +} + +% Several utility definitions with active space: +{ + \obeyspaces + \gdef\obeyedspace{ } + + % Make each space character in the input produce a normal interword + % space in the output. Don't allow a line break at this space, as this + % is used only in environments like @example, where each line of input + % should produce a line of output anyway. + % + \gdef\sepspaces{\obeyspaces\let =\tie} + + % If an index command is used in an @example environment, any spaces + % therein should become regular spaces in the raw index file, not the + % expansion of \tie (\leavevmode \penalty \@M \ ). + \gdef\unsepspaces{\let =\space} +} + + +\def\flushcr{\ifx\par\lisppar \def\next##1{}\else \let\next=\relax \fi \next} + +% Define the framework for environments in texinfo.tex. It's used like this: +% +% \envdef\foo{...} +% \def\Efoo{...} +% +% It's the responsibility of \envdef to insert \begingroup before the +% actual body; @end closes the group after calling \Efoo. \envdef also +% defines \thisenv, so the current environment is known; @end checks +% whether the environment name matches. The \checkenv macro can also be +% used to check whether the current environment is the one expected. +% +% Non-false conditionals (@iftex, @ifset) don't fit into this, so they +% are not treated as environments; they don't open a group. (The +% implementation of @end takes care not to call \endgroup in this +% special case.) + + +% At run-time, environments start with this: +\def\startenvironment#1{\begingroup\def\thisenv{#1}} +% initialize +\let\thisenv\empty + +% ... but they get defined via ``\envdef\foo{...}'': +\long\def\envdef#1#2{\def#1{\startenvironment#1#2}} +\def\envparseargdef#1#2{\parseargdef#1{\startenvironment#1#2}} + +% Check whether we're in the right environment: +\def\checkenv#1{% + \def\temp{#1}% + \ifx\thisenv\temp + \else + \badenverr + \fi +} + +% Environment mismatch, #1 expected: +\def\badenverr{% + \errhelp = \EMsimple + \errmessage{This command can appear only \inenvironment\temp, + not \inenvironment\thisenv}% +} +\def\inenvironment#1{% + \ifx#1\empty + out of any environment% + \else + in environment \expandafter\string#1% + \fi +} + +% @end foo executes the definition of \Efoo. +% But first, it executes a specialized version of \checkenv +% +\parseargdef\end{% + \if 1\csname iscond.#1\endcsname + \else + % The general wording of \badenverr may not be ideal, but... --kasal, 06nov03 + \expandafter\checkenv\csname#1\endcsname + \csname E#1\endcsname + \endgroup + \fi +} + +\newhelp\EMsimple{Press RETURN to continue.} + + +%% Simple single-character @ commands + +% @@ prints an @ +% Kludge this until the fonts are right (grr). +\def\@{{\tt\char64}} + +% This is turned off because it was never documented +% and you can use @w{...} around a quote to suppress ligatures. +%% Define @` and @' to be the same as ` and ' +%% but suppressing ligatures. +%\def\`{{`}} +%\def\'{{'}} + +% Used to generate quoted braces. +\def\mylbrace {{\tt\char123}} +\def\myrbrace {{\tt\char125}} +\let\{=\mylbrace +\let\}=\myrbrace +\begingroup + % Definitions to produce \{ and \} commands for indices, + % and @{ and @} for the aux/toc files. + \catcode`\{ = \other \catcode`\} = \other + \catcode`\[ = 1 \catcode`\] = 2 + \catcode`\! = 0 \catcode`\\ = \other + !gdef!lbracecmd[\{]% + !gdef!rbracecmd[\}]% + !gdef!lbraceatcmd[@{]% + !gdef!rbraceatcmd[@}]% +!endgroup + +% @comma{} to avoid , parsing problems. +\let\comma = , + +% Accents: @, @dotaccent @ringaccent @ubaraccent @udotaccent +% Others are defined by plain TeX: @` @' @" @^ @~ @= @u @v @H. +\let\, = \c +\let\dotaccent = \. +\def\ringaccent#1{{\accent23 #1}} +\let\tieaccent = \t +\let\ubaraccent = \b +\let\udotaccent = \d + +% Other special characters: @questiondown @exclamdown @ordf @ordm +% Plain TeX defines: @AA @AE @O @OE @L (plus lowercase versions) @ss. +\def\questiondown{?`} +\def\exclamdown{!`} +\def\ordf{\leavevmode\raise1ex\hbox{\selectfonts\lllsize \underbar{a}}} +\def\ordm{\leavevmode\raise1ex\hbox{\selectfonts\lllsize \underbar{o}}} + +% Dotless i and dotless j, used for accents. +\def\imacro{i} +\def\jmacro{j} +\def\dotless#1{% + \def\temp{#1}% + \ifx\temp\imacro \ifmmode\imath \else\ptexi \fi + \else\ifx\temp\jmacro \ifmmode\jmath \else\j \fi + \else \errmessage{@dotless can be used only with i or j}% + \fi\fi +} + +% The \TeX{} logo, as in plain, but resetting the spacing so that a +% period following counts as ending a sentence. (Idea found in latex.) +% +\edef\TeX{\TeX \spacefactor=1000 } + +% @LaTeX{} logo. Not quite the same results as the definition in +% latex.ltx, since we use a different font for the raised A; it's most +% convenient for us to use an explicitly smaller font, rather than using +% the \scriptstyle font (since we don't reset \scriptstyle and +% \scriptscriptstyle). +% +\def\LaTeX{% + L\kern-.36em + {\setbox0=\hbox{T}% + \vbox to \ht0{\hbox{\selectfonts\lllsize A}\vss}}% + \kern-.15em + \TeX +} + +% Be sure we're in horizontal mode when doing a tie, since we make space +% equivalent to this in @example-like environments. Otherwise, a space +% at the beginning of a line will start with \penalty -- and +% since \penalty is valid in vertical mode, we'd end up putting the +% penalty on the vertical list instead of in the new paragraph. +{\catcode`@ = 11 + % Avoid using \@M directly, because that causes trouble + % if the definition is written into an index file. + \global\let\tiepenalty = \@M + \gdef\tie{\leavevmode\penalty\tiepenalty\ } +} + +% @: forces normal size whitespace following. +\def\:{\spacefactor=1000 } + +% @* forces a line break. +\def\*{\hfil\break\hbox{}\ignorespaces} + +% @/ allows a line break. +\let\/=\allowbreak + +% @. is an end-of-sentence period. +\def\.{.\spacefactor=\endofsentencespacefactor\space} + +% @! is an end-of-sentence bang. +\def\!{!\spacefactor=\endofsentencespacefactor\space} + +% @? is an end-of-sentence query. +\def\?{?\spacefactor=\endofsentencespacefactor\space} + +% @frenchspacing on|off says whether to put extra space after punctuation. +% +\def\onword{on} +\def\offword{off} +% +\parseargdef\frenchspacing{% + \def\temp{#1}% + \ifx\temp\onword \plainfrenchspacing + \else\ifx\temp\offword \plainnonfrenchspacing + \else + \errhelp = \EMsimple + \errmessage{Unknown @frenchspacing option `\temp', must be on/off}% + \fi\fi +} + +% @w prevents a word break. Without the \leavevmode, @w at the +% beginning of a paragraph, when TeX is still in vertical mode, would +% produce a whole line of output instead of starting the paragraph. +\def\w#1{\leavevmode\hbox{#1}} + +% @group ... @end group forces ... to be all on one page, by enclosing +% it in a TeX vbox. We use \vtop instead of \vbox to construct the box +% to keep its height that of a normal line. According to the rules for +% \topskip (p.114 of the TeXbook), the glue inserted is +% max (\topskip - \ht (first item), 0). If that height is large, +% therefore, no glue is inserted, and the space between the headline and +% the text is small, which looks bad. +% +% Another complication is that the group might be very large. This can +% cause the glue on the previous page to be unduly stretched, because it +% does not have much material. In this case, it's better to add an +% explicit \vfill so that the extra space is at the bottom. The +% threshold for doing this is if the group is more than \vfilllimit +% percent of a page (\vfilllimit can be changed inside of @tex). +% +\newbox\groupbox +\def\vfilllimit{0.7} +% +\envdef\group{% + \ifnum\catcode`\^^M=\active \else + \errhelp = \groupinvalidhelp + \errmessage{@group invalid in context where filling is enabled}% + \fi + \startsavinginserts + % + \setbox\groupbox = \vtop\bgroup + % Do @comment since we are called inside an environment such as + % @example, where each end-of-line in the input causes an + % end-of-line in the output. We don't want the end-of-line after + % the `@group' to put extra space in the output. Since @group + % should appear on a line by itself (according to the Texinfo + % manual), we don't worry about eating any user text. + \comment +} +% +% The \vtop produces a box with normal height and large depth; thus, TeX puts +% \baselineskip glue before it, and (when the next line of text is done) +% \lineskip glue after it. Thus, space below is not quite equal to space +% above. But it's pretty close. +\def\Egroup{% + % To get correct interline space between the last line of the group + % and the first line afterwards, we have to propagate \prevdepth. + \endgraf % Not \par, as it may have been set to \lisppar. + \global\dimen1 = \prevdepth + \egroup % End the \vtop. + % \dimen0 is the vertical size of the group's box. + \dimen0 = \ht\groupbox \advance\dimen0 by \dp\groupbox + % \dimen2 is how much space is left on the page (more or less). + \dimen2 = \pageheight \advance\dimen2 by -\pagetotal + % if the group doesn't fit on the current page, and it's a big big + % group, force a page break. + \ifdim \dimen0 > \dimen2 + \ifdim \pagetotal < \vfilllimit\pageheight + \page + \fi + \fi + \box\groupbox + \prevdepth = \dimen1 + \checkinserts +} +% +% TeX puts in an \escapechar (i.e., `@') at the beginning of the help +% message, so this ends up printing `@group can only ...'. +% +\newhelp\groupinvalidhelp{% +group can only be used in environments such as @example,^^J% +where each line of input produces a line of output.} + +% @need space-in-mils +% forces a page break if there is not space-in-mils remaining. + +\newdimen\mil \mil=0.001in + +% Old definition--didn't work. +%\parseargdef\need{\par % +%% This method tries to make TeX break the page naturally +%% if the depth of the box does not fit. +%{\baselineskip=0pt% +%\vtop to #1\mil{\vfil}\kern -#1\mil\nobreak +%\prevdepth=-1000pt +%}} + +\parseargdef\need{% + % Ensure vertical mode, so we don't make a big box in the middle of a + % paragraph. + \par + % + % If the @need value is less than one line space, it's useless. + \dimen0 = #1\mil + \dimen2 = \ht\strutbox + \advance\dimen2 by \dp\strutbox + \ifdim\dimen0 > \dimen2 + % + % Do a \strut just to make the height of this box be normal, so the + % normal leading is inserted relative to the preceding line. + % And a page break here is fine. + \vtop to #1\mil{\strut\vfil}% + % + % TeX does not even consider page breaks if a penalty added to the + % main vertical list is 10000 or more. But in order to see if the + % empty box we just added fits on the page, we must make it consider + % page breaks. On the other hand, we don't want to actually break the + % page after the empty box. So we use a penalty of 9999. + % + % There is an extremely small chance that TeX will actually break the + % page at this \penalty, if there are no other feasible breakpoints in + % sight. (If the user is using lots of big @group commands, which + % almost-but-not-quite fill up a page, TeX will have a hard time doing + % good page breaking, for example.) However, I could not construct an + % example where a page broke at this \penalty; if it happens in a real + % document, then we can reconsider our strategy. + \penalty9999 + % + % Back up by the size of the box, whether we did a page break or not. + \kern -#1\mil + % + % Do not allow a page break right after this kern. + \nobreak + \fi +} + +% @br forces paragraph break (and is undocumented). + +\let\br = \par + +% @page forces the start of a new page. +% +\def\page{\par\vfill\supereject} + +% @exdent text.... +% outputs text on separate line in roman font, starting at standard page margin + +% This records the amount of indent in the innermost environment. +% That's how much \exdent should take out. +\newskip\exdentamount + +% This defn is used inside fill environments such as @defun. +\parseargdef\exdent{\hfil\break\hbox{\kern -\exdentamount{\rm#1}}\hfil\break} + +% This defn is used inside nofill environments such as @example. +\parseargdef\nofillexdent{{\advance \leftskip by -\exdentamount + \leftline{\hskip\leftskip{\rm#1}}}} + +% @inmargin{WHICH}{TEXT} puts TEXT in the WHICH margin next to the current +% paragraph. For more general purposes, use the \margin insertion +% class. WHICH is `l' or `r'. +% +\newskip\inmarginspacing \inmarginspacing=1cm +\def\strutdepth{\dp\strutbox} +% +\def\doinmargin#1#2{\strut\vadjust{% + \nobreak + \kern-\strutdepth + \vtop to \strutdepth{% + \baselineskip=\strutdepth + \vss + % if you have multiple lines of stuff to put here, you'll need to + % make the vbox yourself of the appropriate size. + \ifx#1l% + \llap{\ignorespaces #2\hskip\inmarginspacing}% + \else + \rlap{\hskip\hsize \hskip\inmarginspacing \ignorespaces #2}% + \fi + \null + }% +}} +\def\inleftmargin{\doinmargin l} +\def\inrightmargin{\doinmargin r} +% +% @inmargin{TEXT [, RIGHT-TEXT]} +% (if RIGHT-TEXT is given, use TEXT for left page, RIGHT-TEXT for right; +% else use TEXT for both). +% +\def\inmargin#1{\parseinmargin #1,,\finish} +\def\parseinmargin#1,#2,#3\finish{% not perfect, but better than nothing. + \setbox0 = \hbox{\ignorespaces #2}% + \ifdim\wd0 > 0pt + \def\lefttext{#1}% have both texts + \def\righttext{#2}% + \else + \def\lefttext{#1}% have only one text + \def\righttext{#1}% + \fi + % + \ifodd\pageno + \def\temp{\inrightmargin\righttext}% odd page -> outside is right margin + \else + \def\temp{\inleftmargin\lefttext}% + \fi + \temp +} + +% @include FILE -- \input text of FILE. +% +\def\include{\parseargusing\filenamecatcodes\includezzz} +\def\includezzz#1{% + \pushthisfilestack + \def\thisfile{#1}% + {% + \makevalueexpandable % we want to expand any @value in FILE. + \turnoffactive % and allow special characters in the expansion + \indexnofonts % Allow `@@' and other weird things in file names. + \edef\temp{\noexpand\input #1 }% + % + % This trickery is to read FILE outside of a group, in case it makes + % definitions, etc. + \expandafter + }\temp + \popthisfilestack +} +\def\filenamecatcodes{% + \catcode`\\=\other + \catcode`~=\other + \catcode`^=\other + \catcode`_=\other + \catcode`|=\other + \catcode`<=\other + \catcode`>=\other + \catcode`+=\other + \catcode`-=\other + \catcode`\`=\other + \catcode`\'=\other +} + +\def\pushthisfilestack{% + \expandafter\pushthisfilestackX\popthisfilestack\StackTerm +} +\def\pushthisfilestackX{% + \expandafter\pushthisfilestackY\thisfile\StackTerm +} +\def\pushthisfilestackY #1\StackTerm #2\StackTerm {% + \gdef\popthisfilestack{\gdef\thisfile{#1}\gdef\popthisfilestack{#2}}% +} + +\def\popthisfilestack{\errthisfilestackempty} +\def\errthisfilestackempty{\errmessage{Internal error: + the stack of filenames is empty.}} + +\def\thisfile{} + +% @center line +% outputs that line, centered. +% +\parseargdef\center{% + \ifhmode + \let\next\centerH + \else + \let\next\centerV + \fi + \next{\hfil \ignorespaces#1\unskip \hfil}% +} +\def\centerH#1{% + {% + \hfil\break + \advance\hsize by -\leftskip + \advance\hsize by -\rightskip + \line{#1}% + \break + }% +} +\def\centerV#1{\line{\kern\leftskip #1\kern\rightskip}} + +% @sp n outputs n lines of vertical space + +\parseargdef\sp{\vskip #1\baselineskip} + +% @comment ...line which is ignored... +% @c is the same as @comment +% @ignore ... @end ignore is another way to write a comment + +\def\comment{\begingroup \catcode`\^^M=\other% +\catcode`\@=\other \catcode`\{=\other \catcode`\}=\other% +\commentxxx} +{\catcode`\^^M=\other \gdef\commentxxx#1^^M{\endgroup}} + +\let\c=\comment + +% @paragraphindent NCHARS +% We'll use ems for NCHARS, close enough. +% NCHARS can also be the word `asis' or `none'. +% We cannot feasibly implement @paragraphindent asis, though. +% +\def\asisword{asis} % no translation, these are keywords +\def\noneword{none} +% +\parseargdef\paragraphindent{% + \def\temp{#1}% + \ifx\temp\asisword + \else + \ifx\temp\noneword + \defaultparindent = 0pt + \else + \defaultparindent = #1em + \fi + \fi + \parindent = \defaultparindent +} + +% @exampleindent NCHARS +% We'll use ems for NCHARS like @paragraphindent. +% It seems @exampleindent asis isn't necessary, but +% I preserve it to make it similar to @paragraphindent. +\parseargdef\exampleindent{% + \def\temp{#1}% + \ifx\temp\asisword + \else + \ifx\temp\noneword + \lispnarrowing = 0pt + \else + \lispnarrowing = #1em + \fi + \fi +} + +% @firstparagraphindent WORD +% If WORD is `none', then suppress indentation of the first paragraph +% after a section heading. If WORD is `insert', then do indent at such +% paragraphs. +% +% The paragraph indentation is suppressed or not by calling +% \suppressfirstparagraphindent, which the sectioning commands do. +% We switch the definition of this back and forth according to WORD. +% By default, we suppress indentation. +% +\def\suppressfirstparagraphindent{\dosuppressfirstparagraphindent} +\def\insertword{insert} +% +\parseargdef\firstparagraphindent{% + \def\temp{#1}% + \ifx\temp\noneword + \let\suppressfirstparagraphindent = \dosuppressfirstparagraphindent + \else\ifx\temp\insertword + \let\suppressfirstparagraphindent = \relax + \else + \errhelp = \EMsimple + \errmessage{Unknown @firstparagraphindent option `\temp'}% + \fi\fi +} + +% Here is how we actually suppress indentation. Redefine \everypar to +% \kern backwards by \parindent, and then reset itself to empty. +% +% We also make \indent itself not actually do anything until the next +% paragraph. +% +\gdef\dosuppressfirstparagraphindent{% + \gdef\indent{% + \restorefirstparagraphindent + \indent + }% + \gdef\noindent{% + \restorefirstparagraphindent + \noindent + }% + \global\everypar = {% + \kern -\parindent + \restorefirstparagraphindent + }% +} + +\gdef\restorefirstparagraphindent{% + \global \let \indent = \ptexindent + \global \let \noindent = \ptexnoindent + \global \everypar = {}% +} + + +% @asis just yields its argument. Used with @table, for example. +% +\def\asis#1{#1} + +% @math outputs its argument in math mode. +% +% One complication: _ usually means subscripts, but it could also mean +% an actual _ character, as in @math{@var{some_variable} + 1}. So make +% _ active, and distinguish by seeing if the current family is \slfam, +% which is what @var uses. +{ + \catcode`\_ = \active + \gdef\mathunderscore{% + \catcode`\_=\active + \def_{\ifnum\fam=\slfam \_\else\sb\fi}% + } +} +% Another complication: we want \\ (and @\) to output a \ character. +% FYI, plain.tex uses \\ as a temporary control sequence (why?), but +% this is not advertised and we don't care. Texinfo does not +% otherwise define @\. +% +% The \mathchar is class=0=ordinary, family=7=ttfam, position=5C=\. +\def\mathbackslash{\ifnum\fam=\ttfam \mathchar"075C \else\backslash \fi} +% +\def\math{% + \tex + \mathunderscore + \let\\ = \mathbackslash + \mathactive + % make the texinfo accent commands work in math mode + \let\"=\ddot + \let\'=\acute + \let\==\bar + \let\^=\hat + \let\`=\grave + \let\u=\breve + \let\v=\check + \let\~=\tilde + \let\dotaccent=\dot + $\finishmath +} +\def\finishmath#1{#1$\endgroup} % Close the group opened by \tex. + +% Some active characters (such as <) are spaced differently in math. +% We have to reset their definitions in case the @math was an argument +% to a command which sets the catcodes (such as @item or @section). +% +{ + \catcode`^ = \active + \catcode`< = \active + \catcode`> = \active + \catcode`+ = \active + \catcode`' = \active + \gdef\mathactive{% + \let^ = \ptexhat + \let< = \ptexless + \let> = \ptexgtr + \let+ = \ptexplus + \let' = \ptexquoteright + } +} + +% Some math mode symbols. +\def\bullet{$\ptexbullet$} +\def\geq{\ifmmode \ge\else $\ge$\fi} +\def\leq{\ifmmode \le\else $\le$\fi} +\def\minus{\ifmmode -\else $-$\fi} + +% @dots{} outputs an ellipsis using the current font. +% We do .5em per period so that it has the same spacing in the cm +% typewriter fonts as three actual period characters; on the other hand, +% in other typewriter fonts three periods are wider than 1.5em. So do +% whichever is larger. +% +\def\dots{% + \leavevmode + \setbox0=\hbox{...}% get width of three periods + \ifdim\wd0 > 1.5em + \dimen0 = \wd0 + \else + \dimen0 = 1.5em + \fi + \hbox to \dimen0{% + \hskip 0pt plus.25fil + .\hskip 0pt plus1fil + .\hskip 0pt plus1fil + .\hskip 0pt plus.5fil + }% +} + +% @enddots{} is an end-of-sentence ellipsis. +% +\def\enddots{% + \dots + \spacefactor=\endofsentencespacefactor +} + +% @comma{} is so commas can be inserted into text without messing up +% Texinfo's parsing. +% +\let\comma = , + +% @refill is a no-op. +\let\refill=\relax + +% If working on a large document in chapters, it is convenient to +% be able to disable indexing, cross-referencing, and contents, for test runs. +% This is done with @novalidate (before @setfilename). +% +\newif\iflinks \linkstrue % by default we want the aux files. +\let\novalidate = \linksfalse + +% @setfilename is done at the beginning of every texinfo file. +% So open here the files we need to have open while reading the input. +% This makes it possible to make a .fmt file for texinfo. +\def\setfilename{% + \fixbackslash % Turn off hack to swallow `\input texinfo'. + \iflinks + \tryauxfile + % Open the new aux file. TeX will close it automatically at exit. + \immediate\openout\auxfile=\jobname.aux + \fi % \openindices needs to do some work in any case. + \openindices + \let\setfilename=\comment % Ignore extra @setfilename cmds. + % + % If texinfo.cnf is present on the system, read it. + % Useful for site-wide @afourpaper, etc. + \openin 1 texinfo.cnf + \ifeof 1 \else \input texinfo.cnf \fi + \closein 1 + % + \comment % Ignore the actual filename. +} + +% Called from \setfilename. +% +\def\openindices{% + \newindex{cp}% + \newcodeindex{fn}% + \newcodeindex{vr}% + \newcodeindex{tp}% + \newcodeindex{ky}% + \newcodeindex{pg}% +} + +% @bye. +\outer\def\bye{\pagealignmacro\tracingstats=1\ptexend} + + +\message{pdf,} +% adobe `portable' document format +\newcount\tempnum +\newcount\lnkcount +\newtoks\filename +\newcount\filenamelength +\newcount\pgn +\newtoks\toksA +\newtoks\toksB +\newtoks\toksC +\newtoks\toksD +\newbox\boxA +\newcount\countA +\newif\ifpdf +\newif\ifpdfmakepagedest + +% when pdftex is run in dvi mode, \pdfoutput is defined (so \pdfoutput=1 +% can be set). So we test for \relax and 0 as well as \undefined, +% borrowed from ifpdf.sty. +\ifx\pdfoutput\undefined +\else + \ifx\pdfoutput\relax + \else + \ifcase\pdfoutput + \else + \pdftrue + \fi + \fi +\fi + +% PDF uses PostScript string constants for the names of xref targets, +% for display in the outlines, and in other places. Thus, we have to +% double any backslashes. Otherwise, a name like "\node" will be +% interpreted as a newline (\n), followed by o, d, e. Not good. +% http://www.ntg.nl/pipermail/ntg-pdftex/2004-July/000654.html +% (and related messages, the final outcome is that it is up to the TeX +% user to double the backslashes and otherwise make the string valid, so +% that's what we do). + +% double active backslashes. +% +{\catcode`\@=0 \catcode`\\=\active + @gdef@activebackslashdouble{% + @catcode`@\=@active + @let\=@doublebackslash} +} + +% To handle parens, we must adopt a different approach, since parens are +% not active characters. hyperref.dtx (which has the same problem as +% us) handles it with this amazing macro to replace tokens, with minor +% changes for Texinfo. It is included here under the GPL by permission +% from the author, Heiko Oberdiek. +% +% #1 is the tokens to replace. +% #2 is the replacement. +% #3 is the control sequence with the string. +% +\def\HyPsdSubst#1#2#3{% + \def\HyPsdReplace##1#1##2\END{% + ##1% + \ifx\\##2\\% + \else + #2% + \HyReturnAfterFi{% + \HyPsdReplace##2\END + }% + \fi + }% + \xdef#3{\expandafter\HyPsdReplace#3#1\END}% +} +\long\def\HyReturnAfterFi#1\fi{\fi#1} + +% #1 is a control sequence in which to do the replacements. +\def\backslashparens#1{% + \xdef#1{#1}% redefine it as its expansion; the definition is simply + % \lastnode when called from \setref -> \pdfmkdest. + \HyPsdSubst{(}{\realbackslash(}{#1}% + \HyPsdSubst{)}{\realbackslash)}{#1}% +} + +\newhelp\nopdfimagehelp{Texinfo supports .png, .jpg, .jpeg, and .pdf images +with PDF output, and none of those formats could be found. (.eps cannot +be supported due to the design of the PDF format; use regular TeX (DVI +output) for that.)} + +\ifpdf + % + % Color manipulation macros based on pdfcolor.tex, + % except using rgb instead of cmyk; the latter is said to render as a + % very dark gray on-screen and a very dark halftone in print, instead + % of actual black. + \def\rgbDarkRed{0.50 0.09 0.12} + \def\rgbBlack{0 0 0} + % + % k sets the color for filling (usual text, etc.); + % K sets the color for stroking (thin rules, e.g., normal _'s). + \def\pdfsetcolor#1{\pdfliteral{#1 rg #1 RG}} + % + % Set color, and create a mark which defines \thiscolor accordingly, + % so that \makeheadline knows which color to restore. + \def\setcolor#1{% + \xdef\lastcolordefs{\gdef\noexpand\thiscolor{#1}}% + \domark + \pdfsetcolor{#1}% + } + % + \def\maincolor{\rgbBlack} + \pdfsetcolor{\maincolor} + \edef\thiscolor{\maincolor} + \def\lastcolordefs{} + % + \def\makefootline{% + \baselineskip24pt + \line{\pdfsetcolor{\maincolor}\the\footline}% + } + % + \def\makeheadline{% + \vbox to 0pt{% + \vskip-22.5pt + \line{% + \vbox to8.5pt{}% + % Extract \thiscolor definition from the marks. + \getcolormarks + % Typeset the headline with \maincolor, then restore the color. + \pdfsetcolor{\maincolor}\the\headline\pdfsetcolor{\thiscolor}% + }% + \vss + }% + \nointerlineskip + } + % + % + \pdfcatalog{/PageMode /UseOutlines} + % + % #1 is image name, #2 width (might be empty/whitespace), #3 height (ditto). + \def\dopdfimage#1#2#3{% + \def\imagewidth{#2}\setbox0 = \hbox{\ignorespaces #2}% + \def\imageheight{#3}\setbox2 = \hbox{\ignorespaces #3}% + % + % pdftex (and the PDF format) support .png, .jpg, .pdf (among + % others). Let's try in that order. + \let\pdfimgext=\empty + \begingroup + \openin 1 #1.png \ifeof 1 + \openin 1 #1.jpg \ifeof 1 + \openin 1 #1.jpeg \ifeof 1 + \openin 1 #1.JPG \ifeof 1 + \openin 1 #1.pdf \ifeof 1 + \openin 1 #1.PDF \ifeof 1 + \errhelp = \nopdfimagehelp + \errmessage{Could not find image file #1 for pdf}% + \else \gdef\pdfimgext{PDF}% + \fi + \else \gdef\pdfimgext{pdf}% + \fi + \else \gdef\pdfimgext{JPG}% + \fi + \else \gdef\pdfimgext{jpeg}% + \fi + \else \gdef\pdfimgext{jpg}% + \fi + \else \gdef\pdfimgext{png}% + \fi + \closein 1 + \endgroup + % + % without \immediate, ancient pdftex seg faults when the same image is + % included twice. (Version 3.14159-pre-1.0-unofficial-20010704.) + \ifnum\pdftexversion < 14 + \immediate\pdfimage + \else + \immediate\pdfximage + \fi + \ifdim \wd0 >0pt width \imagewidth \fi + \ifdim \wd2 >0pt height \imageheight \fi + \ifnum\pdftexversion<13 + #1.\pdfimgext + \else + {#1.\pdfimgext}% + \fi + \ifnum\pdftexversion < 14 \else + \pdfrefximage \pdflastximage + \fi} + % + \def\pdfmkdest#1{{% + % We have to set dummies so commands such as @code, and characters + % such as \, aren't expanded when present in a section title. + \indexnofonts + \turnoffactive + \activebackslashdouble + \makevalueexpandable + \def\pdfdestname{#1}% + \backslashparens\pdfdestname + \safewhatsit{\pdfdest name{\pdfdestname} xyz}% + }} + % + % used to mark target names; must be expandable. + \def\pdfmkpgn#1{#1} + % + % by default, use a color that is dark enough to print on paper as + % nearly black, but still distinguishable for online viewing. + \def\urlcolor{\rgbDarkRed} + \def\linkcolor{\rgbDarkRed} + \def\endlink{\setcolor{\maincolor}\pdfendlink} + % + % Adding outlines to PDF; macros for calculating structure of outlines + % come from Petr Olsak + \def\expnumber#1{\expandafter\ifx\csname#1\endcsname\relax 0% + \else \csname#1\endcsname \fi} + \def\advancenumber#1{\tempnum=\expnumber{#1}\relax + \advance\tempnum by 1 + \expandafter\xdef\csname#1\endcsname{\the\tempnum}} + % + % #1 is the section text, which is what will be displayed in the + % outline by the pdf viewer. #2 is the pdf expression for the number + % of subentries (or empty, for subsubsections). #3 is the node text, + % which might be empty if this toc entry had no corresponding node. + % #4 is the page number + % + \def\dopdfoutline#1#2#3#4{% + % Generate a link to the node text if that exists; else, use the + % page number. We could generate a destination for the section + % text in the case where a section has no node, but it doesn't + % seem worth the trouble, since most documents are normally structured. + \def\pdfoutlinedest{#3}% + \ifx\pdfoutlinedest\empty + \def\pdfoutlinedest{#4}% + \else + % Doubled backslashes in the name. + {\activebackslashdouble \xdef\pdfoutlinedest{#3}% + \backslashparens\pdfoutlinedest}% + \fi + % + % Also double the backslashes in the display string. + {\activebackslashdouble \xdef\pdfoutlinetext{#1}% + \backslashparens\pdfoutlinetext}% + % + \pdfoutline goto name{\pdfmkpgn{\pdfoutlinedest}}#2{\pdfoutlinetext}% + } + % + \def\pdfmakeoutlines{% + \begingroup + % Thanh's hack / proper braces in bookmarks + \edef\mylbrace{\iftrue \string{\else}\fi}\let\{=\mylbrace + \edef\myrbrace{\iffalse{\else\string}\fi}\let\}=\myrbrace + % + % Read toc silently, to get counts of subentries for \pdfoutline. + \def\numchapentry##1##2##3##4{% + \def\thischapnum{##2}% + \def\thissecnum{0}% + \def\thissubsecnum{0}% + }% + \def\numsecentry##1##2##3##4{% + \advancenumber{chap\thischapnum}% + \def\thissecnum{##2}% + \def\thissubsecnum{0}% + }% + \def\numsubsecentry##1##2##3##4{% + \advancenumber{sec\thissecnum}% + \def\thissubsecnum{##2}% + }% + \def\numsubsubsecentry##1##2##3##4{% + \advancenumber{subsec\thissubsecnum}% + }% + \def\thischapnum{0}% + \def\thissecnum{0}% + \def\thissubsecnum{0}% + % + % use \def rather than \let here because we redefine \chapentry et + % al. a second time, below. + \def\appentry{\numchapentry}% + \def\appsecentry{\numsecentry}% + \def\appsubsecentry{\numsubsecentry}% + \def\appsubsubsecentry{\numsubsubsecentry}% + \def\unnchapentry{\numchapentry}% + \def\unnsecentry{\numsecentry}% + \def\unnsubsecentry{\numsubsecentry}% + \def\unnsubsubsecentry{\numsubsubsecentry}% + \readdatafile{toc}% + % + % Read toc second time, this time actually producing the outlines. + % The `-' means take the \expnumber as the absolute number of + % subentries, which we calculated on our first read of the .toc above. + % + % We use the node names as the destinations. + \def\numchapentry##1##2##3##4{% + \dopdfoutline{##1}{count-\expnumber{chap##2}}{##3}{##4}}% + \def\numsecentry##1##2##3##4{% + \dopdfoutline{##1}{count-\expnumber{sec##2}}{##3}{##4}}% + \def\numsubsecentry##1##2##3##4{% + \dopdfoutline{##1}{count-\expnumber{subsec##2}}{##3}{##4}}% + \def\numsubsubsecentry##1##2##3##4{% count is always zero + \dopdfoutline{##1}{}{##3}{##4}}% + % + % PDF outlines are displayed using system fonts, instead of + % document fonts. Therefore we cannot use special characters, + % since the encoding is unknown. For example, the eogonek from + % Latin 2 (0xea) gets translated to a | character. Info from + % Staszek Wawrykiewicz, 19 Jan 2004 04:09:24 +0100. + % + % xx to do this right, we have to translate 8-bit characters to + % their "best" equivalent, based on the @documentencoding. Right + % now, I guess we'll just let the pdf reader have its way. + \indexnofonts + \setupdatafile + \catcode`\\=\active \otherbackslash + \input \tocreadfilename + \endgroup + } + % + \def\skipspaces#1{\def\PP{#1}\def\D{|}% + \ifx\PP\D\let\nextsp\relax + \else\let\nextsp\skipspaces + \ifx\p\space\else\addtokens{\filename}{\PP}% + \advance\filenamelength by 1 + \fi + \fi + \nextsp} + \def\getfilename#1{\filenamelength=0\expandafter\skipspaces#1|\relax} + \ifnum\pdftexversion < 14 + \let \startlink \pdfannotlink + \else + \let \startlink \pdfstartlink + \fi + % make a live url in pdf output. + \def\pdfurl#1{% + \begingroup + % it seems we really need yet another set of dummies; have not + % tried to figure out what each command should do in the context + % of @url. for now, just make @/ a no-op, that's the only one + % people have actually reported a problem with. + % + \normalturnoffactive + \def\@{@}% + \let\/=\empty + \makevalueexpandable + % do we want to go so far as to use \indexnofonts instead of just + % special-casing \var here? + \def\var##1{##1}% + % + \leavevmode\setcolor{\urlcolor}% + \startlink attr{/Border [0 0 0]}% + user{/Subtype /Link /A << /S /URI /URI (#1) >>}% + \endgroup} + \def\pdfgettoks#1.{\setbox\boxA=\hbox{\toksA={#1.}\toksB={}\maketoks}} + \def\addtokens#1#2{\edef\addtoks{\noexpand#1={\the#1#2}}\addtoks} + \def\adn#1{\addtokens{\toksC}{#1}\global\countA=1\let\next=\maketoks} + \def\poptoks#1#2|ENDTOKS|{\let\first=#1\toksD={#1}\toksA={#2}} + \def\maketoks{% + \expandafter\poptoks\the\toksA|ENDTOKS|\relax + \ifx\first0\adn0 + \else\ifx\first1\adn1 \else\ifx\first2\adn2 \else\ifx\first3\adn3 + \else\ifx\first4\adn4 \else\ifx\first5\adn5 \else\ifx\first6\adn6 + \else\ifx\first7\adn7 \else\ifx\first8\adn8 \else\ifx\first9\adn9 + \else + \ifnum0=\countA\else\makelink\fi + \ifx\first.\let\next=\done\else + \let\next=\maketoks + \addtokens{\toksB}{\the\toksD} + \ifx\first,\addtokens{\toksB}{\space}\fi + \fi + \fi\fi\fi\fi\fi\fi\fi\fi\fi\fi + \next} + \def\makelink{\addtokens{\toksB}% + {\noexpand\pdflink{\the\toksC}}\toksC={}\global\countA=0} + \def\pdflink#1{% + \startlink attr{/Border [0 0 0]} goto name{\pdfmkpgn{#1}} + \setcolor{\linkcolor}#1\endlink} + \def\done{\edef\st{\global\noexpand\toksA={\the\toksB}}\st} +\else + % non-pdf mode + \let\pdfmkdest = \gobble + \let\pdfurl = \gobble + \let\endlink = \relax + \let\setcolor = \gobble + \let\pdfsetcolor = \gobble + \let\pdfmakeoutlines = \relax +\fi % \ifx\pdfoutput + + +\message{fonts,} + +% Change the current font style to #1, remembering it in \curfontstyle. +% For now, we do not accumulate font styles: @b{@i{foo}} prints foo in +% italics, not bold italics. +% +\def\setfontstyle#1{% + \def\curfontstyle{#1}% not as a control sequence, because we are \edef'd. + \csname ten#1\endcsname % change the current font +} + +% Select #1 fonts with the current style. +% +\def\selectfonts#1{\csname #1fonts\endcsname \csname\curfontstyle\endcsname} + +\def\rm{\fam=0 \setfontstyle{rm}} +\def\it{\fam=\itfam \setfontstyle{it}} +\def\sl{\fam=\slfam \setfontstyle{sl}} +\def\bf{\fam=\bffam \setfontstyle{bf}}\def\bfstylename{bf} +\def\tt{\fam=\ttfam \setfontstyle{tt}} + +% Unfortunately, we have to override this for titles and the like, since +% in those cases "rm" is bold. Sigh. +\def\rmisbold{\rm\def\curfontstyle{bf}} + +% Texinfo sort of supports the sans serif font style, which plain TeX does not. +% So we set up a \sf. +\newfam\sffam +\def\sf{\fam=\sffam \setfontstyle{sf}} +\let\li = \sf % Sometimes we call it \li, not \sf. + +% We don't need math for this font style. +\def\ttsl{\setfontstyle{ttsl}} + + +% Default leading. +\newdimen\textleading \textleading = 13.2pt + +% Set the baselineskip to #1, and the lineskip and strut size +% correspondingly. There is no deep meaning behind these magic numbers +% used as factors; they just match (closely enough) what Knuth defined. +% +\def\lineskipfactor{.08333} +\def\strutheightpercent{.70833} +\def\strutdepthpercent {.29167} +% +% can get a sort of poor man's double spacing by redefining this. +\def\baselinefactor{1} +% +\def\setleading#1{% + \dimen0 = #1\relax + \normalbaselineskip = \baselinefactor\dimen0 + \normallineskip = \lineskipfactor\normalbaselineskip + \normalbaselines + \setbox\strutbox =\hbox{% + \vrule width0pt height\strutheightpercent\baselineskip + depth \strutdepthpercent \baselineskip + }% +} + +% PDF CMaps. See also LaTeX's t1.cmap. +% +% do nothing with this by default. +\expandafter\let\csname cmapOT1\endcsname\gobble +\expandafter\let\csname cmapOT1IT\endcsname\gobble +\expandafter\let\csname cmapOT1TT\endcsname\gobble + +% if we are producing pdf, and we have \pdffontattr, then define cmaps. +% (\pdffontattr was introduced many years ago, but people still run +% older pdftex's; it's easy to conditionalize, so we do.) +\ifpdf \ifx\pdffontattr\undefined \else + \begingroup + \catcode`\^^M=\active \def^^M{^^J}% Output line endings as the ^^J char. + \catcode`\%=12 \immediate\pdfobj stream {%!PS-Adobe-3.0 Resource-CMap +%%DocumentNeededResources: ProcSet (CIDInit) +%%IncludeResource: ProcSet (CIDInit) +%%BeginResource: CMap (TeX-OT1-0) +%%Title: (TeX-OT1-0 TeX OT1 0) +%%Version: 1.000 +%%EndComments +/CIDInit /ProcSet findresource begin +12 dict begin +begincmap +/CIDSystemInfo +<< /Registry (TeX) +/Ordering (OT1) +/Supplement 0 +>> def +/CMapName /TeX-OT1-0 def +/CMapType 2 def +1 begincodespacerange +<00> <7F> +endcodespacerange +8 beginbfrange +<00> <01> <0393> +<09> <0A> <03A8> +<23> <26> <0023> +<28> <3B> <0028> +<3F> <5B> <003F> +<5D> <5E> <005D> +<61> <7A> <0061> +<7B> <7C> <2013> +endbfrange +40 beginbfchar +<02> <0398> +<03> <039B> +<04> <039E> +<05> <03A0> +<06> <03A3> +<07> <03D2> +<08> <03A6> +<0B> <00660066> +<0C> <00660069> +<0D> <0066006C> +<0E> <006600660069> +<0F> <00660066006C> +<10> <0131> +<11> <0237> +<12> <0060> +<13> <00B4> +<14> <02C7> +<15> <02D8> +<16> <00AF> +<17> <02DA> +<18> <00B8> +<19> <00DF> +<1A> <00E6> +<1B> <0153> +<1C> <00F8> +<1D> <00C6> +<1E> <0152> +<1F> <00D8> +<21> <0021> +<22> <201D> +<27> <2019> +<3C> <00A1> +<3D> <003D> +<3E> <00BF> +<5C> <201C> +<5F> <02D9> +<60> <2018> +<7D> <02DD> +<7E> <007E> +<7F> <00A8> +endbfchar +endcmap +CMapName currentdict /CMap defineresource pop +end +end +%%EndResource +%%EOF + }\endgroup + \expandafter\edef\csname cmapOT1\endcsname#1{% + \pdffontattr#1{/ToUnicode \the\pdflastobj\space 0 R}% + }% +% +% \cmapOT1IT + \begingroup + \catcode`\^^M=\active \def^^M{^^J}% Output line endings as the ^^J char. + \catcode`\%=12 \immediate\pdfobj stream {%!PS-Adobe-3.0 Resource-CMap +%%DocumentNeededResources: ProcSet (CIDInit) +%%IncludeResource: ProcSet (CIDInit) +%%BeginResource: CMap (TeX-OT1IT-0) +%%Title: (TeX-OT1IT-0 TeX OT1IT 0) +%%Version: 1.000 +%%EndComments +/CIDInit /ProcSet findresource begin +12 dict begin +begincmap +/CIDSystemInfo +<< /Registry (TeX) +/Ordering (OT1IT) +/Supplement 0 +>> def +/CMapName /TeX-OT1IT-0 def +/CMapType 2 def +1 begincodespacerange +<00> <7F> +endcodespacerange +8 beginbfrange +<00> <01> <0393> +<09> <0A> <03A8> +<25> <26> <0025> +<28> <3B> <0028> +<3F> <5B> <003F> +<5D> <5E> <005D> +<61> <7A> <0061> +<7B> <7C> <2013> +endbfrange +42 beginbfchar +<02> <0398> +<03> <039B> +<04> <039E> +<05> <03A0> +<06> <03A3> +<07> <03D2> +<08> <03A6> +<0B> <00660066> +<0C> <00660069> +<0D> <0066006C> +<0E> <006600660069> +<0F> <00660066006C> +<10> <0131> +<11> <0237> +<12> <0060> +<13> <00B4> +<14> <02C7> +<15> <02D8> +<16> <00AF> +<17> <02DA> +<18> <00B8> +<19> <00DF> +<1A> <00E6> +<1B> <0153> +<1C> <00F8> +<1D> <00C6> +<1E> <0152> +<1F> <00D8> +<21> <0021> +<22> <201D> +<23> <0023> +<24> <00A3> +<27> <2019> +<3C> <00A1> +<3D> <003D> +<3E> <00BF> +<5C> <201C> +<5F> <02D9> +<60> <2018> +<7D> <02DD> +<7E> <007E> +<7F> <00A8> +endbfchar +endcmap +CMapName currentdict /CMap defineresource pop +end +end +%%EndResource +%%EOF + }\endgroup + \expandafter\edef\csname cmapOT1IT\endcsname#1{% + \pdffontattr#1{/ToUnicode \the\pdflastobj\space 0 R}% + }% +% +% \cmapOT1TT + \begingroup + \catcode`\^^M=\active \def^^M{^^J}% Output line endings as the ^^J char. + \catcode`\%=12 \immediate\pdfobj stream {%!PS-Adobe-3.0 Resource-CMap +%%DocumentNeededResources: ProcSet (CIDInit) +%%IncludeResource: ProcSet (CIDInit) +%%BeginResource: CMap (TeX-OT1TT-0) +%%Title: (TeX-OT1TT-0 TeX OT1TT 0) +%%Version: 1.000 +%%EndComments +/CIDInit /ProcSet findresource begin +12 dict begin +begincmap +/CIDSystemInfo +<< /Registry (TeX) +/Ordering (OT1TT) +/Supplement 0 +>> def +/CMapName /TeX-OT1TT-0 def +/CMapType 2 def +1 begincodespacerange +<00> <7F> +endcodespacerange +5 beginbfrange +<00> <01> <0393> +<09> <0A> <03A8> +<21> <26> <0021> +<28> <5F> <0028> +<61> <7E> <0061> +endbfrange +32 beginbfchar +<02> <0398> +<03> <039B> +<04> <039E> +<05> <03A0> +<06> <03A3> +<07> <03D2> +<08> <03A6> +<0B> <2191> +<0C> <2193> +<0D> <0027> +<0E> <00A1> +<0F> <00BF> +<10> <0131> +<11> <0237> +<12> <0060> +<13> <00B4> +<14> <02C7> +<15> <02D8> +<16> <00AF> +<17> <02DA> +<18> <00B8> +<19> <00DF> +<1A> <00E6> +<1B> <0153> +<1C> <00F8> +<1D> <00C6> +<1E> <0152> +<1F> <00D8> +<20> <2423> +<27> <2019> +<60> <2018> +<7F> <00A8> +endbfchar +endcmap +CMapName currentdict /CMap defineresource pop +end +end +%%EndResource +%%EOF + }\endgroup + \expandafter\edef\csname cmapOT1TT\endcsname#1{% + \pdffontattr#1{/ToUnicode \the\pdflastobj\space 0 R}% + }% +\fi\fi + + +% Set the font macro #1 to the font named #2, adding on the +% specified font prefix (normally `cm'). +% #3 is the font's design size, #4 is a scale factor, #5 is the CMap +% encoding (currently only OT1, OT1IT and OT1TT are allowed, pass +% empty to omit). +\def\setfont#1#2#3#4#5{% + \font#1=\fontprefix#2#3 scaled #4 + \csname cmap#5\endcsname#1% +} +% This is what gets called when #5 of \setfont is empty. +\let\cmap\gobble +% emacs-page end of cmaps + +% Use cm as the default font prefix. +% To specify the font prefix, you must define \fontprefix +% before you read in texinfo.tex. +\ifx\fontprefix\undefined +\def\fontprefix{cm} +\fi +% Support font families that don't use the same naming scheme as CM. +\def\rmshape{r} +\def\rmbshape{bx} %where the normal face is bold +\def\bfshape{b} +\def\bxshape{bx} +\def\ttshape{tt} +\def\ttbshape{tt} +\def\ttslshape{sltt} +\def\itshape{ti} +\def\itbshape{bxti} +\def\slshape{sl} +\def\slbshape{bxsl} +\def\sfshape{ss} +\def\sfbshape{ss} +\def\scshape{csc} +\def\scbshape{csc} + +% Definitions for a main text size of 11pt. This is the default in +% Texinfo. +% +\def\definetextfontsizexi{% +% Text fonts (11.2pt, magstep1). +\def\textnominalsize{11pt} +\edef\mainmagstep{\magstephalf} +\setfont\textrm\rmshape{10}{\mainmagstep}{OT1} +\setfont\texttt\ttshape{10}{\mainmagstep}{OT1TT} +\setfont\textbf\bfshape{10}{\mainmagstep}{OT1} +\setfont\textit\itshape{10}{\mainmagstep}{OT1IT} +\setfont\textsl\slshape{10}{\mainmagstep}{OT1} +\setfont\textsf\sfshape{10}{\mainmagstep}{OT1} +\setfont\textsc\scshape{10}{\mainmagstep}{OT1} +\setfont\textttsl\ttslshape{10}{\mainmagstep}{OT1TT} +\font\texti=cmmi10 scaled \mainmagstep +\font\textsy=cmsy10 scaled \mainmagstep +\def\textecsize{1095} + +% A few fonts for @defun names and args. +\setfont\defbf\bfshape{10}{\magstep1}{OT1} +\setfont\deftt\ttshape{10}{\magstep1}{OT1TT} +\setfont\defttsl\ttslshape{10}{\magstep1}{OT1TT} +\def\df{\let\tentt=\deftt \let\tenbf = \defbf \let\tenttsl=\defttsl \bf} + +% Fonts for indices, footnotes, small examples (9pt). +\def\smallnominalsize{9pt} +\setfont\smallrm\rmshape{9}{1000}{OT1} +\setfont\smalltt\ttshape{9}{1000}{OT1TT} +\setfont\smallbf\bfshape{10}{900}{OT1} +\setfont\smallit\itshape{9}{1000}{OT1IT} +\setfont\smallsl\slshape{9}{1000}{OT1} +\setfont\smallsf\sfshape{9}{1000}{OT1} +\setfont\smallsc\scshape{10}{900}{OT1} +\setfont\smallttsl\ttslshape{10}{900}{OT1TT} +\font\smalli=cmmi9 +\font\smallsy=cmsy9 +\def\smallecsize{0900} + +% Fonts for small examples (8pt). +\def\smallernominalsize{8pt} +\setfont\smallerrm\rmshape{8}{1000}{OT1} +\setfont\smallertt\ttshape{8}{1000}{OT1TT} +\setfont\smallerbf\bfshape{10}{800}{OT1} +\setfont\smallerit\itshape{8}{1000}{OT1IT} +\setfont\smallersl\slshape{8}{1000}{OT1} +\setfont\smallersf\sfshape{8}{1000}{OT1} +\setfont\smallersc\scshape{10}{800}{OT1} +\setfont\smallerttsl\ttslshape{10}{800}{OT1TT} +\font\smalleri=cmmi8 +\font\smallersy=cmsy8 +\def\smallerecsize{0800} + +% Fonts for title page (20.4pt): +\def\titlenominalsize{20pt} +\setfont\titlerm\rmbshape{12}{\magstep3}{OT1} +\setfont\titleit\itbshape{10}{\magstep4}{OT1IT} +\setfont\titlesl\slbshape{10}{\magstep4}{OT1} +\setfont\titlett\ttbshape{12}{\magstep3}{OT1TT} +\setfont\titlettsl\ttslshape{10}{\magstep4}{OT1TT} +\setfont\titlesf\sfbshape{17}{\magstep1}{OT1} +\let\titlebf=\titlerm +\setfont\titlesc\scbshape{10}{\magstep4}{OT1} +\font\titlei=cmmi12 scaled \magstep3 +\font\titlesy=cmsy10 scaled \magstep4 +\def\titleecsize{2074} + +% Chapter (and unnumbered) fonts (17.28pt). +\def\chapnominalsize{17pt} +\setfont\chaprm\rmbshape{12}{\magstep2}{OT1} +\setfont\chapit\itbshape{10}{\magstep3}{OT1IT} +\setfont\chapsl\slbshape{10}{\magstep3}{OT1} +\setfont\chaptt\ttbshape{12}{\magstep2}{OT1TT} +\setfont\chapttsl\ttslshape{10}{\magstep3}{OT1TT} +\setfont\chapsf\sfbshape{17}{1000}{OT1} +\let\chapbf=\chaprm +\setfont\chapsc\scbshape{10}{\magstep3}{OT1} +\font\chapi=cmmi12 scaled \magstep2 +\font\chapsy=cmsy10 scaled \magstep3 +\def\chapecsize{1728} + +% Section fonts (14.4pt). +\def\secnominalsize{14pt} +\setfont\secrm\rmbshape{12}{\magstep1}{OT1} +\setfont\secit\itbshape{10}{\magstep2}{OT1IT} +\setfont\secsl\slbshape{10}{\magstep2}{OT1} +\setfont\sectt\ttbshape{12}{\magstep1}{OT1TT} +\setfont\secttsl\ttslshape{10}{\magstep2}{OT1TT} +\setfont\secsf\sfbshape{12}{\magstep1}{OT1} +\let\secbf\secrm +\setfont\secsc\scbshape{10}{\magstep2}{OT1} +\font\seci=cmmi12 scaled \magstep1 +\font\secsy=cmsy10 scaled \magstep2 +\def\sececsize{1440} + +% Subsection fonts (13.15pt). +\def\ssecnominalsize{13pt} +\setfont\ssecrm\rmbshape{12}{\magstephalf}{OT1} +\setfont\ssecit\itbshape{10}{1315}{OT1IT} +\setfont\ssecsl\slbshape{10}{1315}{OT1} +\setfont\ssectt\ttbshape{12}{\magstephalf}{OT1TT} +\setfont\ssecttsl\ttslshape{10}{1315}{OT1TT} +\setfont\ssecsf\sfbshape{12}{\magstephalf}{OT1} +\let\ssecbf\ssecrm +\setfont\ssecsc\scbshape{10}{1315}{OT1} +\font\sseci=cmmi12 scaled \magstephalf +\font\ssecsy=cmsy10 scaled 1315 +\def\ssececsize{1200} + +% Reduced fonts for @acro in text (10pt). +\def\reducednominalsize{10pt} +\setfont\reducedrm\rmshape{10}{1000}{OT1} +\setfont\reducedtt\ttshape{10}{1000}{OT1TT} +\setfont\reducedbf\bfshape{10}{1000}{OT1} +\setfont\reducedit\itshape{10}{1000}{OT1IT} +\setfont\reducedsl\slshape{10}{1000}{OT1} +\setfont\reducedsf\sfshape{10}{1000}{OT1} +\setfont\reducedsc\scshape{10}{1000}{OT1} +\setfont\reducedttsl\ttslshape{10}{1000}{OT1TT} +\font\reducedi=cmmi10 +\font\reducedsy=cmsy10 +\def\reducedecsize{1000} + +% reset the current fonts +\textfonts +\rm +} % end of 11pt text font size definitions + + +% Definitions to make the main text be 10pt Computer Modern, with +% section, chapter, etc., sizes following suit. This is for the GNU +% Press printing of the Emacs 22 manual. Maybe other manuals in the +% future. Used with @smallbook, which sets the leading to 12pt. +% +\def\definetextfontsizex{% +% Text fonts (10pt). +\def\textnominalsize{10pt} +\edef\mainmagstep{1000} +\setfont\textrm\rmshape{10}{\mainmagstep}{OT1} +\setfont\texttt\ttshape{10}{\mainmagstep}{OT1TT} +\setfont\textbf\bfshape{10}{\mainmagstep}{OT1} +\setfont\textit\itshape{10}{\mainmagstep}{OT1IT} +\setfont\textsl\slshape{10}{\mainmagstep}{OT1} +\setfont\textsf\sfshape{10}{\mainmagstep}{OT1} +\setfont\textsc\scshape{10}{\mainmagstep}{OT1} +\setfont\textttsl\ttslshape{10}{\mainmagstep}{OT1TT} +\font\texti=cmmi10 scaled \mainmagstep +\font\textsy=cmsy10 scaled \mainmagstep +\def\textecsize{1000} + +% A few fonts for @defun names and args. +\setfont\defbf\bfshape{10}{\magstephalf}{OT1} +\setfont\deftt\ttshape{10}{\magstephalf}{OT1TT} +\setfont\defttsl\ttslshape{10}{\magstephalf}{OT1TT} +\def\df{\let\tentt=\deftt \let\tenbf = \defbf \let\tenttsl=\defttsl \bf} + +% Fonts for indices, footnotes, small examples (9pt). +\def\smallnominalsize{9pt} +\setfont\smallrm\rmshape{9}{1000}{OT1} +\setfont\smalltt\ttshape{9}{1000}{OT1TT} +\setfont\smallbf\bfshape{10}{900}{OT1} +\setfont\smallit\itshape{9}{1000}{OT1IT} +\setfont\smallsl\slshape{9}{1000}{OT1} +\setfont\smallsf\sfshape{9}{1000}{OT1} +\setfont\smallsc\scshape{10}{900}{OT1} +\setfont\smallttsl\ttslshape{10}{900}{OT1TT} +\font\smalli=cmmi9 +\font\smallsy=cmsy9 +\def\smallecsize{0900} + +% Fonts for small examples (8pt). +\def\smallernominalsize{8pt} +\setfont\smallerrm\rmshape{8}{1000}{OT1} +\setfont\smallertt\ttshape{8}{1000}{OT1TT} +\setfont\smallerbf\bfshape{10}{800}{OT1} +\setfont\smallerit\itshape{8}{1000}{OT1IT} +\setfont\smallersl\slshape{8}{1000}{OT1} +\setfont\smallersf\sfshape{8}{1000}{OT1} +\setfont\smallersc\scshape{10}{800}{OT1} +\setfont\smallerttsl\ttslshape{10}{800}{OT1TT} +\font\smalleri=cmmi8 +\font\smallersy=cmsy8 +\def\smallerecsize{0800} + +% Fonts for title page (20.4pt): +\def\titlenominalsize{20pt} +\setfont\titlerm\rmbshape{12}{\magstep3}{OT1} +\setfont\titleit\itbshape{10}{\magstep4}{OT1IT} +\setfont\titlesl\slbshape{10}{\magstep4}{OT1} +\setfont\titlett\ttbshape{12}{\magstep3}{OT1TT} +\setfont\titlettsl\ttslshape{10}{\magstep4}{OT1TT} +\setfont\titlesf\sfbshape{17}{\magstep1}{OT1} +\let\titlebf=\titlerm +\setfont\titlesc\scbshape{10}{\magstep4}{OT1} +\font\titlei=cmmi12 scaled \magstep3 +\font\titlesy=cmsy10 scaled \magstep4 +\def\titleecsize{2074} + +% Chapter fonts (14.4pt). +\def\chapnominalsize{14pt} +\setfont\chaprm\rmbshape{12}{\magstep1}{OT1} +\setfont\chapit\itbshape{10}{\magstep2}{OT1IT} +\setfont\chapsl\slbshape{10}{\magstep2}{OT1} +\setfont\chaptt\ttbshape{12}{\magstep1}{OT1TT} +\setfont\chapttsl\ttslshape{10}{\magstep2}{OT1TT} +\setfont\chapsf\sfbshape{12}{\magstep1}{OT1} +\let\chapbf\chaprm +\setfont\chapsc\scbshape{10}{\magstep2}{OT1} +\font\chapi=cmmi12 scaled \magstep1 +\font\chapsy=cmsy10 scaled \magstep2 +\def\chapecsize{1440} + +% Section fonts (12pt). +\def\secnominalsize{12pt} +\setfont\secrm\rmbshape{12}{1000}{OT1} +\setfont\secit\itbshape{10}{\magstep1}{OT1IT} +\setfont\secsl\slbshape{10}{\magstep1}{OT1} +\setfont\sectt\ttbshape{12}{1000}{OT1TT} +\setfont\secttsl\ttslshape{10}{\magstep1}{OT1TT} +\setfont\secsf\sfbshape{12}{1000}{OT1} +\let\secbf\secrm +\setfont\secsc\scbshape{10}{\magstep1}{OT1} +\font\seci=cmmi12 +\font\secsy=cmsy10 scaled \magstep1 +\def\sececsize{1200} + +% Subsection fonts (10pt). +\def\ssecnominalsize{10pt} +\setfont\ssecrm\rmbshape{10}{1000}{OT1} +\setfont\ssecit\itbshape{10}{1000}{OT1IT} +\setfont\ssecsl\slbshape{10}{1000}{OT1} +\setfont\ssectt\ttbshape{10}{1000}{OT1TT} +\setfont\ssecttsl\ttslshape{10}{1000}{OT1TT} +\setfont\ssecsf\sfbshape{10}{1000}{OT1} +\let\ssecbf\ssecrm +\setfont\ssecsc\scbshape{10}{1000}{OT1} +\font\sseci=cmmi10 +\font\ssecsy=cmsy10 +\def\ssececsize{1000} + +% Reduced fonts for @acro in text (9pt). +\def\reducednominalsize{9pt} +\setfont\reducedrm\rmshape{9}{1000}{OT1} +\setfont\reducedtt\ttshape{9}{1000}{OT1TT} +\setfont\reducedbf\bfshape{10}{900}{OT1} +\setfont\reducedit\itshape{9}{1000}{OT1IT} +\setfont\reducedsl\slshape{9}{1000}{OT1} +\setfont\reducedsf\sfshape{9}{1000}{OT1} +\setfont\reducedsc\scshape{10}{900}{OT1} +\setfont\reducedttsl\ttslshape{10}{900}{OT1TT} +\font\reducedi=cmmi9 +\font\reducedsy=cmsy9 +\def\reducedecsize{0900} + +% reduce space between paragraphs +\divide\parskip by 2 + +% reset the current fonts +\textfonts +\rm +} % end of 10pt text font size definitions + + +% We provide the user-level command +% @fonttextsize 10 +% (or 11) to redefine the text font size. pt is assumed. +% +\def\xword{10} +\def\xiword{11} +% +\parseargdef\fonttextsize{% + \def\textsizearg{#1}% + \wlog{doing @fonttextsize \textsizearg}% + % + % Set \globaldefs so that documents can use this inside @tex, since + % makeinfo 4.8 does not support it, but we need it nonetheless. + % + \begingroup \globaldefs=1 + \ifx\textsizearg\xword \definetextfontsizex + \else \ifx\textsizearg\xiword \definetextfontsizexi + \else + \errhelp=\EMsimple + \errmessage{@fonttextsize only supports `10' or `11', not `\textsizearg'} + \fi\fi + \endgroup +} + + +% In order for the font changes to affect most math symbols and letters, +% we have to define the \textfont of the standard families. Since +% texinfo doesn't allow for producing subscripts and superscripts except +% in the main text, we don't bother to reset \scriptfont and +% \scriptscriptfont (which would also require loading a lot more fonts). +% +\def\resetmathfonts{% + \textfont0=\tenrm \textfont1=\teni \textfont2=\tensy + \textfont\itfam=\tenit \textfont\slfam=\tensl \textfont\bffam=\tenbf + \textfont\ttfam=\tentt \textfont\sffam=\tensf +} + +% The font-changing commands redefine the meanings of \tenSTYLE, instead +% of just \STYLE. We do this because \STYLE needs to also set the +% current \fam for math mode. Our \STYLE (e.g., \rm) commands hardwire +% \tenSTYLE to set the current font. +% +% Each font-changing command also sets the names \lsize (one size lower) +% and \lllsize (three sizes lower). These relative commands are used in +% the LaTeX logo and acronyms. +% +% This all needs generalizing, badly. +% +\def\textfonts{% + \let\tenrm=\textrm \let\tenit=\textit \let\tensl=\textsl + \let\tenbf=\textbf \let\tentt=\texttt \let\smallcaps=\textsc + \let\tensf=\textsf \let\teni=\texti \let\tensy=\textsy + \let\tenttsl=\textttsl + \def\curfontsize{text}% + \def\lsize{reduced}\def\lllsize{smaller}% + \resetmathfonts \setleading{\textleading}} +\def\titlefonts{% + \let\tenrm=\titlerm \let\tenit=\titleit \let\tensl=\titlesl + \let\tenbf=\titlebf \let\tentt=\titlett \let\smallcaps=\titlesc + \let\tensf=\titlesf \let\teni=\titlei \let\tensy=\titlesy + \let\tenttsl=\titlettsl + \def\curfontsize{title}% + \def\lsize{chap}\def\lllsize{subsec}% + \resetmathfonts \setleading{25pt}} +\def\titlefont#1{{\titlefonts\rmisbold #1}} +\def\chapfonts{% + \let\tenrm=\chaprm \let\tenit=\chapit \let\tensl=\chapsl + \let\tenbf=\chapbf \let\tentt=\chaptt \let\smallcaps=\chapsc + \let\tensf=\chapsf \let\teni=\chapi \let\tensy=\chapsy + \let\tenttsl=\chapttsl + \def\curfontsize{chap}% + \def\lsize{sec}\def\lllsize{text}% + \resetmathfonts \setleading{19pt}} +\def\secfonts{% + \let\tenrm=\secrm \let\tenit=\secit \let\tensl=\secsl + \let\tenbf=\secbf \let\tentt=\sectt \let\smallcaps=\secsc + \let\tensf=\secsf \let\teni=\seci \let\tensy=\secsy + \let\tenttsl=\secttsl + \def\curfontsize{sec}% + \def\lsize{subsec}\def\lllsize{reduced}% + \resetmathfonts \setleading{16pt}} +\def\subsecfonts{% + \let\tenrm=\ssecrm \let\tenit=\ssecit \let\tensl=\ssecsl + \let\tenbf=\ssecbf \let\tentt=\ssectt \let\smallcaps=\ssecsc + \let\tensf=\ssecsf \let\teni=\sseci \let\tensy=\ssecsy + \let\tenttsl=\ssecttsl + \def\curfontsize{ssec}% + \def\lsize{text}\def\lllsize{small}% + \resetmathfonts \setleading{15pt}} +\let\subsubsecfonts = \subsecfonts +\def\reducedfonts{% + \let\tenrm=\reducedrm \let\tenit=\reducedit \let\tensl=\reducedsl + \let\tenbf=\reducedbf \let\tentt=\reducedtt \let\reducedcaps=\reducedsc + \let\tensf=\reducedsf \let\teni=\reducedi \let\tensy=\reducedsy + \let\tenttsl=\reducedttsl + \def\curfontsize{reduced}% + \def\lsize{small}\def\lllsize{smaller}% + \resetmathfonts \setleading{10.5pt}} +\def\smallfonts{% + \let\tenrm=\smallrm \let\tenit=\smallit \let\tensl=\smallsl + \let\tenbf=\smallbf \let\tentt=\smalltt \let\smallcaps=\smallsc + \let\tensf=\smallsf \let\teni=\smalli \let\tensy=\smallsy + \let\tenttsl=\smallttsl + \def\curfontsize{small}% + \def\lsize{smaller}\def\lllsize{smaller}% + \resetmathfonts \setleading{10.5pt}} +\def\smallerfonts{% + \let\tenrm=\smallerrm \let\tenit=\smallerit \let\tensl=\smallersl + \let\tenbf=\smallerbf \let\tentt=\smallertt \let\smallcaps=\smallersc + \let\tensf=\smallersf \let\teni=\smalleri \let\tensy=\smallersy + \let\tenttsl=\smallerttsl + \def\curfontsize{smaller}% + \def\lsize{smaller}\def\lllsize{smaller}% + \resetmathfonts \setleading{9.5pt}} + +% Fonts for short table of contents. +\setfont\shortcontrm\rmshape{12}{1000}{OT1} +\setfont\shortcontbf\bfshape{10}{\magstep1}{OT1} % no cmb12 +\setfont\shortcontsl\slshape{12}{1000}{OT1} +\setfont\shortconttt\ttshape{12}{1000}{OT1TT} + +% Define these just so they can be easily changed for other fonts. +\def\angleleft{$\langle$} +\def\angleright{$\rangle$} + +% Set the fonts to use with the @small... environments. +\let\smallexamplefonts = \smallfonts + +% About \smallexamplefonts. If we use \smallfonts (9pt), @smallexample +% can fit this many characters: +% 8.5x11=86 smallbook=72 a4=90 a5=69 +% If we use \scriptfonts (8pt), then we can fit this many characters: +% 8.5x11=90+ smallbook=80 a4=90+ a5=77 +% For me, subjectively, the few extra characters that fit aren't worth +% the additional smallness of 8pt. So I'm making the default 9pt. +% +% By the way, for comparison, here's what fits with @example (10pt): +% 8.5x11=71 smallbook=60 a4=75 a5=58 +% --karl, 24jan03. + +% Set up the default fonts, so we can use them for creating boxes. +% +\definetextfontsizexi + + +\message{markup,} + +% Check if we are currently using a typewriter font. Since all the +% Computer Modern typewriter fonts have zero interword stretch (and +% shrink), and it is reasonable to expect all typewriter fonts to have +% this property, we can check that font parameter. +% +\def\ifmonospace{\ifdim\fontdimen3\font=0pt } + +% Markup style infrastructure. \defmarkupstylesetup\INITMACRO will +% define and register \INITMACRO to be called on markup style changes. +% \INITMACRO can check \currentmarkupstyle for the innermost +% style and the set of \ifmarkupSTYLE switches for all styles +% currently in effect. +\newif\ifmarkupvar +\newif\ifmarkupsamp +\newif\ifmarkupkey +%\newif\ifmarkupfile % @file == @samp. +%\newif\ifmarkupoption % @option == @samp. +\newif\ifmarkupcode +\newif\ifmarkupkbd +%\newif\ifmarkupenv % @env == @code. +%\newif\ifmarkupcommand % @command == @code. +\newif\ifmarkuptex % @tex (and part of @math, for now). +\newif\ifmarkupexample +\newif\ifmarkupverb +\newif\ifmarkupverbatim + +\let\currentmarkupstyle\empty + +\def\setupmarkupstyle#1{% + \csname markup#1true\endcsname + \def\currentmarkupstyle{#1}% + \markupstylesetup +} + +\let\markupstylesetup\empty + +\def\defmarkupstylesetup#1{% + \expandafter\def\expandafter\markupstylesetup + \expandafter{\markupstylesetup #1}% + \def#1% +} + +% Markup style setup for left and right quotes. +\defmarkupstylesetup\markupsetuplq{% + \expandafter\let\expandafter \temp \csname markupsetuplq\currentmarkupstyle\endcsname + \ifx\temp\relax \markupsetuplqdefault \else \temp \fi +} + +\defmarkupstylesetup\markupsetuprq{% + \expandafter\let\expandafter \temp \csname markupsetuprq\currentmarkupstyle\endcsname + \ifx\temp\relax \markupsetuprqdefault \else \temp \fi +} + +{ +\catcode`\'=\active +\catcode`\`=\active + +\gdef\markupsetuplqdefault{\let`\lq} +\gdef\markupsetuprqdefault{\let'\rq} + +\gdef\markupsetcodequoteleft{\let`\codequoteleft} +\gdef\markupsetcodequoteright{\let'\codequoteright} + +\gdef\markupsetnoligaturesquoteleft{\let`\noligaturesquoteleft} +} + +\let\markupsetuplqcode \markupsetcodequoteleft +\let\markupsetuprqcode \markupsetcodequoteright +\let\markupsetuplqexample \markupsetcodequoteleft +\let\markupsetuprqexample \markupsetcodequoteright +\let\markupsetuplqverb \markupsetcodequoteleft +\let\markupsetuprqverb \markupsetcodequoteright +\let\markupsetuplqverbatim \markupsetcodequoteleft +\let\markupsetuprqverbatim \markupsetcodequoteright + +\let\markupsetuplqsamp \markupsetnoligaturesquoteleft +\let\markupsetuplqkbd \markupsetnoligaturesquoteleft + +% Allow an option to not replace quotes with a regular directed right +% quote/apostrophe (char 0x27), but instead use the undirected quote +% from cmtt (char 0x0d). The undirected quote is ugly, so don't make it +% the default, but it works for pasting with more pdf viewers (at least +% evince), the lilypond developers report. xpdf does work with the +% regular 0x27. +% +\def\codequoteright{% + \expandafter\ifx\csname SETtxicodequoteundirected\endcsname\relax + \expandafter\ifx\csname SETcodequoteundirected\endcsname\relax + '% + \else \char'15 \fi + \else \char'15 \fi +} +% +% and a similar option for the left quote char vs. a grave accent. +% Modern fonts display ASCII 0x60 as a grave accent, so some people like +% the code environments to do likewise. +% +\def\codequoteleft{% + \expandafter\ifx\csname SETtxicodequotebacktick\endcsname\relax + \expandafter\ifx\csname SETcodequotebacktick\endcsname\relax + % [Knuth] pp. 380,381,391 + % \relax disables Spanish ligatures ?` and !` of \tt font. + \relax`% + \else \char'22 \fi + \else \char'22 \fi +} + +% [Knuth] pp. 380,381,391, disable Spanish ligatures ?` and !` of \tt font. +\def\noligaturesquoteleft{\relax\lq} + +% Count depth in font-changes, for error checks +\newcount\fontdepth \fontdepth=0 + +%% Add scribe-like font environments, plus @l for inline lisp (usually sans +%% serif) and @ii for TeX italic + +% \smartitalic{ARG} outputs arg in italics, followed by an italic correction +% unless the following character is such as not to need one. +\def\smartitalicx{\ifx\next,\else\ifx\next-\else\ifx\next.\else + \ptexslash\fi\fi\fi} +\def\smartslanted#1{{\ifusingtt\ttsl\sl #1}\futurelet\next\smartitalicx} +\def\smartitalic#1{{\ifusingtt\ttsl\it #1}\futurelet\next\smartitalicx} + +% like \smartslanted except unconditionally uses \ttsl. +% @var is set to this for defun arguments. +\def\ttslanted#1{{\ttsl #1}\futurelet\next\smartitalicx} + +% @cite is like \smartslanted except unconditionally use \sl. We never want +% ttsl for book titles, do we? +\def\cite#1{{\sl #1}\futurelet\next\smartitalicx} + +\let\i=\smartitalic +\let\slanted=\smartslanted +\def\var#1{{\setupmarkupstyle{var}\smartslanted{#1}}} +\let\dfn=\smartslanted +\let\emph=\smartitalic + +% Explicit font changes: @r, @sc, undocumented @ii. +\def\r#1{{\rm #1}} % roman font +\def\sc#1{{\smallcaps#1}} % smallcaps font +\def\ii#1{{\it #1}} % italic font + +% @b, explicit bold. Also @strong. +\def\b#1{{\bf #1}} +\let\strong=\b + +% @sansserif, explicit sans. +\def\sansserif#1{{\sf #1}} + +% We can't just use \exhyphenpenalty, because that only has effect at +% the end of a paragraph. Restore normal hyphenation at the end of the +% group within which \nohyphenation is presumably called. +% +\def\nohyphenation{\hyphenchar\font = -1 \aftergroup\restorehyphenation} +\def\restorehyphenation{\hyphenchar\font = `- } + +% Set sfcode to normal for the chars that usually have another value. +% Can't use plain's \frenchspacing because it uses the `\x notation, and +% sometimes \x has an active definition that messes things up. +% +\catcode`@=11 + \def\plainfrenchspacing{% + \sfcode\dotChar =\@m \sfcode\questChar=\@m \sfcode\exclamChar=\@m + \sfcode\colonChar=\@m \sfcode\semiChar =\@m \sfcode\commaChar =\@m + \def\endofsentencespacefactor{1000}% for @. and friends + } + \def\plainnonfrenchspacing{% + \sfcode`\.3000\sfcode`\?3000\sfcode`\!3000 + \sfcode`\:2000\sfcode`\;1500\sfcode`\,1250 + \def\endofsentencespacefactor{3000}% for @. and friends + } +\catcode`@=\other +\def\endofsentencespacefactor{3000}% default + +% @t, explicit typewriter. +\def\t#1{% + {\tt \rawbackslash \plainfrenchspacing #1}% + \null +} + +% @samp. +\def\samp#1{{\setupmarkupstyle{samp}\lq\tclose{#1}\rq\null}} + +% definition of @key that produces a lozenge. Doesn't adjust to text size. +%\setfont\keyrm\rmshape{8}{1000}{OT1} +%\font\keysy=cmsy9 +%\def\key#1{{\keyrm\textfont2=\keysy \leavevmode\hbox{% +% \raise0.4pt\hbox{\angleleft}\kern-.08em\vtop{% +% \vbox{\hrule\kern-0.4pt +% \hbox{\raise0.4pt\hbox{\vphantom{\angleleft}}#1}}% +% \kern-0.4pt\hrule}% +% \kern-.06em\raise0.4pt\hbox{\angleright}}}} + +% definition of @key with no lozenge. If the current font is already +% monospace, don't change it; that way, we respect @kbdinputstyle. But +% if it isn't monospace, then use \tt. +% +\def\key#1{{\setupmarkupstyle{key}% + \nohyphenation + \ifmonospace\else\tt\fi + #1}\null} + +% ctrl is no longer a Texinfo command. +\def\ctrl #1{{\tt \rawbackslash \hat}#1} + +% @file, @option are the same as @samp. +\let\file=\samp +\let\option=\samp + +% @code is a modification of @t, +% which makes spaces the same size as normal in the surrounding text. +\def\tclose#1{% + {% + % Change normal interword space to be same as for the current font. + \spaceskip = \fontdimen2\font + % + % Switch to typewriter. + \tt + % + % But `\ ' produces the large typewriter interword space. + \def\ {{\spaceskip = 0pt{} }}% + % + % Turn off hyphenation. + \nohyphenation + % + \rawbackslash + \plainfrenchspacing + #1% + }% + \null +} + +% We *must* turn on hyphenation at `-' and `_' in @code. +% Otherwise, it is too hard to avoid overfull hboxes +% in the Emacs manual, the Library manual, etc. + +% Unfortunately, TeX uses one parameter (\hyphenchar) to control +% both hyphenation at - and hyphenation within words. +% We must therefore turn them both off (\tclose does that) +% and arrange explicitly to hyphenate at a dash. +% -- rms. +{ + \catcode`\-=\active \catcode`\_=\active + \catcode`\'=\active \catcode`\`=\active + \global\let'=\rq \global\let`=\lq % default definitions + % + \global\def\code{\begingroup + \setupmarkupstyle{code}% + % The following should really be moved into \setupmarkupstyle handlers. + \catcode\dashChar=\active \catcode\underChar=\active + \ifallowcodebreaks + \let-\codedash + \let_\codeunder + \else + \let-\realdash + \let_\realunder + \fi + \codex + } +} + +\def\realdash{-} +\def\codedash{-\discretionary{}{}{}} +\def\codeunder{% + % this is all so @math{@code{var_name}+1} can work. In math mode, _ + % is "active" (mathcode"8000) and \normalunderscore (or \char95, etc.) + % will therefore expand the active definition of _, which is us + % (inside @code that is), therefore an endless loop. + \ifusingtt{\ifmmode + \mathchar"075F % class 0=ordinary, family 7=ttfam, pos 0x5F=_. + \else\normalunderscore \fi + \discretionary{}{}{}}% + {\_}% +} +\def\codex #1{\tclose{#1}\endgroup} + +% An additional complication: the above will allow breaks after, e.g., +% each of the four underscores in __typeof__. This is undesirable in +% some manuals, especially if they don't have long identifiers in +% general. @allowcodebreaks provides a way to control this. +% +\newif\ifallowcodebreaks \allowcodebreakstrue + +\def\keywordtrue{true} +\def\keywordfalse{false} + +\parseargdef\allowcodebreaks{% + \def\txiarg{#1}% + \ifx\txiarg\keywordtrue + \allowcodebreakstrue + \else\ifx\txiarg\keywordfalse + \allowcodebreaksfalse + \else + \errhelp = \EMsimple + \errmessage{Unknown @allowcodebreaks option `\txiarg'}% + \fi\fi +} + +% @kbd is like @code, except that if the argument is just one @key command, +% then @kbd has no effect. +\def\kbd#1{{\setupmarkupstyle{kbd}\def\look{#1}\expandafter\kbdfoo\look??\par}} + +% @kbdinputstyle -- arg is `distinct' (@kbd uses slanted tty font always), +% `example' (@kbd uses ttsl only inside of @example and friends), +% or `code' (@kbd uses normal tty font always). +\parseargdef\kbdinputstyle{% + \def\txiarg{#1}% + \ifx\txiarg\worddistinct + \gdef\kbdexamplefont{\ttsl}\gdef\kbdfont{\ttsl}% + \else\ifx\txiarg\wordexample + \gdef\kbdexamplefont{\ttsl}\gdef\kbdfont{\tt}% + \else\ifx\txiarg\wordcode + \gdef\kbdexamplefont{\tt}\gdef\kbdfont{\tt}% + \else + \errhelp = \EMsimple + \errmessage{Unknown @kbdinputstyle option `\txiarg'}% + \fi\fi\fi +} +\def\worddistinct{distinct} +\def\wordexample{example} +\def\wordcode{code} + +% Default is `distinct'. +\kbdinputstyle distinct + +\def\xkey{\key} +\def\kbdfoo#1#2#3\par{\def\one{#1}\def\three{#3}\def\threex{??}% +\ifx\one\xkey\ifx\threex\three \key{#2}% +\else{\tclose{\kbdfont\setupmarkupstyle{kbd}\look}}\fi +\else{\tclose{\kbdfont\setupmarkupstyle{kbd}\look}}\fi} + +% For @indicateurl, @env, @command quotes seem unnecessary, so use \code. +\let\indicateurl=\code +\let\env=\code +\let\command=\code + +% @clicksequence{File @click{} Open ...} +\def\clicksequence#1{\begingroup #1\endgroup} + +% @clickstyle @arrow (by default) +\parseargdef\clickstyle{\def\click{#1}} +\def\click{\arrow} + +% @uref (abbreviation for `urlref') takes an optional (comma-separated) +% second argument specifying the text to display and an optional third +% arg as text to display instead of (rather than in addition to) the url +% itself. First (mandatory) arg is the url. Perhaps eventually put in +% a hypertex \special here. +% +\def\uref#1{\douref #1,,,\finish} +\def\douref#1,#2,#3,#4\finish{\begingroup + \unsepspaces + \pdfurl{#1}% + \setbox0 = \hbox{\ignorespaces #3}% + \ifdim\wd0 > 0pt + \unhbox0 % third arg given, show only that + \else + \setbox0 = \hbox{\ignorespaces #2}% + \ifdim\wd0 > 0pt + \ifpdf + \unhbox0 % PDF: 2nd arg given, show only it + \else + \unhbox0\ (\code{#1})% DVI: 2nd arg given, show both it and url + \fi + \else + \code{#1}% only url given, so show it + \fi + \fi + \endlink +\endgroup} + +% @url synonym for @uref, since that's how everyone uses it. +% +\let\url=\uref + +% rms does not like angle brackets --karl, 17may97. +% So now @email is just like @uref, unless we are pdf. +% +%\def\email#1{\angleleft{\tt #1}\angleright} +\ifpdf + \def\email#1{\doemail#1,,\finish} + \def\doemail#1,#2,#3\finish{\begingroup + \unsepspaces + \pdfurl{mailto:#1}% + \setbox0 = \hbox{\ignorespaces #2}% + \ifdim\wd0>0pt\unhbox0\else\code{#1}\fi + \endlink + \endgroup} +\else + \let\email=\uref +\fi + +% Typeset a dimension, e.g., `in' or `pt'. The only reason for the +% argument is to make the input look right: @dmn{pt} instead of @dmn{}pt. +% +\def\dmn#1{\thinspace #1} + +% @l was never documented to mean ``switch to the Lisp font'', +% and it is not used as such in any manual I can find. We need it for +% Polish suppressed-l. --karl, 22sep96. +%\def\l#1{{\li #1}\null} + +% @acronym for "FBI", "NATO", and the like. +% We print this one point size smaller, since it's intended for +% all-uppercase. +% +\def\acronym#1{\doacronym #1,,\finish} +\def\doacronym#1,#2,#3\finish{% + {\selectfonts\lsize #1}% + \def\temp{#2}% + \ifx\temp\empty \else + \space ({\unsepspaces \ignorespaces \temp \unskip})% + \fi +} + +% @abbr for "Comput. J." and the like. +% No font change, but don't do end-of-sentence spacing. +% +\def\abbr#1{\doabbr #1,,\finish} +\def\doabbr#1,#2,#3\finish{% + {\plainfrenchspacing #1}% + \def\temp{#2}% + \ifx\temp\empty \else + \space ({\unsepspaces \ignorespaces \temp \unskip})% + \fi +} + + +\message{glyphs,} + +% @point{}, @result{}, @expansion{}, @print{}, @equiv{}. +% +% Since these characters are used in examples, they should be an even number of +% \tt widths. Each \tt character is 1en, so two makes it 1em. +% +\def\point{$\star$} +\def\arrow{\leavevmode\raise.05ex\hbox to 1em{\hfil$\rightarrow$\hfil}} +\def\result{\leavevmode\raise.05ex\hbox to 1em{\hfil$\Rightarrow$\hfil}} +\def\expansion{\leavevmode\hbox to 1em{\hfil$\mapsto$\hfil}} +\def\print{\leavevmode\lower.1ex\hbox to 1em{\hfil$\dashv$\hfil}} +\def\equiv{\leavevmode\hbox to 1em{\hfil$\ptexequiv$\hfil}} + +% The @error{} command. +% Adapted from the TeXbook's \boxit. +% +\newbox\errorbox +% +{\tentt \global\dimen0 = 3em}% Width of the box. +\dimen2 = .55pt % Thickness of rules +% The text. (`r' is open on the right, `e' somewhat less so on the left.) +\setbox0 = \hbox{\kern-.75pt \reducedsf error\kern-1.5pt} +% +\setbox\errorbox=\hbox to \dimen0{\hfil + \hsize = \dimen0 \advance\hsize by -5.8pt % Space to left+right. + \advance\hsize by -2\dimen2 % Rules. + \vbox{% + \hrule height\dimen2 + \hbox{\vrule width\dimen2 \kern3pt % Space to left of text. + \vtop{\kern2.4pt \box0 \kern2.4pt}% Space above/below. + \kern3pt\vrule width\dimen2}% Space to right. + \hrule height\dimen2} + \hfil} +% +\def\error{\leavevmode\lower.7ex\copy\errorbox} + +% @pounds{} is a sterling sign, which Knuth put in the CM italic font. +% +\def\pounds{{\it\$}} + +% @euro{} comes from a separate font, depending on the current style. +% We use the free feym* fonts from the eurosym package by Henrik +% Theiling, which support regular, slanted, bold and bold slanted (and +% "outlined" (blackboard board, sort of) versions, which we don't need). +% It is available from http://www.ctan.org/tex-archive/fonts/eurosym. +% +% Although only regular is the truly official Euro symbol, we ignore +% that. The Euro is designed to be slightly taller than the regular +% font height. +% +% feymr - regular +% feymo - slanted +% feybr - bold +% feybo - bold slanted +% +% There is no good (free) typewriter version, to my knowledge. +% A feymr10 euro is ~7.3pt wide, while a normal cmtt10 char is ~5.25pt wide. +% Hmm. +% +% Also doesn't work in math. Do we need to do math with euro symbols? +% Hope not. +% +% +\def\euro{{\eurofont e}} +\def\eurofont{% + % We set the font at each command, rather than predefining it in + % \textfonts and the other font-switching commands, so that + % installations which never need the symbol don't have to have the + % font installed. + % + % There is only one designed size (nominal 10pt), so we always scale + % that to the current nominal size. + % + % By the way, simply using "at 1em" works for cmr10 and the like, but + % does not work for cmbx10 and other extended/shrunken fonts. + % + \def\eurosize{\csname\curfontsize nominalsize\endcsname}% + % + \ifx\curfontstyle\bfstylename + % bold: + \font\thiseurofont = \ifusingit{feybo10}{feybr10} at \eurosize + \else + % regular: + \font\thiseurofont = \ifusingit{feymo10}{feymr10} at \eurosize + \fi + \thiseurofont +} + +% Glyphs from the EC fonts. We don't use \let for the aliases, because +% sometimes we redefine the original macro, and the alias should reflect +% the redefinition. +% +% Use LaTeX names for the Icelandic letters. +\def\DH{{\ecfont \char"D0}} % Eth +\def\dh{{\ecfont \char"F0}} % eth +\def\TH{{\ecfont \char"DE}} % Thorn +\def\th{{\ecfont \char"FE}} % thorn +% +\def\guillemetleft{{\ecfont \char"13}} +\def\guillemotleft{\guillemetleft} +\def\guillemetright{{\ecfont \char"14}} +\def\guillemotright{\guillemetright} +\def\guilsinglleft{{\ecfont \char"0E}} +\def\guilsinglright{{\ecfont \char"0F}} +\def\quotedblbase{{\ecfont \char"12}} +\def\quotesinglbase{{\ecfont \char"0D}} +% +% This positioning is not perfect (see the ogonek LaTeX package), but +% we have the precomposed glyphs for the most common cases. We put the +% tests to use those glyphs in the single \ogonek macro so we have fewer +% dummy definitions to worry about for index entries, etc. +% +% ogonek is also used with other letters in Lithuanian (IOU), but using +% the precomposed glyphs for those is not so easy since they aren't in +% the same EC font. +\def\ogonek#1{{% + \def\temp{#1}% + \ifx\temp\macrocharA\Aogonek + \else\ifx\temp\macrochara\aogonek + \else\ifx\temp\macrocharE\Eogonek + \else\ifx\temp\macrochare\eogonek + \else + \ecfont \setbox0=\hbox{#1}% + \ifdim\ht0=1ex\accent"0C #1% + \else\ooalign{\unhbox0\crcr\hidewidth\char"0C \hidewidth}% + \fi + \fi\fi\fi\fi + }% +} +\def\Aogonek{{\ecfont \char"81}}\def\macrocharA{A} +\def\aogonek{{\ecfont \char"A1}}\def\macrochara{a} +\def\Eogonek{{\ecfont \char"86}}\def\macrocharE{E} +\def\eogonek{{\ecfont \char"A6}}\def\macrochare{e} +% +% Use the ec* fonts (cm-super in outline format) for non-CM glyphs. +\def\ecfont{% + % We can't distinguish serif/sans and italic/slanted, but this + % is used for crude hacks anyway (like adding French and German + % quotes to documents typeset with CM, where we lose kerning), so + % hopefully nobody will notice/care. + \edef\ecsize{\csname\curfontsize ecsize\endcsname}% + \edef\nominalsize{\csname\curfontsize nominalsize\endcsname}% + \ifx\curfontstyle\bfstylename + % bold: + \font\thisecfont = ecb\ifusingit{i}{x}\ecsize \space at \nominalsize + \else + % regular: + \font\thisecfont = ec\ifusingit{ti}{rm}\ecsize \space at \nominalsize + \fi + \thisecfont +} + +% @registeredsymbol - R in a circle. The font for the R should really +% be smaller yet, but lllsize is the best we can do for now. +% Adapted from the plain.tex definition of \copyright. +% +\def\registeredsymbol{% + $^{{\ooalign{\hfil\raise.07ex\hbox{\selectfonts\lllsize R}% + \hfil\crcr\Orb}}% + }$% +} + +% @textdegree - the normal degrees sign. +% +\def\textdegree{$^\circ$} + +% Laurent Siebenmann reports \Orb undefined with: +% Textures 1.7.7 (preloaded format=plain 93.10.14) (68K) 16 APR 2004 02:38 +% so we'll define it if necessary. +% +\ifx\Orb\undefined +\def\Orb{\mathhexbox20D} +\fi + +% Quotes. +\chardef\quotedblleft="5C +\chardef\quotedblright=`\" +\chardef\quoteleft=`\` +\chardef\quoteright=`\' + + +\message{page headings,} + +\newskip\titlepagetopglue \titlepagetopglue = 1.5in +\newskip\titlepagebottomglue \titlepagebottomglue = 2pc + +% First the title page. Must do @settitle before @titlepage. +\newif\ifseenauthor +\newif\iffinishedtitlepage + +% Do an implicit @contents or @shortcontents after @end titlepage if the +% user says @setcontentsaftertitlepage or @setshortcontentsaftertitlepage. +% +\newif\ifsetcontentsaftertitlepage + \let\setcontentsaftertitlepage = \setcontentsaftertitlepagetrue +\newif\ifsetshortcontentsaftertitlepage + \let\setshortcontentsaftertitlepage = \setshortcontentsaftertitlepagetrue + +\parseargdef\shorttitlepage{\begingroup\hbox{}\vskip 1.5in \chaprm \centerline{#1}% + \endgroup\page\hbox{}\page} + +\envdef\titlepage{% + % Open one extra group, as we want to close it in the middle of \Etitlepage. + \begingroup + \parindent=0pt \textfonts + % Leave some space at the very top of the page. + \vglue\titlepagetopglue + % No rule at page bottom unless we print one at the top with @title. + \finishedtitlepagetrue + % + % Most title ``pages'' are actually two pages long, with space + % at the top of the second. We don't want the ragged left on the second. + \let\oldpage = \page + \def\page{% + \iffinishedtitlepage\else + \finishtitlepage + \fi + \let\page = \oldpage + \page + \null + }% +} + +\def\Etitlepage{% + \iffinishedtitlepage\else + \finishtitlepage + \fi + % It is important to do the page break before ending the group, + % because the headline and footline are only empty inside the group. + % If we use the new definition of \page, we always get a blank page + % after the title page, which we certainly don't want. + \oldpage + \endgroup + % + % Need this before the \...aftertitlepage checks so that if they are + % in effect the toc pages will come out with page numbers. + \HEADINGSon + % + % If they want short, they certainly want long too. + \ifsetshortcontentsaftertitlepage + \shortcontents + \contents + \global\let\shortcontents = \relax + \global\let\contents = \relax + \fi + % + \ifsetcontentsaftertitlepage + \contents + \global\let\contents = \relax + \global\let\shortcontents = \relax + \fi +} + +\def\finishtitlepage{% + \vskip4pt \hrule height 2pt width \hsize + \vskip\titlepagebottomglue + \finishedtitlepagetrue +} + +%%% Macros to be used within @titlepage: + +\let\subtitlerm=\tenrm +\def\subtitlefont{\subtitlerm \normalbaselineskip = 13pt \normalbaselines} + +\parseargdef\title{% + \checkenv\titlepage + \leftline{\titlefonts\rmisbold #1} + % print a rule at the page bottom also. + \finishedtitlepagefalse + \vskip4pt \hrule height 4pt width \hsize \vskip4pt +} + +\parseargdef\subtitle{% + \checkenv\titlepage + {\subtitlefont \rightline{#1}}% +} + +% @author should come last, but may come many times. +% It can also be used inside @quotation. +% +\parseargdef\author{% + \def\temp{\quotation}% + \ifx\thisenv\temp + \def\quotationauthor{#1}% printed in \Equotation. + \else + \checkenv\titlepage + \ifseenauthor\else \vskip 0pt plus 1filll \seenauthortrue \fi + {\secfonts\rmisbold \leftline{#1}}% + \fi +} + + +%%% Set up page headings and footings. + +\let\thispage=\folio + +\newtoks\evenheadline % headline on even pages +\newtoks\oddheadline % headline on odd pages +\newtoks\evenfootline % footline on even pages +\newtoks\oddfootline % footline on odd pages + +% Now make TeX use those variables +\headline={{\textfonts\rm \ifodd\pageno \the\oddheadline + \else \the\evenheadline \fi}} +\footline={{\textfonts\rm \ifodd\pageno \the\oddfootline + \else \the\evenfootline \fi}\HEADINGShook} +\let\HEADINGShook=\relax + +% Commands to set those variables. +% For example, this is what @headings on does +% @evenheading @thistitle|@thispage|@thischapter +% @oddheading @thischapter|@thispage|@thistitle +% @evenfooting @thisfile|| +% @oddfooting ||@thisfile + + +\def\evenheading{\parsearg\evenheadingxxx} +\def\evenheadingxxx #1{\evenheadingyyy #1\|\|\|\|\finish} +\def\evenheadingyyy #1\|#2\|#3\|#4\finish{% +\global\evenheadline={\rlap{\centerline{#2}}\line{#1\hfil#3}}} + +\def\oddheading{\parsearg\oddheadingxxx} +\def\oddheadingxxx #1{\oddheadingyyy #1\|\|\|\|\finish} +\def\oddheadingyyy #1\|#2\|#3\|#4\finish{% +\global\oddheadline={\rlap{\centerline{#2}}\line{#1\hfil#3}}} + +\parseargdef\everyheading{\oddheadingxxx{#1}\evenheadingxxx{#1}}% + +\def\evenfooting{\parsearg\evenfootingxxx} +\def\evenfootingxxx #1{\evenfootingyyy #1\|\|\|\|\finish} +\def\evenfootingyyy #1\|#2\|#3\|#4\finish{% +\global\evenfootline={\rlap{\centerline{#2}}\line{#1\hfil#3}}} + +\def\oddfooting{\parsearg\oddfootingxxx} +\def\oddfootingxxx #1{\oddfootingyyy #1\|\|\|\|\finish} +\def\oddfootingyyy #1\|#2\|#3\|#4\finish{% + \global\oddfootline = {\rlap{\centerline{#2}}\line{#1\hfil#3}}% + % + % Leave some space for the footline. Hopefully ok to assume + % @evenfooting will not be used by itself. + \global\advance\pageheight by -12pt + \global\advance\vsize by -12pt +} + +\parseargdef\everyfooting{\oddfootingxxx{#1}\evenfootingxxx{#1}} + +% @evenheadingmarks top \thischapter <- chapter at the top of a page +% @evenheadingmarks bottom \thischapter <- chapter at the bottom of a page +% +% The same set of arguments for: +% +% @oddheadingmarks +% @evenfootingmarks +% @oddfootingmarks +% @everyheadingmarks +% @everyfootingmarks + +\def\evenheadingmarks{\headingmarks{even}{heading}} +\def\oddheadingmarks{\headingmarks{odd}{heading}} +\def\evenfootingmarks{\headingmarks{even}{footing}} +\def\oddfootingmarks{\headingmarks{odd}{footing}} +\def\everyheadingmarks#1 {\headingmarks{even}{heading}{#1} + \headingmarks{odd}{heading}{#1} } +\def\everyfootingmarks#1 {\headingmarks{even}{footing}{#1} + \headingmarks{odd}{footing}{#1} } +% #1 = even/odd, #2 = heading/footing, #3 = top/bottom. +\def\headingmarks#1#2#3 {% + \expandafter\let\expandafter\temp \csname get#3headingmarks\endcsname + \global\expandafter\let\csname get#1#2marks\endcsname \temp +} + +\everyheadingmarks bottom +\everyfootingmarks bottom + +% @headings double turns headings on for double-sided printing. +% @headings single turns headings on for single-sided printing. +% @headings off turns them off. +% @headings on same as @headings double, retained for compatibility. +% @headings after turns on double-sided headings after this page. +% @headings doubleafter turns on double-sided headings after this page. +% @headings singleafter turns on single-sided headings after this page. +% By default, they are off at the start of a document, +% and turned `on' after @end titlepage. + +\def\headings #1 {\csname HEADINGS#1\endcsname} + +\def\HEADINGSoff{% +\global\evenheadline={\hfil} \global\evenfootline={\hfil} +\global\oddheadline={\hfil} \global\oddfootline={\hfil}} +\HEADINGSoff +% When we turn headings on, set the page number to 1. +% For double-sided printing, put current file name in lower left corner, +% chapter name on inside top of right hand pages, document +% title on inside top of left hand pages, and page numbers on outside top +% edge of all pages. +\def\HEADINGSdouble{% +\global\pageno=1 +\global\evenfootline={\hfil} +\global\oddfootline={\hfil} +\global\evenheadline={\line{\folio\hfil\thistitle}} +\global\oddheadline={\line{\thischapter\hfil\folio}} +\global\let\contentsalignmacro = \chapoddpage +} +\let\contentsalignmacro = \chappager + +% For single-sided printing, chapter title goes across top left of page, +% page number on top right. +\def\HEADINGSsingle{% +\global\pageno=1 +\global\evenfootline={\hfil} +\global\oddfootline={\hfil} +\global\evenheadline={\line{\thischapter\hfil\folio}} +\global\oddheadline={\line{\thischapter\hfil\folio}} +\global\let\contentsalignmacro = \chappager +} +\def\HEADINGSon{\HEADINGSdouble} + +\def\HEADINGSafter{\let\HEADINGShook=\HEADINGSdoublex} +\let\HEADINGSdoubleafter=\HEADINGSafter +\def\HEADINGSdoublex{% +\global\evenfootline={\hfil} +\global\oddfootline={\hfil} +\global\evenheadline={\line{\folio\hfil\thistitle}} +\global\oddheadline={\line{\thischapter\hfil\folio}} +\global\let\contentsalignmacro = \chapoddpage +} + +\def\HEADINGSsingleafter{\let\HEADINGShook=\HEADINGSsinglex} +\def\HEADINGSsinglex{% +\global\evenfootline={\hfil} +\global\oddfootline={\hfil} +\global\evenheadline={\line{\thischapter\hfil\folio}} +\global\oddheadline={\line{\thischapter\hfil\folio}} +\global\let\contentsalignmacro = \chappager +} + +% Subroutines used in generating headings +% This produces Day Month Year style of output. +% Only define if not already defined, in case a txi-??.tex file has set +% up a different format (e.g., txi-cs.tex does this). +\ifx\today\undefined +\def\today{% + \number\day\space + \ifcase\month + \or\putwordMJan\or\putwordMFeb\or\putwordMMar\or\putwordMApr + \or\putwordMMay\or\putwordMJun\or\putwordMJul\or\putwordMAug + \or\putwordMSep\or\putwordMOct\or\putwordMNov\or\putwordMDec + \fi + \space\number\year} +\fi + +% @settitle line... specifies the title of the document, for headings. +% It generates no output of its own. +\def\thistitle{\putwordNoTitle} +\def\settitle{\parsearg{\gdef\thistitle}} + + +\message{tables,} +% Tables -- @table, @ftable, @vtable, @item(x). + +% default indentation of table text +\newdimen\tableindent \tableindent=.8in +% default indentation of @itemize and @enumerate text +\newdimen\itemindent \itemindent=.3in +% margin between end of table item and start of table text. +\newdimen\itemmargin \itemmargin=.1in + +% used internally for \itemindent minus \itemmargin +\newdimen\itemmax + +% Note @table, @ftable, and @vtable define @item, @itemx, etc., with +% these defs. +% They also define \itemindex +% to index the item name in whatever manner is desired (perhaps none). + +\newif\ifitemxneedsnegativevskip + +\def\itemxpar{\par\ifitemxneedsnegativevskip\nobreak\vskip-\parskip\nobreak\fi} + +\def\internalBitem{\smallbreak \parsearg\itemzzz} +\def\internalBitemx{\itemxpar \parsearg\itemzzz} + +\def\itemzzz #1{\begingroup % + \advance\hsize by -\rightskip + \advance\hsize by -\tableindent + \setbox0=\hbox{\itemindicate{#1}}% + \itemindex{#1}% + \nobreak % This prevents a break before @itemx. + % + % If the item text does not fit in the space we have, put it on a line + % by itself, and do not allow a page break either before or after that + % line. We do not start a paragraph here because then if the next + % command is, e.g., @kindex, the whatsit would get put into the + % horizontal list on a line by itself, resulting in extra blank space. + \ifdim \wd0>\itemmax + % + % Make this a paragraph so we get the \parskip glue and wrapping, + % but leave it ragged-right. + \begingroup + \advance\leftskip by-\tableindent + \advance\hsize by\tableindent + \advance\rightskip by0pt plus1fil + \leavevmode\unhbox0\par + \endgroup + % + % We're going to be starting a paragraph, but we don't want the + % \parskip glue -- logically it's part of the @item we just started. + \nobreak \vskip-\parskip + % + % Stop a page break at the \parskip glue coming up. However, if + % what follows is an environment such as @example, there will be no + % \parskip glue; then the negative vskip we just inserted would + % cause the example and the item to crash together. So we use this + % bizarre value of 10001 as a signal to \aboveenvbreak to insert + % \parskip glue after all. Section titles are handled this way also. + % + \penalty 10001 + \endgroup + \itemxneedsnegativevskipfalse + \else + % The item text fits into the space. Start a paragraph, so that the + % following text (if any) will end up on the same line. + \noindent + % Do this with kerns and \unhbox so that if there is a footnote in + % the item text, it can migrate to the main vertical list and + % eventually be printed. + \nobreak\kern-\tableindent + \dimen0 = \itemmax \advance\dimen0 by \itemmargin \advance\dimen0 by -\wd0 + \unhbox0 + \nobreak\kern\dimen0 + \endgroup + \itemxneedsnegativevskiptrue + \fi +} + +\def\item{\errmessage{@item while not in a list environment}} +\def\itemx{\errmessage{@itemx while not in a list environment}} + +% @table, @ftable, @vtable. +\envdef\table{% + \let\itemindex\gobble + \tablecheck{table}% +} +\envdef\ftable{% + \def\itemindex ##1{\doind {fn}{\code{##1}}}% + \tablecheck{ftable}% +} +\envdef\vtable{% + \def\itemindex ##1{\doind {vr}{\code{##1}}}% + \tablecheck{vtable}% +} +\def\tablecheck#1{% + \ifnum \the\catcode`\^^M=\active + \endgroup + \errmessage{This command won't work in this context; perhaps the problem is + that we are \inenvironment\thisenv}% + \def\next{\doignore{#1}}% + \else + \let\next\tablex + \fi + \next +} +\def\tablex#1{% + \def\itemindicate{#1}% + \parsearg\tabley +} +\def\tabley#1{% + {% + \makevalueexpandable + \edef\temp{\noexpand\tablez #1\space\space\space}% + \expandafter + }\temp \endtablez +} +\def\tablez #1 #2 #3 #4\endtablez{% + \aboveenvbreak + \ifnum 0#1>0 \advance \leftskip by #1\mil \fi + \ifnum 0#2>0 \tableindent=#2\mil \fi + \ifnum 0#3>0 \advance \rightskip by #3\mil \fi + \itemmax=\tableindent + \advance \itemmax by -\itemmargin + \advance \leftskip by \tableindent + \exdentamount=\tableindent + \parindent = 0pt + \parskip = \smallskipamount + \ifdim \parskip=0pt \parskip=2pt \fi + \let\item = \internalBitem + \let\itemx = \internalBitemx +} +\def\Etable{\endgraf\afterenvbreak} +\let\Eftable\Etable +\let\Evtable\Etable +\let\Eitemize\Etable +\let\Eenumerate\Etable + +% This is the counter used by @enumerate, which is really @itemize + +\newcount \itemno + +\envdef\itemize{\parsearg\doitemize} + +\def\doitemize#1{% + \aboveenvbreak + \itemmax=\itemindent + \advance\itemmax by -\itemmargin + \advance\leftskip by \itemindent + \exdentamount=\itemindent + \parindent=0pt + \parskip=\smallskipamount + \ifdim\parskip=0pt \parskip=2pt \fi + % + % Try typesetting the item mark that if the document erroneously says + % something like @itemize @samp (intending @table), there's an error + % right away at the @itemize. It's not the best error message in the + % world, but it's better than leaving it to the @item. This means if + % the user wants an empty mark, they have to say @w{} not just @w. + \def\itemcontents{#1}% + \setbox0 = \hbox{\itemcontents}% + % + % @itemize with no arg is equivalent to @itemize @bullet. + \ifx\itemcontents\empty\def\itemcontents{\bullet}\fi + % + \let\item=\itemizeitem +} + +% Definition of @item while inside @itemize and @enumerate. +% +\def\itemizeitem{% + \advance\itemno by 1 % for enumerations + {\let\par=\endgraf \smallbreak}% reasonable place to break + {% + % If the document has an @itemize directly after a section title, a + % \nobreak will be last on the list, and \sectionheading will have + % done a \vskip-\parskip. In that case, we don't want to zero + % parskip, or the item text will crash with the heading. On the + % other hand, when there is normal text preceding the item (as there + % usually is), we do want to zero parskip, or there would be too much + % space. In that case, we won't have a \nobreak before. At least + % that's the theory. + \ifnum\lastpenalty<10000 \parskip=0in \fi + \noindent + \hbox to 0pt{\hss \itemcontents \kern\itemmargin}% + % + \vadjust{\penalty 1200}}% not good to break after first line of item. + \flushcr +} + +% \splitoff TOKENS\endmark defines \first to be the first token in +% TOKENS, and \rest to be the remainder. +% +\def\splitoff#1#2\endmark{\def\first{#1}\def\rest{#2}}% + +% Allow an optional argument of an uppercase letter, lowercase letter, +% or number, to specify the first label in the enumerated list. No +% argument is the same as `1'. +% +\envparseargdef\enumerate{\enumeratey #1 \endenumeratey} +\def\enumeratey #1 #2\endenumeratey{% + % If we were given no argument, pretend we were given `1'. + \def\thearg{#1}% + \ifx\thearg\empty \def\thearg{1}\fi + % + % Detect if the argument is a single token. If so, it might be a + % letter. Otherwise, the only valid thing it can be is a number. + % (We will always have one token, because of the test we just made. + % This is a good thing, since \splitoff doesn't work given nothing at + % all -- the first parameter is undelimited.) + \expandafter\splitoff\thearg\endmark + \ifx\rest\empty + % Only one token in the argument. It could still be anything. + % A ``lowercase letter'' is one whose \lccode is nonzero. + % An ``uppercase letter'' is one whose \lccode is both nonzero, and + % not equal to itself. + % Otherwise, we assume it's a number. + % + % We need the \relax at the end of the \ifnum lines to stop TeX from + % continuing to look for a . + % + \ifnum\lccode\expandafter`\thearg=0\relax + \numericenumerate % a number (we hope) + \else + % It's a letter. + \ifnum\lccode\expandafter`\thearg=\expandafter`\thearg\relax + \lowercaseenumerate % lowercase letter + \else + \uppercaseenumerate % uppercase letter + \fi + \fi + \else + % Multiple tokens in the argument. We hope it's a number. + \numericenumerate + \fi +} + +% An @enumerate whose labels are integers. The starting integer is +% given in \thearg. +% +\def\numericenumerate{% + \itemno = \thearg + \startenumeration{\the\itemno}% +} + +% The starting (lowercase) letter is in \thearg. +\def\lowercaseenumerate{% + \itemno = \expandafter`\thearg + \startenumeration{% + % Be sure we're not beyond the end of the alphabet. + \ifnum\itemno=0 + \errmessage{No more lowercase letters in @enumerate; get a bigger + alphabet}% + \fi + \char\lccode\itemno + }% +} + +% The starting (uppercase) letter is in \thearg. +\def\uppercaseenumerate{% + \itemno = \expandafter`\thearg + \startenumeration{% + % Be sure we're not beyond the end of the alphabet. + \ifnum\itemno=0 + \errmessage{No more uppercase letters in @enumerate; get a bigger + alphabet} + \fi + \char\uccode\itemno + }% +} + +% Call \doitemize, adding a period to the first argument and supplying the +% common last two arguments. Also subtract one from the initial value in +% \itemno, since @item increments \itemno. +% +\def\startenumeration#1{% + \advance\itemno by -1 + \doitemize{#1.}\flushcr +} + +% @alphaenumerate and @capsenumerate are abbreviations for giving an arg +% to @enumerate. +% +\def\alphaenumerate{\enumerate{a}} +\def\capsenumerate{\enumerate{A}} +\def\Ealphaenumerate{\Eenumerate} +\def\Ecapsenumerate{\Eenumerate} + + +% @multitable macros +% Amy Hendrickson, 8/18/94, 3/6/96 +% +% @multitable ... @end multitable will make as many columns as desired. +% Contents of each column will wrap at width given in preamble. Width +% can be specified either with sample text given in a template line, +% or in percent of \hsize, the current width of text on page. + +% Table can continue over pages but will only break between lines. + +% To make preamble: +% +% Either define widths of columns in terms of percent of \hsize: +% @multitable @columnfractions .25 .3 .45 +% @item ... +% +% Numbers following @columnfractions are the percent of the total +% current hsize to be used for each column. You may use as many +% columns as desired. + + +% Or use a template: +% @multitable {Column 1 template} {Column 2 template} {Column 3 template} +% @item ... +% using the widest term desired in each column. + +% Each new table line starts with @item, each subsequent new column +% starts with @tab. Empty columns may be produced by supplying @tab's +% with nothing between them for as many times as empty columns are needed, +% ie, @tab@tab@tab will produce two empty columns. + +% @item, @tab do not need to be on their own lines, but it will not hurt +% if they are. + +% Sample multitable: + +% @multitable {Column 1 template} {Column 2 template} {Column 3 template} +% @item first col stuff @tab second col stuff @tab third col +% @item +% first col stuff +% @tab +% second col stuff +% @tab +% third col +% @item first col stuff @tab second col stuff +% @tab Many paragraphs of text may be used in any column. +% +% They will wrap at the width determined by the template. +% @item@tab@tab This will be in third column. +% @end multitable + +% Default dimensions may be reset by user. +% @multitableparskip is vertical space between paragraphs in table. +% @multitableparindent is paragraph indent in table. +% @multitablecolmargin is horizontal space to be left between columns. +% @multitablelinespace is space to leave between table items, baseline +% to baseline. +% 0pt means it depends on current normal line spacing. +% +\newskip\multitableparskip +\newskip\multitableparindent +\newdimen\multitablecolspace +\newskip\multitablelinespace +\multitableparskip=0pt +\multitableparindent=6pt +\multitablecolspace=12pt +\multitablelinespace=0pt + +% Macros used to set up halign preamble: +% +\let\endsetuptable\relax +\def\xendsetuptable{\endsetuptable} +\let\columnfractions\relax +\def\xcolumnfractions{\columnfractions} +\newif\ifsetpercent + +% #1 is the @columnfraction, usually a decimal number like .5, but might +% be just 1. We just use it, whatever it is. +% +\def\pickupwholefraction#1 {% + \global\advance\colcount by 1 + \expandafter\xdef\csname col\the\colcount\endcsname{#1\hsize}% + \setuptable +} + +\newcount\colcount +\def\setuptable#1{% + \def\firstarg{#1}% + \ifx\firstarg\xendsetuptable + \let\go = \relax + \else + \ifx\firstarg\xcolumnfractions + \global\setpercenttrue + \else + \ifsetpercent + \let\go\pickupwholefraction + \else + \global\advance\colcount by 1 + \setbox0=\hbox{#1\unskip\space}% Add a normal word space as a + % separator; typically that is always in the input, anyway. + \expandafter\xdef\csname col\the\colcount\endcsname{\the\wd0}% + \fi + \fi + \ifx\go\pickupwholefraction + % Put the argument back for the \pickupwholefraction call, so + % we'll always have a period there to be parsed. + \def\go{\pickupwholefraction#1}% + \else + \let\go = \setuptable + \fi% + \fi + \go +} + +% multitable-only commands. +% +% @headitem starts a heading row, which we typeset in bold. +% Assignments have to be global since we are inside the implicit group +% of an alignment entry. \everycr resets \everytab so we don't have to +% undo it ourselves. +\def\headitemfont{\b}% for people to use in the template row; not changeable +\def\headitem{% + \checkenv\multitable + \crcr + \global\everytab={\bf}% can't use \headitemfont since the parsing differs + \the\everytab % for the first item +}% +% +% A \tab used to include \hskip1sp. But then the space in a template +% line is not enough. That is bad. So let's go back to just `&' until +% we again encounter the problem the 1sp was intended to solve. +% --karl, nathan@acm.org, 20apr99. +\def\tab{\checkenv\multitable &\the\everytab}% + +% @multitable ... @end multitable definitions: +% +\newtoks\everytab % insert after every tab. +% +\envdef\multitable{% + \vskip\parskip + \startsavinginserts + % + % @item within a multitable starts a normal row. + % We use \def instead of \let so that if one of the multitable entries + % contains an @itemize, we don't choke on the \item (seen as \crcr aka + % \endtemplate) expanding \doitemize. + \def\item{\crcr}% + % + \tolerance=9500 + \hbadness=9500 + \setmultitablespacing + \parskip=\multitableparskip + \parindent=\multitableparindent + \overfullrule=0pt + \global\colcount=0 + % + \everycr = {% + \noalign{% + \global\everytab={}% + \global\colcount=0 % Reset the column counter. + % Check for saved footnotes, etc. + \checkinserts + % Keeps underfull box messages off when table breaks over pages. + %\filbreak + % Maybe so, but it also creates really weird page breaks when the + % table breaks over pages. Wouldn't \vfil be better? Wait until the + % problem manifests itself, so it can be fixed for real --karl. + }% + }% + % + \parsearg\domultitable +} +\def\domultitable#1{% + % To parse everything between @multitable and @item: + \setuptable#1 \endsetuptable + % + % This preamble sets up a generic column definition, which will + % be used as many times as user calls for columns. + % \vtop will set a single line and will also let text wrap and + % continue for many paragraphs if desired. + \halign\bgroup &% + \global\advance\colcount by 1 + \multistrut + \vtop{% + % Use the current \colcount to find the correct column width: + \hsize=\expandafter\csname col\the\colcount\endcsname + % + % In order to keep entries from bumping into each other + % we will add a \leftskip of \multitablecolspace to all columns after + % the first one. + % + % If a template has been used, we will add \multitablecolspace + % to the width of each template entry. + % + % If the user has set preamble in terms of percent of \hsize we will + % use that dimension as the width of the column, and the \leftskip + % will keep entries from bumping into each other. Table will start at + % left margin and final column will justify at right margin. + % + % Make sure we don't inherit \rightskip from the outer environment. + \rightskip=0pt + \ifnum\colcount=1 + % The first column will be indented with the surrounding text. + \advance\hsize by\leftskip + \else + \ifsetpercent \else + % If user has not set preamble in terms of percent of \hsize + % we will advance \hsize by \multitablecolspace. + \advance\hsize by \multitablecolspace + \fi + % In either case we will make \leftskip=\multitablecolspace: + \leftskip=\multitablecolspace + \fi + % Ignoring space at the beginning and end avoids an occasional spurious + % blank line, when TeX decides to break the line at the space before the + % box from the multistrut, so the strut ends up on a line by itself. + % For example: + % @multitable @columnfractions .11 .89 + % @item @code{#} + % @tab Legal holiday which is valid in major parts of the whole country. + % Is automatically provided with highlighting sequences respectively + % marking characters. + \noindent\ignorespaces##\unskip\multistrut + }\cr +} +\def\Emultitable{% + \crcr + \egroup % end the \halign + \global\setpercentfalse +} + +\def\setmultitablespacing{% + \def\multistrut{\strut}% just use the standard line spacing + % + % Compute \multitablelinespace (if not defined by user) for use in + % \multitableparskip calculation. We used define \multistrut based on + % this, but (ironically) that caused the spacing to be off. + % See bug-texinfo report from Werner Lemberg, 31 Oct 2004 12:52:20 +0100. +\ifdim\multitablelinespace=0pt +\setbox0=\vbox{X}\global\multitablelinespace=\the\baselineskip +\global\advance\multitablelinespace by-\ht0 +\fi +%% Test to see if parskip is larger than space between lines of +%% table. If not, do nothing. +%% If so, set to same dimension as multitablelinespace. +\ifdim\multitableparskip>\multitablelinespace +\global\multitableparskip=\multitablelinespace +\global\advance\multitableparskip-7pt %% to keep parskip somewhat smaller + %% than skip between lines in the table. +\fi% +\ifdim\multitableparskip=0pt +\global\multitableparskip=\multitablelinespace +\global\advance\multitableparskip-7pt %% to keep parskip somewhat smaller + %% than skip between lines in the table. +\fi} + + +\message{conditionals,} + +% @iftex, @ifnotdocbook, @ifnothtml, @ifnotinfo, @ifnotplaintext, +% @ifnotxml always succeed. They currently do nothing; we don't +% attempt to check whether the conditionals are properly nested. But we +% have to remember that they are conditionals, so that @end doesn't +% attempt to close an environment group. +% +\def\makecond#1{% + \expandafter\let\csname #1\endcsname = \relax + \expandafter\let\csname iscond.#1\endcsname = 1 +} +\makecond{iftex} +\makecond{ifnotdocbook} +\makecond{ifnothtml} +\makecond{ifnotinfo} +\makecond{ifnotplaintext} +\makecond{ifnotxml} + +% Ignore @ignore, @ifhtml, @ifinfo, and the like. +% +\def\direntry{\doignore{direntry}} +\def\documentdescription{\doignore{documentdescription}} +\def\docbook{\doignore{docbook}} +\def\html{\doignore{html}} +\def\ifdocbook{\doignore{ifdocbook}} +\def\ifhtml{\doignore{ifhtml}} +\def\ifinfo{\doignore{ifinfo}} +\def\ifnottex{\doignore{ifnottex}} +\def\ifplaintext{\doignore{ifplaintext}} +\def\ifxml{\doignore{ifxml}} +\def\ignore{\doignore{ignore}} +\def\menu{\doignore{menu}} +\def\xml{\doignore{xml}} + +% Ignore text until a line `@end #1', keeping track of nested conditionals. +% +% A count to remember the depth of nesting. +\newcount\doignorecount + +\def\doignore#1{\begingroup + % Scan in ``verbatim'' mode: + \obeylines + \catcode`\@ = \other + \catcode`\{ = \other + \catcode`\} = \other + % + % Make sure that spaces turn into tokens that match what \doignoretext wants. + \spaceisspace + % + % Count number of #1's that we've seen. + \doignorecount = 0 + % + % Swallow text until we reach the matching `@end #1'. + \dodoignore{#1}% +} + +{ \catcode`_=11 % We want to use \_STOP_ which cannot appear in texinfo source. + \obeylines % + % + \gdef\dodoignore#1{% + % #1 contains the command name as a string, e.g., `ifinfo'. + % + % Define a command to find the next `@end #1'. + \long\def\doignoretext##1^^M@end #1{% + \doignoretextyyy##1^^M@#1\_STOP_}% + % + % And this command to find another #1 command, at the beginning of a + % line. (Otherwise, we would consider a line `@c @ifset', for + % example, to count as an @ifset for nesting.) + \long\def\doignoretextyyy##1^^M@#1##2\_STOP_{\doignoreyyy{##2}\_STOP_}% + % + % And now expand that command. + \doignoretext ^^M% + }% +} + +\def\doignoreyyy#1{% + \def\temp{#1}% + \ifx\temp\empty % Nothing found. + \let\next\doignoretextzzz + \else % Found a nested condition, ... + \advance\doignorecount by 1 + \let\next\doignoretextyyy % ..., look for another. + % If we're here, #1 ends with ^^M\ifinfo (for example). + \fi + \next #1% the token \_STOP_ is present just after this macro. +} + +% We have to swallow the remaining "\_STOP_". +% +\def\doignoretextzzz#1{% + \ifnum\doignorecount = 0 % We have just found the outermost @end. + \let\next\enddoignore + \else % Still inside a nested condition. + \advance\doignorecount by -1 + \let\next\doignoretext % Look for the next @end. + \fi + \next +} + +% Finish off ignored text. +{ \obeylines% + % Ignore anything after the last `@end #1'; this matters in verbatim + % environments, where otherwise the newline after an ignored conditional + % would result in a blank line in the output. + \gdef\enddoignore#1^^M{\endgroup\ignorespaces}% +} + + +% @set VAR sets the variable VAR to an empty value. +% @set VAR REST-OF-LINE sets VAR to the value REST-OF-LINE. +% +% Since we want to separate VAR from REST-OF-LINE (which might be +% empty), we can't just use \parsearg; we have to insert a space of our +% own to delimit the rest of the line, and then take it out again if we +% didn't need it. +% We rely on the fact that \parsearg sets \catcode`\ =10. +% +\parseargdef\set{\setyyy#1 \endsetyyy} +\def\setyyy#1 #2\endsetyyy{% + {% + \makevalueexpandable + \def\temp{#2}% + \edef\next{\gdef\makecsname{SET#1}}% + \ifx\temp\empty + \next{}% + \else + \setzzz#2\endsetzzz + \fi + }% +} +% Remove the trailing space \setxxx inserted. +\def\setzzz#1 \endsetzzz{\next{#1}} + +% @clear VAR clears (i.e., unsets) the variable VAR. +% +\parseargdef\clear{% + {% + \makevalueexpandable + \global\expandafter\let\csname SET#1\endcsname=\relax + }% +} + +% @value{foo} gets the text saved in variable foo. +\def\value{\begingroup\makevalueexpandable\valuexxx} +\def\valuexxx#1{\expandablevalue{#1}\endgroup} +{ + \catcode`\- = \active \catcode`\_ = \active + % + \gdef\makevalueexpandable{% + \let\value = \expandablevalue + % We don't want these characters active, ... + \catcode`\-=\other \catcode`\_=\other + % ..., but we might end up with active ones in the argument if + % we're called from @code, as @code{@value{foo-bar_}}, though. + % So \let them to their normal equivalents. + \let-\realdash \let_\normalunderscore + } +} + +% We have this subroutine so that we can handle at least some @value's +% properly in indexes (we call \makevalueexpandable in \indexdummies). +% The command has to be fully expandable (if the variable is set), since +% the result winds up in the index file. This means that if the +% variable's value contains other Texinfo commands, it's almost certain +% it will fail (although perhaps we could fix that with sufficient work +% to do a one-level expansion on the result, instead of complete). +% +\def\expandablevalue#1{% + \expandafter\ifx\csname SET#1\endcsname\relax + {[No value for ``#1'']}% + \message{Variable `#1', used in @value, is not set.}% + \else + \csname SET#1\endcsname + \fi +} + +% @ifset VAR ... @end ifset reads the `...' iff VAR has been defined +% with @set. +% +% To get special treatment of `@end ifset,' call \makeond and the redefine. +% +\makecond{ifset} +\def\ifset{\parsearg{\doifset{\let\next=\ifsetfail}}} +\def\doifset#1#2{% + {% + \makevalueexpandable + \let\next=\empty + \expandafter\ifx\csname SET#2\endcsname\relax + #1% If not set, redefine \next. + \fi + \expandafter + }\next +} +\def\ifsetfail{\doignore{ifset}} + +% @ifclear VAR ... @end ifclear reads the `...' iff VAR has never been +% defined with @set, or has been undefined with @clear. +% +% The `\else' inside the `\doifset' parameter is a trick to reuse the +% above code: if the variable is not set, do nothing, if it is set, +% then redefine \next to \ifclearfail. +% +\makecond{ifclear} +\def\ifclear{\parsearg{\doifset{\else \let\next=\ifclearfail}}} +\def\ifclearfail{\doignore{ifclear}} + +% @dircategory CATEGORY -- specify a category of the dir file +% which this file should belong to. Ignore this in TeX. +\let\dircategory=\comment + +% @defininfoenclose. +\let\definfoenclose=\comment + + +\message{indexing,} +% Index generation facilities + +% Define \newwrite to be identical to plain tex's \newwrite +% except not \outer, so it can be used within macros and \if's. +\edef\newwrite{\makecsname{ptexnewwrite}} + +% \newindex {foo} defines an index named foo. +% It automatically defines \fooindex such that +% \fooindex ...rest of line... puts an entry in the index foo. +% It also defines \fooindfile to be the number of the output channel for +% the file that accumulates this index. The file's extension is foo. +% The name of an index should be no more than 2 characters long +% for the sake of vms. +% +\def\newindex#1{% + \iflinks + \expandafter\newwrite \csname#1indfile\endcsname + \openout \csname#1indfile\endcsname \jobname.#1 % Open the file + \fi + \expandafter\xdef\csname#1index\endcsname{% % Define @#1index + \noexpand\doindex{#1}} +} + +% @defindex foo == \newindex{foo} +% +\def\defindex{\parsearg\newindex} + +% Define @defcodeindex, like @defindex except put all entries in @code. +% +\def\defcodeindex{\parsearg\newcodeindex} +% +\def\newcodeindex#1{% + \iflinks + \expandafter\newwrite \csname#1indfile\endcsname + \openout \csname#1indfile\endcsname \jobname.#1 + \fi + \expandafter\xdef\csname#1index\endcsname{% + \noexpand\docodeindex{#1}}% +} + + +% @synindex foo bar makes index foo feed into index bar. +% Do this instead of @defindex foo if you don't want it as a separate index. +% +% @syncodeindex foo bar similar, but put all entries made for index foo +% inside @code. +% +\def\synindex#1 #2 {\dosynindex\doindex{#1}{#2}} +\def\syncodeindex#1 #2 {\dosynindex\docodeindex{#1}{#2}} + +% #1 is \doindex or \docodeindex, #2 the index getting redefined (foo), +% #3 the target index (bar). +\def\dosynindex#1#2#3{% + % Only do \closeout if we haven't already done it, else we'll end up + % closing the target index. + \expandafter \ifx\csname donesynindex#2\endcsname \relax + % The \closeout helps reduce unnecessary open files; the limit on the + % Acorn RISC OS is a mere 16 files. + \expandafter\closeout\csname#2indfile\endcsname + \expandafter\let\csname donesynindex#2\endcsname = 1 + \fi + % redefine \fooindfile: + \expandafter\let\expandafter\temp\expandafter=\csname#3indfile\endcsname + \expandafter\let\csname#2indfile\endcsname=\temp + % redefine \fooindex: + \expandafter\xdef\csname#2index\endcsname{\noexpand#1{#3}}% +} + +% Define \doindex, the driver for all \fooindex macros. +% Argument #1 is generated by the calling \fooindex macro, +% and it is "foo", the name of the index. + +% \doindex just uses \parsearg; it calls \doind for the actual work. +% This is because \doind is more useful to call from other macros. + +% There is also \dosubind {index}{topic}{subtopic} +% which makes an entry in a two-level index such as the operation index. + +\def\doindex#1{\edef\indexname{#1}\parsearg\singleindexer} +\def\singleindexer #1{\doind{\indexname}{#1}} + +% like the previous two, but they put @code around the argument. +\def\docodeindex#1{\edef\indexname{#1}\parsearg\singlecodeindexer} +\def\singlecodeindexer #1{\doind{\indexname}{\code{#1}}} + +% Take care of Texinfo commands that can appear in an index entry. +% Since there are some commands we want to expand, and others we don't, +% we have to laboriously prevent expansion for those that we don't. +% +\def\indexdummies{% + \escapechar = `\\ % use backslash in output files. + \def\@{@}% change to @@ when we switch to @ as escape char in index files. + \def\ {\realbackslash\space }% + % + % Need these in case \tex is in effect and \{ is a \delimiter again. + % But can't use \lbracecmd and \rbracecmd because texindex assumes + % braces and backslashes are used only as delimiters. + \let\{ = \mylbrace + \let\} = \myrbrace + % + % I don't entirely understand this, but when an index entry is + % generated from a macro call, the \endinput which \scanmacro inserts + % causes processing to be prematurely terminated. This is, + % apparently, because \indexsorttmp is fully expanded, and \endinput + % is an expandable command. The redefinition below makes \endinput + % disappear altogether for that purpose -- although logging shows that + % processing continues to some further point. On the other hand, it + % seems \endinput does not hurt in the printed index arg, since that + % is still getting written without apparent harm. + % + % Sample source (mac-idx3.tex, reported by Graham Percival to + % help-texinfo, 22may06): + % @macro funindex {WORD} + % @findex xyz + % @end macro + % ... + % @funindex commtest + % + % The above is not enough to reproduce the bug, but it gives the flavor. + % + % Sample whatsit resulting: + % .@write3{\entry{xyz}{@folio }{@code {xyz@endinput }}} + % + % So: + \let\endinput = \empty + % + % Do the redefinitions. + \commondummies +} + +% For the aux and toc files, @ is the escape character. So we want to +% redefine everything using @ as the escape character (instead of +% \realbackslash, still used for index files). When everything uses @, +% this will be simpler. +% +\def\atdummies{% + \def\@{@@}% + \def\ {@ }% + \let\{ = \lbraceatcmd + \let\} = \rbraceatcmd + % + % Do the redefinitions. + \commondummies + \otherbackslash +} + +% Called from \indexdummies and \atdummies. +% +\def\commondummies{% + % + % \definedummyword defines \#1 as \string\#1\space, thus effectively + % preventing its expansion. This is used only for control% words, + % not control letters, because the \space would be incorrect for + % control characters, but is needed to separate the control word + % from whatever follows. + % + % For control letters, we have \definedummyletter, which omits the + % space. + % + % These can be used both for control words that take an argument and + % those that do not. If it is followed by {arg} in the input, then + % that will dutifully get written to the index (or wherever). + % + \def\definedummyword ##1{\def##1{\string##1\space}}% + \def\definedummyletter##1{\def##1{\string##1}}% + \let\definedummyaccent\definedummyletter + % + \commondummiesnofonts + % + \definedummyletter\_% + % + % Non-English letters. + \definedummyword\AA + \definedummyword\AE + \definedummyword\DH + \definedummyword\L + \definedummyword\O + \definedummyword\OE + \definedummyword\TH + \definedummyword\aa + \definedummyword\ae + \definedummyword\dh + \definedummyword\exclamdown + \definedummyword\l + \definedummyword\o + \definedummyword\oe + \definedummyword\ordf + \definedummyword\ordm + \definedummyword\questiondown + \definedummyword\ss + \definedummyword\th + % + % Although these internal commands shouldn't show up, sometimes they do. + \definedummyword\bf + \definedummyword\gtr + \definedummyword\hat + \definedummyword\less + \definedummyword\sf + \definedummyword\sl + \definedummyword\tclose + \definedummyword\tt + % + \definedummyword\LaTeX + \definedummyword\TeX + % + % Assorted special characters. + \definedummyword\bullet + \definedummyword\comma + \definedummyword\copyright + \definedummyword\registeredsymbol + \definedummyword\dots + \definedummyword\enddots + \definedummyword\equiv + \definedummyword\error + \definedummyword\euro + \definedummyword\guillemetleft + \definedummyword\guillemetright + \definedummyword\guilsinglleft + \definedummyword\guilsinglright + \definedummyword\expansion + \definedummyword\minus + \definedummyword\ogonek + \definedummyword\pounds + \definedummyword\point + \definedummyword\print + \definedummyword\quotedblbase + \definedummyword\quotedblleft + \definedummyword\quotedblright + \definedummyword\quoteleft + \definedummyword\quoteright + \definedummyword\quotesinglbase + \definedummyword\result + \definedummyword\textdegree + % + % We want to disable all macros so that they are not expanded by \write. + \macrolist + % + \normalturnoffactive + % + % Handle some cases of @value -- where it does not contain any + % (non-fully-expandable) commands. + \makevalueexpandable +} + +% \commondummiesnofonts: common to \commondummies and \indexnofonts. +% +\def\commondummiesnofonts{% + % Control letters and accents. + \definedummyletter\!% + \definedummyaccent\"% + \definedummyaccent\'% + \definedummyletter\*% + \definedummyaccent\,% + \definedummyletter\.% + \definedummyletter\/% + \definedummyletter\:% + \definedummyaccent\=% + \definedummyletter\?% + \definedummyaccent\^% + \definedummyaccent\`% + \definedummyaccent\~% + \definedummyword\u + \definedummyword\v + \definedummyword\H + \definedummyword\dotaccent + \definedummyword\ogonek + \definedummyword\ringaccent + \definedummyword\tieaccent + \definedummyword\ubaraccent + \definedummyword\udotaccent + \definedummyword\dotless + % + % Texinfo font commands. + \definedummyword\b + \definedummyword\i + \definedummyword\r + \definedummyword\sc + \definedummyword\t + % + % Commands that take arguments. + \definedummyword\acronym + \definedummyword\cite + \definedummyword\code + \definedummyword\command + \definedummyword\dfn + \definedummyword\email + \definedummyword\emph + \definedummyword\env + \definedummyword\file + \definedummyword\kbd + \definedummyword\key + \definedummyword\math + \definedummyword\option + \definedummyword\pxref + \definedummyword\ref + \definedummyword\samp + \definedummyword\strong + \definedummyword\tie + \definedummyword\uref + \definedummyword\url + \definedummyword\var + \definedummyword\verb + \definedummyword\w + \definedummyword\xref +} + +% \indexnofonts is used when outputting the strings to sort the index +% by, and when constructing control sequence names. It eliminates all +% control sequences and just writes whatever the best ASCII sort string +% would be for a given command (usually its argument). +% +\def\indexnofonts{% + % Accent commands should become @asis. + \def\definedummyaccent##1{\let##1\asis}% + % We can just ignore other control letters. + \def\definedummyletter##1{\let##1\empty}% + % Hopefully, all control words can become @asis. + \let\definedummyword\definedummyaccent + % + \commondummiesnofonts + % + % Don't no-op \tt, since it isn't a user-level command + % and is used in the definitions of the active chars like <, >, |, etc. + % Likewise with the other plain tex font commands. + %\let\tt=\asis + % + \def\ { }% + \def\@{@}% + % how to handle braces? + \def\_{\normalunderscore}% + % + % Non-English letters. + \def\AA{AA}% + \def\AE{AE}% + \def\DH{DZZ}% + \def\L{L}% + \def\OE{OE}% + \def\O{O}% + \def\TH{ZZZ}% + \def\aa{aa}% + \def\ae{ae}% + \def\dh{dzz}% + \def\exclamdown{!}% + \def\l{l}% + \def\oe{oe}% + \def\ordf{a}% + \def\ordm{o}% + \def\o{o}% + \def\questiondown{?}% + \def\ss{ss}% + \def\th{zzz}% + % + \def\LaTeX{LaTeX}% + \def\TeX{TeX}% + % + % Assorted special characters. + % (The following {} will end up in the sort string, but that's ok.) + \def\bullet{bullet}% + \def\comma{,}% + \def\copyright{copyright}% + \def\dots{...}% + \def\enddots{...}% + \def\equiv{==}% + \def\error{error}% + \def\euro{euro}% + \def\expansion{==>}% + \def\guillemetleft{<<}% + \def\guillemetright{>>}% + \def\guilsinglleft{<}% + \def\guilsinglright{>}% + \def\minus{-}% + \def\point{.}% + \def\pounds{pounds}% + \def\print{-|}% + \def\quotedblbase{"}% + \def\quotedblleft{"}% + \def\quotedblright{"}% + \def\quoteleft{`}% + \def\quoteright{'}% + \def\quotesinglbase{,}% + \def\registeredsymbol{R}% + \def\result{=>}% + \def\textdegree{o}% + % + % We need to get rid of all macros, leaving only the arguments (if present). + % Of course this is not nearly correct, but it is the best we can do for now. + % makeinfo does not expand macros in the argument to @deffn, which ends up + % writing an index entry, and texindex isn't prepared for an index sort entry + % that starts with \. + % + % Since macro invocations are followed by braces, we can just redefine them + % to take a single TeX argument. The case of a macro invocation that + % goes to end-of-line is not handled. + % + \macrolist +} + +\let\indexbackslash=0 %overridden during \printindex. +\let\SETmarginindex=\relax % put index entries in margin (undocumented)? + +% Most index entries go through here, but \dosubind is the general case. +% #1 is the index name, #2 is the entry text. +\def\doind#1#2{\dosubind{#1}{#2}{}} + +% Workhorse for all \fooindexes. +% #1 is name of index, #2 is stuff to put there, #3 is subentry -- +% empty if called from \doind, as we usually are (the main exception +% is with most defuns, which call us directly). +% +\def\dosubind#1#2#3{% + \iflinks + {% + % Store the main index entry text (including the third arg). + \toks0 = {#2}% + % If third arg is present, precede it with a space. + \def\thirdarg{#3}% + \ifx\thirdarg\empty \else + \toks0 = \expandafter{\the\toks0 \space #3}% + \fi + % + \edef\writeto{\csname#1indfile\endcsname}% + % + \safewhatsit\dosubindwrite + }% + \fi +} + +% Write the entry in \toks0 to the index file: +% +\def\dosubindwrite{% + % Put the index entry in the margin if desired. + \ifx\SETmarginindex\relax\else + \insert\margin{\hbox{\vrule height8pt depth3pt width0pt \the\toks0}}% + \fi + % + % Remember, we are within a group. + \indexdummies % Must do this here, since \bf, etc expand at this stage + \def\backslashcurfont{\indexbackslash}% \indexbackslash isn't defined now + % so it will be output as is; and it will print as backslash. + % + % Process the index entry with all font commands turned off, to + % get the string to sort by. + {\indexnofonts + \edef\temp{\the\toks0}% need full expansion + \xdef\indexsorttmp{\temp}% + }% + % + % Set up the complete index entry, with both the sort key and + % the original text, including any font commands. We write + % three arguments to \entry to the .?? file (four in the + % subentry case), texindex reduces to two when writing the .??s + % sorted result. + \edef\temp{% + \write\writeto{% + \string\entry{\indexsorttmp}{\noexpand\folio}{\the\toks0}}% + }% + \temp +} + +% Take care of unwanted page breaks/skips around a whatsit: +% +% If a skip is the last thing on the list now, preserve it +% by backing up by \lastskip, doing the \write, then inserting +% the skip again. Otherwise, the whatsit generated by the +% \write or \pdfdest will make \lastskip zero. The result is that +% sequences like this: +% @end defun +% @tindex whatever +% @defun ... +% will have extra space inserted, because the \medbreak in the +% start of the @defun won't see the skip inserted by the @end of +% the previous defun. +% +% But don't do any of this if we're not in vertical mode. We +% don't want to do a \vskip and prematurely end a paragraph. +% +% Avoid page breaks due to these extra skips, too. +% +% But wait, there is a catch there: +% We'll have to check whether \lastskip is zero skip. \ifdim is not +% sufficient for this purpose, as it ignores stretch and shrink parts +% of the skip. The only way seems to be to check the textual +% representation of the skip. +% +% The following is almost like \def\zeroskipmacro{0.0pt} except that +% the ``p'' and ``t'' characters have catcode \other, not 11 (letter). +% +\edef\zeroskipmacro{\expandafter\the\csname z@skip\endcsname} +% +\newskip\whatsitskip +\newcount\whatsitpenalty +% +% ..., ready, GO: +% +\def\safewhatsit#1{% +\ifhmode + #1% +\else + % \lastskip and \lastpenalty cannot both be nonzero simultaneously. + \whatsitskip = \lastskip + \edef\lastskipmacro{\the\lastskip}% + \whatsitpenalty = \lastpenalty + % + % If \lastskip is nonzero, that means the last item was a + % skip. And since a skip is discardable, that means this + % -\whatsitskip glue we're inserting is preceded by a + % non-discardable item, therefore it is not a potential + % breakpoint, therefore no \nobreak needed. + \ifx\lastskipmacro\zeroskipmacro + \else + \vskip-\whatsitskip + \fi + % + #1% + % + \ifx\lastskipmacro\zeroskipmacro + % If \lastskip was zero, perhaps the last item was a penalty, and + % perhaps it was >=10000, e.g., a \nobreak. In that case, we want + % to re-insert the same penalty (values >10000 are used for various + % signals); since we just inserted a non-discardable item, any + % following glue (such as a \parskip) would be a breakpoint. For example: + % + % @deffn deffn-whatever + % @vindex index-whatever + % Description. + % would allow a break between the index-whatever whatsit + % and the "Description." paragraph. + \ifnum\whatsitpenalty>9999 \penalty\whatsitpenalty \fi + \else + % On the other hand, if we had a nonzero \lastskip, + % this make-up glue would be preceded by a non-discardable item + % (the whatsit from the \write), so we must insert a \nobreak. + \nobreak\vskip\whatsitskip + \fi +\fi +} + +% The index entry written in the file actually looks like +% \entry {sortstring}{page}{topic} +% or +% \entry {sortstring}{page}{topic}{subtopic} +% The texindex program reads in these files and writes files +% containing these kinds of lines: +% \initial {c} +% before the first topic whose initial is c +% \entry {topic}{pagelist} +% for a topic that is used without subtopics +% \primary {topic} +% for the beginning of a topic that is used with subtopics +% \secondary {subtopic}{pagelist} +% for each subtopic. + +% Define the user-accessible indexing commands +% @findex, @vindex, @kindex, @cindex. + +\def\findex {\fnindex} +\def\kindex {\kyindex} +\def\cindex {\cpindex} +\def\vindex {\vrindex} +\def\tindex {\tpindex} +\def\pindex {\pgindex} + +\def\cindexsub {\begingroup\obeylines\cindexsub} +{\obeylines % +\gdef\cindexsub "#1" #2^^M{\endgroup % +\dosubind{cp}{#2}{#1}}} + +% Define the macros used in formatting output of the sorted index material. + +% @printindex causes a particular index (the ??s file) to get printed. +% It does not print any chapter heading (usually an @unnumbered). +% +\parseargdef\printindex{\begingroup + \dobreak \chapheadingskip{10000}% + % + \smallfonts \rm + \tolerance = 9500 + \plainfrenchspacing + \everypar = {}% don't want the \kern\-parindent from indentation suppression. + % + % See if the index file exists and is nonempty. + % Change catcode of @ here so that if the index file contains + % \initial {@} + % as its first line, TeX doesn't complain about mismatched braces + % (because it thinks @} is a control sequence). + \catcode`\@ = 11 + \openin 1 \jobname.#1s + \ifeof 1 + % \enddoublecolumns gets confused if there is no text in the index, + % and it loses the chapter title and the aux file entries for the + % index. The easiest way to prevent this problem is to make sure + % there is some text. + \putwordIndexNonexistent + \else + % + % If the index file exists but is empty, then \openin leaves \ifeof + % false. We have to make TeX try to read something from the file, so + % it can discover if there is anything in it. + \read 1 to \temp + \ifeof 1 + \putwordIndexIsEmpty + \else + % Index files are almost Texinfo source, but we use \ as the escape + % character. It would be better to use @, but that's too big a change + % to make right now. + \def\indexbackslash{\backslashcurfont}% + \catcode`\\ = 0 + \escapechar = `\\ + \begindoublecolumns + \input \jobname.#1s + \enddoublecolumns + \fi + \fi + \closein 1 +\endgroup} + +% These macros are used by the sorted index file itself. +% Change them to control the appearance of the index. + +\def\initial#1{{% + % Some minor font changes for the special characters. + \let\tentt=\sectt \let\tt=\sectt \let\sf=\sectt + % + % Remove any glue we may have, we'll be inserting our own. + \removelastskip + % + % We like breaks before the index initials, so insert a bonus. + \nobreak + \vskip 0pt plus 3\baselineskip + \penalty 0 + \vskip 0pt plus -3\baselineskip + % + % Typeset the initial. Making this add up to a whole number of + % baselineskips increases the chance of the dots lining up from column + % to column. It still won't often be perfect, because of the stretch + % we need before each entry, but it's better. + % + % No shrink because it confuses \balancecolumns. + \vskip 1.67\baselineskip plus .5\baselineskip + \leftline{\secbf #1}% + % Do our best not to break after the initial. + \nobreak + \vskip .33\baselineskip plus .1\baselineskip +}} + +% \entry typesets a paragraph consisting of the text (#1), dot leaders, and +% then page number (#2) flushed to the right margin. It is used for index +% and table of contents entries. The paragraph is indented by \leftskip. +% +% A straightforward implementation would start like this: +% \def\entry#1#2{... +% But this freezes the catcodes in the argument, and can cause problems to +% @code, which sets - active. This problem was fixed by a kludge--- +% ``-'' was active throughout whole index, but this isn't really right. +% +% The right solution is to prevent \entry from swallowing the whole text. +% --kasal, 21nov03 +\def\entry{% + \begingroup + % + % Start a new paragraph if necessary, so our assignments below can't + % affect previous text. + \par + % + % Do not fill out the last line with white space. + \parfillskip = 0in + % + % No extra space above this paragraph. + \parskip = 0in + % + % Do not prefer a separate line ending with a hyphen to fewer lines. + \finalhyphendemerits = 0 + % + % \hangindent is only relevant when the entry text and page number + % don't both fit on one line. In that case, bob suggests starting the + % dots pretty far over on the line. Unfortunately, a large + % indentation looks wrong when the entry text itself is broken across + % lines. So we use a small indentation and put up with long leaders. + % + % \hangafter is reset to 1 (which is the value we want) at the start + % of each paragraph, so we need not do anything with that. + \hangindent = 2em + % + % When the entry text needs to be broken, just fill out the first line + % with blank space. + \rightskip = 0pt plus1fil + % + % A bit of stretch before each entry for the benefit of balancing + % columns. + \vskip 0pt plus1pt + % + % Swallow the left brace of the text (first parameter): + \afterassignment\doentry + \let\temp = +} +\def\doentry{% + \bgroup % Instead of the swallowed brace. + \noindent + \aftergroup\finishentry + % And now comes the text of the entry. +} +\def\finishentry#1{% + % #1 is the page number. + % + % The following is kludged to not output a line of dots in the index if + % there are no page numbers. The next person who breaks this will be + % cursed by a Unix daemon. + \setbox\boxA = \hbox{#1}% + \ifdim\wd\boxA = 0pt + \ % + \else + % + % If we must, put the page number on a line of its own, and fill out + % this line with blank space. (The \hfil is overwhelmed with the + % fill leaders glue in \indexdotfill if the page number does fit.) + \hfil\penalty50 + \null\nobreak\indexdotfill % Have leaders before the page number. + % + % The `\ ' here is removed by the implicit \unskip that TeX does as + % part of (the primitive) \par. Without it, a spurious underfull + % \hbox ensues. + \ifpdf + \pdfgettoks#1.% + \ \the\toksA + \else + \ #1% + \fi + \fi + \par + \endgroup +} + +% Like plain.tex's \dotfill, except uses up at least 1 em. +\def\indexdotfill{\cleaders + \hbox{$\mathsurround=0pt \mkern1.5mu.\mkern1.5mu$}\hskip 1em plus 1fill} + +\def\primary #1{\line{#1\hfil}} + +\newskip\secondaryindent \secondaryindent=0.5cm +\def\secondary#1#2{{% + \parfillskip=0in + \parskip=0in + \hangindent=1in + \hangafter=1 + \noindent\hskip\secondaryindent\hbox{#1}\indexdotfill + \ifpdf + \pdfgettoks#2.\ \the\toksA % The page number ends the paragraph. + \else + #2 + \fi + \par +}} + +% Define two-column mode, which we use to typeset indexes. +% Adapted from the TeXbook, page 416, which is to say, +% the manmac.tex format used to print the TeXbook itself. +\catcode`\@=11 + +\newbox\partialpage +\newdimen\doublecolumnhsize + +\def\begindoublecolumns{\begingroup % ended by \enddoublecolumns + % Grab any single-column material above us. + \output = {% + % + % Here is a possibility not foreseen in manmac: if we accumulate a + % whole lot of material, we might end up calling this \output + % routine twice in a row (see the doublecol-lose test, which is + % essentially a couple of indexes with @setchapternewpage off). In + % that case we just ship out what is in \partialpage with the normal + % output routine. Generally, \partialpage will be empty when this + % runs and this will be a no-op. See the indexspread.tex test case. + \ifvoid\partialpage \else + \onepageout{\pagecontents\partialpage}% + \fi + % + \global\setbox\partialpage = \vbox{% + % Unvbox the main output page. + \unvbox\PAGE + \kern-\topskip \kern\baselineskip + }% + }% + \eject % run that output routine to set \partialpage + % + % Use the double-column output routine for subsequent pages. + \output = {\doublecolumnout}% + % + % Change the page size parameters. We could do this once outside this + % routine, in each of @smallbook, @afourpaper, and the default 8.5x11 + % format, but then we repeat the same computation. Repeating a couple + % of assignments once per index is clearly meaningless for the + % execution time, so we may as well do it in one place. + % + % First we halve the line length, less a little for the gutter between + % the columns. We compute the gutter based on the line length, so it + % changes automatically with the paper format. The magic constant + % below is chosen so that the gutter has the same value (well, +-<1pt) + % as it did when we hard-coded it. + % + % We put the result in a separate register, \doublecolumhsize, so we + % can restore it in \pagesofar, after \hsize itself has (potentially) + % been clobbered. + % + \doublecolumnhsize = \hsize + \advance\doublecolumnhsize by -.04154\hsize + \divide\doublecolumnhsize by 2 + \hsize = \doublecolumnhsize + % + % Double the \vsize as well. (We don't need a separate register here, + % since nobody clobbers \vsize.) + \vsize = 2\vsize +} + +% The double-column output routine for all double-column pages except +% the last. +% +\def\doublecolumnout{% + \splittopskip=\topskip \splitmaxdepth=\maxdepth + % Get the available space for the double columns -- the normal + % (undoubled) page height minus any material left over from the + % previous page. + \dimen@ = \vsize + \divide\dimen@ by 2 + \advance\dimen@ by -\ht\partialpage + % + % box0 will be the left-hand column, box2 the right. + \setbox0=\vsplit255 to\dimen@ \setbox2=\vsplit255 to\dimen@ + \onepageout\pagesofar + \unvbox255 + \penalty\outputpenalty +} +% +% Re-output the contents of the output page -- any previous material, +% followed by the two boxes we just split, in box0 and box2. +\def\pagesofar{% + \unvbox\partialpage + % + \hsize = \doublecolumnhsize + \wd0=\hsize \wd2=\hsize + \hbox to\pagewidth{\box0\hfil\box2}% +} +% +% All done with double columns. +\def\enddoublecolumns{% + % The following penalty ensures that the page builder is exercised + % _before_ we change the output routine. This is necessary in the + % following situation: + % + % The last section of the index consists only of a single entry. + % Before this section, \pagetotal is less than \pagegoal, so no + % break occurs before the last section starts. However, the last + % section, consisting of \initial and the single \entry, does not + % fit on the page and has to be broken off. Without the following + % penalty the page builder will not be exercised until \eject + % below, and by that time we'll already have changed the output + % routine to the \balancecolumns version, so the next-to-last + % double-column page will be processed with \balancecolumns, which + % is wrong: The two columns will go to the main vertical list, with + % the broken-off section in the recent contributions. As soon as + % the output routine finishes, TeX starts reconsidering the page + % break. The two columns and the broken-off section both fit on the + % page, because the two columns now take up only half of the page + % goal. When TeX sees \eject from below which follows the final + % section, it invokes the new output routine that we've set after + % \balancecolumns below; \onepageout will try to fit the two columns + % and the final section into the vbox of \pageheight (see + % \pagebody), causing an overfull box. + % + % Note that glue won't work here, because glue does not exercise the + % page builder, unlike penalties (see The TeXbook, pp. 280-281). + \penalty0 + % + \output = {% + % Split the last of the double-column material. Leave it on the + % current page, no automatic page break. + \balancecolumns + % + % If we end up splitting too much material for the current page, + % though, there will be another page break right after this \output + % invocation ends. Having called \balancecolumns once, we do not + % want to call it again. Therefore, reset \output to its normal + % definition right away. (We hope \balancecolumns will never be + % called on to balance too much material, but if it is, this makes + % the output somewhat more palatable.) + \global\output = {\onepageout{\pagecontents\PAGE}}% + }% + \eject + \endgroup % started in \begindoublecolumns + % + % \pagegoal was set to the doubled \vsize above, since we restarted + % the current page. We're now back to normal single-column + % typesetting, so reset \pagegoal to the normal \vsize (after the + % \endgroup where \vsize got restored). + \pagegoal = \vsize +} +% +% Called at the end of the double column material. +\def\balancecolumns{% + \setbox0 = \vbox{\unvbox255}% like \box255 but more efficient, see p.120. + \dimen@ = \ht0 + \advance\dimen@ by \topskip + \advance\dimen@ by-\baselineskip + \divide\dimen@ by 2 % target to split to + %debug\message{final 2-column material height=\the\ht0, target=\the\dimen@.}% + \splittopskip = \topskip + % Loop until we get a decent breakpoint. + {% + \vbadness = 10000 + \loop + \global\setbox3 = \copy0 + \global\setbox1 = \vsplit3 to \dimen@ + \ifdim\ht3>\dimen@ + \global\advance\dimen@ by 1pt + \repeat + }% + %debug\message{split to \the\dimen@, column heights: \the\ht1, \the\ht3.}% + \setbox0=\vbox to\dimen@{\unvbox1}% + \setbox2=\vbox to\dimen@{\unvbox3}% + % + \pagesofar +} +\catcode`\@ = \other + + +\message{sectioning,} +% Chapters, sections, etc. + +% \unnumberedno is an oxymoron, of course. But we count the unnumbered +% sections so that we can refer to them unambiguously in the pdf +% outlines by their "section number". We avoid collisions with chapter +% numbers by starting them at 10000. (If a document ever has 10000 +% chapters, we're in trouble anyway, I'm sure.) +\newcount\unnumberedno \unnumberedno = 10000 +\newcount\chapno +\newcount\secno \secno=0 +\newcount\subsecno \subsecno=0 +\newcount\subsubsecno \subsubsecno=0 + +% This counter is funny since it counts through charcodes of letters A, B, ... +\newcount\appendixno \appendixno = `\@ +% +% \def\appendixletter{\char\the\appendixno} +% We do the following ugly conditional instead of the above simple +% construct for the sake of pdftex, which needs the actual +% letter in the expansion, not just typeset. +% +\def\appendixletter{% + \ifnum\appendixno=`A A% + \else\ifnum\appendixno=`B B% + \else\ifnum\appendixno=`C C% + \else\ifnum\appendixno=`D D% + \else\ifnum\appendixno=`E E% + \else\ifnum\appendixno=`F F% + \else\ifnum\appendixno=`G G% + \else\ifnum\appendixno=`H H% + \else\ifnum\appendixno=`I I% + \else\ifnum\appendixno=`J J% + \else\ifnum\appendixno=`K K% + \else\ifnum\appendixno=`L L% + \else\ifnum\appendixno=`M M% + \else\ifnum\appendixno=`N N% + \else\ifnum\appendixno=`O O% + \else\ifnum\appendixno=`P P% + \else\ifnum\appendixno=`Q Q% + \else\ifnum\appendixno=`R R% + \else\ifnum\appendixno=`S S% + \else\ifnum\appendixno=`T T% + \else\ifnum\appendixno=`U U% + \else\ifnum\appendixno=`V V% + \else\ifnum\appendixno=`W W% + \else\ifnum\appendixno=`X X% + \else\ifnum\appendixno=`Y Y% + \else\ifnum\appendixno=`Z Z% + % The \the is necessary, despite appearances, because \appendixletter is + % expanded while writing the .toc file. \char\appendixno is not + % expandable, thus it is written literally, thus all appendixes come out + % with the same letter (or @) in the toc without it. + \else\char\the\appendixno + \fi\fi\fi\fi\fi\fi\fi\fi\fi\fi\fi\fi\fi + \fi\fi\fi\fi\fi\fi\fi\fi\fi\fi\fi\fi\fi} + +% Each @chapter defines these (using marks) as the number+name, number +% and name of the chapter. Page headings and footings can use +% these. @section does likewise. +\def\thischapter{} +\def\thischapternum{} +\def\thischaptername{} +\def\thissection{} +\def\thissectionnum{} +\def\thissectionname{} + +\newcount\absseclevel % used to calculate proper heading level +\newcount\secbase\secbase=0 % @raisesections/@lowersections modify this count + +% @raisesections: treat @section as chapter, @subsection as section, etc. +\def\raisesections{\global\advance\secbase by -1} +\let\up=\raisesections % original BFox name + +% @lowersections: treat @chapter as section, @section as subsection, etc. +\def\lowersections{\global\advance\secbase by 1} +\let\down=\lowersections % original BFox name + +% we only have subsub. +\chardef\maxseclevel = 3 +% +% A numbered section within an unnumbered changes to unnumbered too. +% To achive this, remember the "biggest" unnum. sec. we are currently in: +\chardef\unmlevel = \maxseclevel +% +% Trace whether the current chapter is an appendix or not: +% \chapheadtype is "N" or "A", unnumbered chapters are ignored. +\def\chapheadtype{N} + +% Choose a heading macro +% #1 is heading type +% #2 is heading level +% #3 is text for heading +\def\genhead#1#2#3{% + % Compute the abs. sec. level: + \absseclevel=#2 + \advance\absseclevel by \secbase + % Make sure \absseclevel doesn't fall outside the range: + \ifnum \absseclevel < 0 + \absseclevel = 0 + \else + \ifnum \absseclevel > 3 + \absseclevel = 3 + \fi + \fi + % The heading type: + \def\headtype{#1}% + \if \headtype U% + \ifnum \absseclevel < \unmlevel + \chardef\unmlevel = \absseclevel + \fi + \else + % Check for appendix sections: + \ifnum \absseclevel = 0 + \edef\chapheadtype{\headtype}% + \else + \if \headtype A\if \chapheadtype N% + \errmessage{@appendix... within a non-appendix chapter}% + \fi\fi + \fi + % Check for numbered within unnumbered: + \ifnum \absseclevel > \unmlevel + \def\headtype{U}% + \else + \chardef\unmlevel = 3 + \fi + \fi + % Now print the heading: + \if \headtype U% + \ifcase\absseclevel + \unnumberedzzz{#3}% + \or \unnumberedseczzz{#3}% + \or \unnumberedsubseczzz{#3}% + \or \unnumberedsubsubseczzz{#3}% + \fi + \else + \if \headtype A% + \ifcase\absseclevel + \appendixzzz{#3}% + \or \appendixsectionzzz{#3}% + \or \appendixsubseczzz{#3}% + \or \appendixsubsubseczzz{#3}% + \fi + \else + \ifcase\absseclevel + \chapterzzz{#3}% + \or \seczzz{#3}% + \or \numberedsubseczzz{#3}% + \or \numberedsubsubseczzz{#3}% + \fi + \fi + \fi + \suppressfirstparagraphindent +} + +% an interface: +\def\numhead{\genhead N} +\def\apphead{\genhead A} +\def\unnmhead{\genhead U} + +% @chapter, @appendix, @unnumbered. Increment top-level counter, reset +% all lower-level sectioning counters to zero. +% +% Also set \chaplevelprefix, which we prepend to @float sequence numbers +% (e.g., figures), q.v. By default (before any chapter), that is empty. +\let\chaplevelprefix = \empty +% +\outer\parseargdef\chapter{\numhead0{#1}} % normally numhead0 calls chapterzzz +\def\chapterzzz#1{% + % section resetting is \global in case the chapter is in a group, such + % as an @include file. + \global\secno=0 \global\subsecno=0 \global\subsubsecno=0 + \global\advance\chapno by 1 + % + % Used for \float. + \gdef\chaplevelprefix{\the\chapno.}% + \resetallfloatnos + % + % \putwordChapter can contain complex things in translations. + \toks0=\expandafter{\putwordChapter}% + \message{\the\toks0 \space \the\chapno}% + % + % Write the actual heading. + \chapmacro{#1}{Ynumbered}{\the\chapno}% + % + % So @section and the like are numbered underneath this chapter. + \global\let\section = \numberedsec + \global\let\subsection = \numberedsubsec + \global\let\subsubsection = \numberedsubsubsec +} + +\outer\parseargdef\appendix{\apphead0{#1}} % normally calls appendixzzz +% +\def\appendixzzz#1{% + \global\secno=0 \global\subsecno=0 \global\subsubsecno=0 + \global\advance\appendixno by 1 + \gdef\chaplevelprefix{\appendixletter.}% + \resetallfloatnos + % + % \putwordAppendix can contain complex things in translations. + \toks0=\expandafter{\putwordAppendix}% + \message{\the\toks0 \space \appendixletter}% + % + \chapmacro{#1}{Yappendix}{\appendixletter}% + % + \global\let\section = \appendixsec + \global\let\subsection = \appendixsubsec + \global\let\subsubsection = \appendixsubsubsec +} + +\outer\parseargdef\unnumbered{\unnmhead0{#1}} % normally unnmhead0 calls unnumberedzzz +\def\unnumberedzzz#1{% + \global\secno=0 \global\subsecno=0 \global\subsubsecno=0 + \global\advance\unnumberedno by 1 + % + % Since an unnumbered has no number, no prefix for figures. + \global\let\chaplevelprefix = \empty + \resetallfloatnos + % + % This used to be simply \message{#1}, but TeX fully expands the + % argument to \message. Therefore, if #1 contained @-commands, TeX + % expanded them. For example, in `@unnumbered The @cite{Book}', TeX + % expanded @cite (which turns out to cause errors because \cite is meant + % to be executed, not expanded). + % + % Anyway, we don't want the fully-expanded definition of @cite to appear + % as a result of the \message, we just want `@cite' itself. We use + % \the to achieve this: TeX expands \the only once, + % simply yielding the contents of . (We also do this for + % the toc entries.) + \toks0 = {#1}% + \message{(\the\toks0)}% + % + \chapmacro{#1}{Ynothing}{\the\unnumberedno}% + % + \global\let\section = \unnumberedsec + \global\let\subsection = \unnumberedsubsec + \global\let\subsubsection = \unnumberedsubsubsec +} + +% @centerchap is like @unnumbered, but the heading is centered. +\outer\parseargdef\centerchap{% + % Well, we could do the following in a group, but that would break + % an assumption that \chapmacro is called at the outermost level. + % Thus we are safer this way: --kasal, 24feb04 + \let\centerparametersmaybe = \centerparameters + \unnmhead0{#1}% + \let\centerparametersmaybe = \relax +} + +% @top is like @unnumbered. +\let\top\unnumbered + +% Sections. +\outer\parseargdef\numberedsec{\numhead1{#1}} % normally calls seczzz +\def\seczzz#1{% + \global\subsecno=0 \global\subsubsecno=0 \global\advance\secno by 1 + \sectionheading{#1}{sec}{Ynumbered}{\the\chapno.\the\secno}% +} + +\outer\parseargdef\appendixsection{\apphead1{#1}} % normally calls appendixsectionzzz +\def\appendixsectionzzz#1{% + \global\subsecno=0 \global\subsubsecno=0 \global\advance\secno by 1 + \sectionheading{#1}{sec}{Yappendix}{\appendixletter.\the\secno}% +} +\let\appendixsec\appendixsection + +\outer\parseargdef\unnumberedsec{\unnmhead1{#1}} % normally calls unnumberedseczzz +\def\unnumberedseczzz#1{% + \global\subsecno=0 \global\subsubsecno=0 \global\advance\secno by 1 + \sectionheading{#1}{sec}{Ynothing}{\the\unnumberedno.\the\secno}% +} + +% Subsections. +\outer\parseargdef\numberedsubsec{\numhead2{#1}} % normally calls numberedsubseczzz +\def\numberedsubseczzz#1{% + \global\subsubsecno=0 \global\advance\subsecno by 1 + \sectionheading{#1}{subsec}{Ynumbered}{\the\chapno.\the\secno.\the\subsecno}% +} + +\outer\parseargdef\appendixsubsec{\apphead2{#1}} % normally calls appendixsubseczzz +\def\appendixsubseczzz#1{% + \global\subsubsecno=0 \global\advance\subsecno by 1 + \sectionheading{#1}{subsec}{Yappendix}% + {\appendixletter.\the\secno.\the\subsecno}% +} + +\outer\parseargdef\unnumberedsubsec{\unnmhead2{#1}} %normally calls unnumberedsubseczzz +\def\unnumberedsubseczzz#1{% + \global\subsubsecno=0 \global\advance\subsecno by 1 + \sectionheading{#1}{subsec}{Ynothing}% + {\the\unnumberedno.\the\secno.\the\subsecno}% +} + +% Subsubsections. +\outer\parseargdef\numberedsubsubsec{\numhead3{#1}} % normally numberedsubsubseczzz +\def\numberedsubsubseczzz#1{% + \global\advance\subsubsecno by 1 + \sectionheading{#1}{subsubsec}{Ynumbered}% + {\the\chapno.\the\secno.\the\subsecno.\the\subsubsecno}% +} + +\outer\parseargdef\appendixsubsubsec{\apphead3{#1}} % normally appendixsubsubseczzz +\def\appendixsubsubseczzz#1{% + \global\advance\subsubsecno by 1 + \sectionheading{#1}{subsubsec}{Yappendix}% + {\appendixletter.\the\secno.\the\subsecno.\the\subsubsecno}% +} + +\outer\parseargdef\unnumberedsubsubsec{\unnmhead3{#1}} %normally unnumberedsubsubseczzz +\def\unnumberedsubsubseczzz#1{% + \global\advance\subsubsecno by 1 + \sectionheading{#1}{subsubsec}{Ynothing}% + {\the\unnumberedno.\the\secno.\the\subsecno.\the\subsubsecno}% +} + +% These macros control what the section commands do, according +% to what kind of chapter we are in (ordinary, appendix, or unnumbered). +% Define them by default for a numbered chapter. +\let\section = \numberedsec +\let\subsection = \numberedsubsec +\let\subsubsection = \numberedsubsubsec + +% Define @majorheading, @heading and @subheading + +% NOTE on use of \vbox for chapter headings, section headings, and such: +% 1) We use \vbox rather than the earlier \line to permit +% overlong headings to fold. +% 2) \hyphenpenalty is set to 10000 because hyphenation in a +% heading is obnoxious; this forbids it. +% 3) Likewise, headings look best if no \parindent is used, and +% if justification is not attempted. Hence \raggedright. + +\def\majorheading{% + {\advance\chapheadingskip by 10pt \chapbreak }% + \parsearg\chapheadingzzz +} + +\def\chapheading{\chapbreak \parsearg\chapheadingzzz} +\def\chapheadingzzz#1{% + {\chapfonts \vbox{\hyphenpenalty=10000\tolerance=5000 + \parindent=0pt\ptexraggedright + \rmisbold #1\hfill}}% + \bigskip \par\penalty 200\relax + \suppressfirstparagraphindent +} + +% @heading, @subheading, @subsubheading. +\parseargdef\heading{\sectionheading{#1}{sec}{Yomitfromtoc}{} + \suppressfirstparagraphindent} +\parseargdef\subheading{\sectionheading{#1}{subsec}{Yomitfromtoc}{} + \suppressfirstparagraphindent} +\parseargdef\subsubheading{\sectionheading{#1}{subsubsec}{Yomitfromtoc}{} + \suppressfirstparagraphindent} + +% These macros generate a chapter, section, etc. heading only +% (including whitespace, linebreaking, etc. around it), +% given all the information in convenient, parsed form. + +%%% Args are the skip and penalty (usually negative) +\def\dobreak#1#2{\par\ifdim\lastskip<#1\removelastskip\penalty#2\vskip#1\fi} + +%%% Define plain chapter starts, and page on/off switching for it +% Parameter controlling skip before chapter headings (if needed) + +\newskip\chapheadingskip + +\def\chapbreak{\dobreak \chapheadingskip {-4000}} +\def\chappager{\par\vfill\supereject} +% Because \domark is called before \chapoddpage, the filler page will +% get the headings for the next chapter, which is wrong. But we don't +% care -- we just disable all headings on the filler page. +\def\chapoddpage{% + \chappager + \ifodd\pageno \else + \begingroup + \evenheadline={\hfil}\evenfootline={\hfil}% + \oddheadline={\hfil}\oddfootline={\hfil}% + \hbox to 0pt{}% + \chappager + \endgroup + \fi +} + +\def\setchapternewpage #1 {\csname CHAPPAG#1\endcsname} + +\def\CHAPPAGoff{% +\global\let\contentsalignmacro = \chappager +\global\let\pchapsepmacro=\chapbreak +\global\let\pagealignmacro=\chappager} + +\def\CHAPPAGon{% +\global\let\contentsalignmacro = \chappager +\global\let\pchapsepmacro=\chappager +\global\let\pagealignmacro=\chappager +\global\def\HEADINGSon{\HEADINGSsingle}} + +\def\CHAPPAGodd{% +\global\let\contentsalignmacro = \chapoddpage +\global\let\pchapsepmacro=\chapoddpage +\global\let\pagealignmacro=\chapoddpage +\global\def\HEADINGSon{\HEADINGSdouble}} + +\CHAPPAGon + +% Chapter opening. +% +% #1 is the text, #2 is the section type (Ynumbered, Ynothing, +% Yappendix, Yomitfromtoc), #3 the chapter number. +% +% To test against our argument. +\def\Ynothingkeyword{Ynothing} +\def\Yomitfromtockeyword{Yomitfromtoc} +\def\Yappendixkeyword{Yappendix} +% +\def\chapmacro#1#2#3{% + % Insert the first mark before the heading break (see notes for \domark). + \let\prevchapterdefs=\lastchapterdefs + \let\prevsectiondefs=\lastsectiondefs + \gdef\lastsectiondefs{\gdef\thissectionname{}\gdef\thissectionnum{}% + \gdef\thissection{}}% + % + \def\temptype{#2}% + \ifx\temptype\Ynothingkeyword + \gdef\lastchapterdefs{\gdef\thischaptername{#1}\gdef\thischapternum{}% + \gdef\thischapter{\thischaptername}}% + \else\ifx\temptype\Yomitfromtockeyword + \gdef\lastchapterdefs{\gdef\thischaptername{#1}\gdef\thischapternum{}% + \gdef\thischapter{}}% + \else\ifx\temptype\Yappendixkeyword + \toks0={#1}% + \xdef\lastchapterdefs{% + \gdef\noexpand\thischaptername{\the\toks0}% + \gdef\noexpand\thischapternum{\appendixletter}% + % \noexpand\putwordAppendix avoids expanding indigestible + % commands in some of the translations. + \gdef\noexpand\thischapter{\noexpand\putwordAppendix{} + \noexpand\thischapternum: + \noexpand\thischaptername}% + }% + \else + \toks0={#1}% + \xdef\lastchapterdefs{% + \gdef\noexpand\thischaptername{\the\toks0}% + \gdef\noexpand\thischapternum{\the\chapno}% + % \noexpand\putwordChapter avoids expanding indigestible + % commands in some of the translations. + \gdef\noexpand\thischapter{\noexpand\putwordChapter{} + \noexpand\thischapternum: + \noexpand\thischaptername}% + }% + \fi\fi\fi + % + % Output the mark. Pass it through \safewhatsit, to take care of + % the preceding space. + \safewhatsit\domark + % + % Insert the chapter heading break. + \pchapsepmacro + % + % Now the second mark, after the heading break. No break points + % between here and the heading. + \let\prevchapterdefs=\lastchapterdefs + \let\prevsectiondefs=\lastsectiondefs + \domark + % + {% + \chapfonts \rmisbold + % + % Have to define \lastsection before calling \donoderef, because the + % xref code eventually uses it. On the other hand, it has to be called + % after \pchapsepmacro, or the headline will change too soon. + \gdef\lastsection{#1}% + % + % Only insert the separating space if we have a chapter/appendix + % number, and don't print the unnumbered ``number''. + \ifx\temptype\Ynothingkeyword + \setbox0 = \hbox{}% + \def\toctype{unnchap}% + \else\ifx\temptype\Yomitfromtockeyword + \setbox0 = \hbox{}% contents like unnumbered, but no toc entry + \def\toctype{omit}% + \else\ifx\temptype\Yappendixkeyword + \setbox0 = \hbox{\putwordAppendix{} #3\enspace}% + \def\toctype{app}% + \else + \setbox0 = \hbox{#3\enspace}% + \def\toctype{numchap}% + \fi\fi\fi + % + % Write the toc entry for this chapter. Must come before the + % \donoderef, because we include the current node name in the toc + % entry, and \donoderef resets it to empty. + \writetocentry{\toctype}{#1}{#3}% + % + % For pdftex, we have to write out the node definition (aka, make + % the pdfdest) after any page break, but before the actual text has + % been typeset. If the destination for the pdf outline is after the + % text, then jumping from the outline may wind up with the text not + % being visible, for instance under high magnification. + \donoderef{#2}% + % + % Typeset the actual heading. + \nobreak % Avoid page breaks at the interline glue. + \vbox{\hyphenpenalty=10000 \tolerance=5000 \parindent=0pt \ptexraggedright + \hangindent=\wd0 \centerparametersmaybe + \unhbox0 #1\par}% + }% + \nobreak\bigskip % no page break after a chapter title + \nobreak +} + +% @centerchap -- centered and unnumbered. +\let\centerparametersmaybe = \relax +\def\centerparameters{% + \advance\rightskip by 3\rightskip + \leftskip = \rightskip + \parfillskip = 0pt +} + + +% I don't think this chapter style is supported any more, so I'm not +% updating it with the new noderef stuff. We'll see. --karl, 11aug03. +% +\def\setchapterstyle #1 {\csname CHAPF#1\endcsname} +% +\def\unnchfopen #1{% +\chapoddpage {\chapfonts \vbox{\hyphenpenalty=10000\tolerance=5000 + \parindent=0pt\ptexraggedright + \rmisbold #1\hfill}}\bigskip \par\nobreak +} +\def\chfopen #1#2{\chapoddpage {\chapfonts +\vbox to 3in{\vfil \hbox to\hsize{\hfil #2} \hbox to\hsize{\hfil #1} \vfil}}% +\par\penalty 5000 % +} +\def\centerchfopen #1{% +\chapoddpage {\chapfonts \vbox{\hyphenpenalty=10000\tolerance=5000 + \parindent=0pt + \hfill {\rmisbold #1}\hfill}}\bigskip \par\nobreak +} +\def\CHAPFopen{% + \global\let\chapmacro=\chfopen + \global\let\centerchapmacro=\centerchfopen} + + +% Section titles. These macros combine the section number parts and +% call the generic \sectionheading to do the printing. +% +\newskip\secheadingskip +\def\secheadingbreak{\dobreak \secheadingskip{-1000}} + +% Subsection titles. +\newskip\subsecheadingskip +\def\subsecheadingbreak{\dobreak \subsecheadingskip{-500}} + +% Subsubsection titles. +\def\subsubsecheadingskip{\subsecheadingskip} +\def\subsubsecheadingbreak{\subsecheadingbreak} + + +% Print any size, any type, section title. +% +% #1 is the text, #2 is the section level (sec/subsec/subsubsec), #3 is +% the section type for xrefs (Ynumbered, Ynothing, Yappendix), #4 is the +% section number. +% +\def\seckeyword{sec} +% +\def\sectionheading#1#2#3#4{% + {% + % Switch to the right set of fonts. + \csname #2fonts\endcsname \rmisbold + % + \def\sectionlevel{#2}% + \def\temptype{#3}% + % + % Insert first mark before the heading break (see notes for \domark). + \let\prevsectiondefs=\lastsectiondefs + \ifx\temptype\Ynothingkeyword + \ifx\sectionlevel\seckeyword + \gdef\lastsectiondefs{\gdef\thissectionname{#1}\gdef\thissectionnum{}% + \gdef\thissection{\thissectionname}}% + \fi + \else\ifx\temptype\Yomitfromtockeyword + % Don't redefine \thissection. + \else\ifx\temptype\Yappendixkeyword + \ifx\sectionlevel\seckeyword + \toks0={#1}% + \xdef\lastsectiondefs{% + \gdef\noexpand\thissectionname{\the\toks0}% + \gdef\noexpand\thissectionnum{#4}% + % \noexpand\putwordSection avoids expanding indigestible + % commands in some of the translations. + \gdef\noexpand\thissection{\noexpand\putwordSection{} + \noexpand\thissectionnum: + \noexpand\thissectionname}% + }% + \fi + \else + \ifx\sectionlevel\seckeyword + \toks0={#1}% + \xdef\lastsectiondefs{% + \gdef\noexpand\thissectionname{\the\toks0}% + \gdef\noexpand\thissectionnum{#4}% + % \noexpand\putwordSection avoids expanding indigestible + % commands in some of the translations. + \gdef\noexpand\thissection{\noexpand\putwordSection{} + \noexpand\thissectionnum: + \noexpand\thissectionname}% + }% + \fi + \fi\fi\fi + % + % Go into vertical mode. Usually we'll already be there, but we + % don't want the following whatsit to end up in a preceding paragraph + % if the document didn't happen to have a blank line. + \par + % + % Output the mark. Pass it through \safewhatsit, to take care of + % the preceding space. + \safewhatsit\domark + % + % Insert space above the heading. + \csname #2headingbreak\endcsname + % + % Now the second mark, after the heading break. No break points + % between here and the heading. + \let\prevsectiondefs=\lastsectiondefs + \domark + % + % Only insert the space after the number if we have a section number. + \ifx\temptype\Ynothingkeyword + \setbox0 = \hbox{}% + \def\toctype{unn}% + \gdef\lastsection{#1}% + \else\ifx\temptype\Yomitfromtockeyword + % for @headings -- no section number, don't include in toc, + % and don't redefine \lastsection. + \setbox0 = \hbox{}% + \def\toctype{omit}% + \let\sectionlevel=\empty + \else\ifx\temptype\Yappendixkeyword + \setbox0 = \hbox{#4\enspace}% + \def\toctype{app}% + \gdef\lastsection{#1}% + \else + \setbox0 = \hbox{#4\enspace}% + \def\toctype{num}% + \gdef\lastsection{#1}% + \fi\fi\fi + % + % Write the toc entry (before \donoderef). See comments in \chapmacro. + \writetocentry{\toctype\sectionlevel}{#1}{#4}% + % + % Write the node reference (= pdf destination for pdftex). + % Again, see comments in \chapmacro. + \donoderef{#3}% + % + % Interline glue will be inserted when the vbox is completed. + % That glue will be a valid breakpoint for the page, since it'll be + % preceded by a whatsit (usually from the \donoderef, or from the + % \writetocentry if there was no node). We don't want to allow that + % break, since then the whatsits could end up on page n while the + % section is on page n+1, thus toc/etc. are wrong. Debian bug 276000. + \nobreak + % + % Output the actual section heading. + \vbox{\hyphenpenalty=10000 \tolerance=5000 \parindent=0pt \ptexraggedright + \hangindent=\wd0 % zero if no section number + \unhbox0 #1}% + }% + % Add extra space after the heading -- half of whatever came above it. + % Don't allow stretch, though. + \kern .5 \csname #2headingskip\endcsname + % + % Do not let the kern be a potential breakpoint, as it would be if it + % was followed by glue. + \nobreak + % + % We'll almost certainly start a paragraph next, so don't let that + % glue accumulate. (Not a breakpoint because it's preceded by a + % discardable item.) + \vskip-\parskip + % + % This is purely so the last item on the list is a known \penalty > + % 10000. This is so \startdefun can avoid allowing breakpoints after + % section headings. Otherwise, it would insert a valid breakpoint between: + % + % @section sec-whatever + % @deffn def-whatever + \penalty 10001 +} + + +\message{toc,} +% Table of contents. +\newwrite\tocfile + +% Write an entry to the toc file, opening it if necessary. +% Called from @chapter, etc. +% +% Example usage: \writetocentry{sec}{Section Name}{\the\chapno.\the\secno} +% We append the current node name (if any) and page number as additional +% arguments for the \{chap,sec,...}entry macros which will eventually +% read this. The node name is used in the pdf outlines as the +% destination to jump to. +% +% We open the .toc file for writing here instead of at @setfilename (or +% any other fixed time) so that @contents can be anywhere in the document. +% But if #1 is `omit', then we don't do anything. This is used for the +% table of contents chapter openings themselves. +% +\newif\iftocfileopened +\def\omitkeyword{omit}% +% +\def\writetocentry#1#2#3{% + \edef\writetoctype{#1}% + \ifx\writetoctype\omitkeyword \else + \iftocfileopened\else + \immediate\openout\tocfile = \jobname.toc + \global\tocfileopenedtrue + \fi + % + \iflinks + {\atdummies + \edef\temp{% + \write\tocfile{@#1entry{#2}{#3}{\lastnode}{\noexpand\folio}}}% + \temp + }% + \fi + \fi + % + % Tell \shipout to create a pdf destination on each page, if we're + % writing pdf. These are used in the table of contents. We can't + % just write one on every page because the title pages are numbered + % 1 and 2 (the page numbers aren't printed), and so are the first + % two pages of the document. Thus, we'd have two destinations named + % `1', and two named `2'. + \ifpdf \global\pdfmakepagedesttrue \fi +} + + +% These characters do not print properly in the Computer Modern roman +% fonts, so we must take special care. This is more or less redundant +% with the Texinfo input format setup at the end of this file. +% +\def\activecatcodes{% + \catcode`\"=\active + \catcode`\$=\active + \catcode`\<=\active + \catcode`\>=\active + \catcode`\\=\active + \catcode`\^=\active + \catcode`\_=\active + \catcode`\|=\active + \catcode`\~=\active +} + + +% Read the toc file, which is essentially Texinfo input. +\def\readtocfile{% + \setupdatafile + \activecatcodes + \input \tocreadfilename +} + +\newskip\contentsrightmargin \contentsrightmargin=1in +\newcount\savepageno +\newcount\lastnegativepageno \lastnegativepageno = -1 + +% Prepare to read what we've written to \tocfile. +% +\def\startcontents#1{% + % If @setchapternewpage on, and @headings double, the contents should + % start on an odd page, unlike chapters. Thus, we maintain + % \contentsalignmacro in parallel with \pagealignmacro. + % From: Torbjorn Granlund + \contentsalignmacro + \immediate\closeout\tocfile + % + % Don't need to put `Contents' or `Short Contents' in the headline. + % It is abundantly clear what they are. + \chapmacro{#1}{Yomitfromtoc}{}% + % + \savepageno = \pageno + \begingroup % Set up to handle contents files properly. + \raggedbottom % Worry more about breakpoints than the bottom. + \advance\hsize by -\contentsrightmargin % Don't use the full line length. + % + % Roman numerals for page numbers. + \ifnum \pageno>0 \global\pageno = \lastnegativepageno \fi +} + +% redefined for the two-volume lispref. We always output on +% \jobname.toc even if this is redefined. +% +\def\tocreadfilename{\jobname.toc} + +% Normal (long) toc. +% +\def\contents{% + \startcontents{\putwordTOC}% + \openin 1 \tocreadfilename\space + \ifeof 1 \else + \readtocfile + \fi + \vfill \eject + \contentsalignmacro % in case @setchapternewpage odd is in effect + \ifeof 1 \else + \pdfmakeoutlines + \fi + \closein 1 + \endgroup + \lastnegativepageno = \pageno + \global\pageno = \savepageno +} + +% And just the chapters. +\def\summarycontents{% + \startcontents{\putwordShortTOC}% + % + \let\numchapentry = \shortchapentry + \let\appentry = \shortchapentry + \let\unnchapentry = \shortunnchapentry + % We want a true roman here for the page numbers. + \secfonts + \let\rm=\shortcontrm \let\bf=\shortcontbf + \let\sl=\shortcontsl \let\tt=\shortconttt + \rm + \hyphenpenalty = 10000 + \advance\baselineskip by 1pt % Open it up a little. + \def\numsecentry##1##2##3##4{} + \let\appsecentry = \numsecentry + \let\unnsecentry = \numsecentry + \let\numsubsecentry = \numsecentry + \let\appsubsecentry = \numsecentry + \let\unnsubsecentry = \numsecentry + \let\numsubsubsecentry = \numsecentry + \let\appsubsubsecentry = \numsecentry + \let\unnsubsubsecentry = \numsecentry + \openin 1 \tocreadfilename\space + \ifeof 1 \else + \readtocfile + \fi + \closein 1 + \vfill \eject + \contentsalignmacro % in case @setchapternewpage odd is in effect + \endgroup + \lastnegativepageno = \pageno + \global\pageno = \savepageno +} +\let\shortcontents = \summarycontents + +% Typeset the label for a chapter or appendix for the short contents. +% The arg is, e.g., `A' for an appendix, or `3' for a chapter. +% +\def\shortchaplabel#1{% + % This space should be enough, since a single number is .5em, and the + % widest letter (M) is 1em, at least in the Computer Modern fonts. + % But use \hss just in case. + % (This space doesn't include the extra space that gets added after + % the label; that gets put in by \shortchapentry above.) + % + % We'd like to right-justify chapter numbers, but that looks strange + % with appendix letters. And right-justifying numbers and + % left-justifying letters looks strange when there is less than 10 + % chapters. Have to read the whole toc once to know how many chapters + % there are before deciding ... + \hbox to 1em{#1\hss}% +} + +% These macros generate individual entries in the table of contents. +% The first argument is the chapter or section name. +% The last argument is the page number. +% The arguments in between are the chapter number, section number, ... + +% Chapters, in the main contents. +\def\numchapentry#1#2#3#4{\dochapentry{#2\labelspace#1}{#4}} +% +% Chapters, in the short toc. +% See comments in \dochapentry re vbox and related settings. +\def\shortchapentry#1#2#3#4{% + \tocentry{\shortchaplabel{#2}\labelspace #1}{\doshortpageno\bgroup#4\egroup}% +} + +% Appendices, in the main contents. +% Need the word Appendix, and a fixed-size box. +% +\def\appendixbox#1{% + % We use M since it's probably the widest letter. + \setbox0 = \hbox{\putwordAppendix{} M}% + \hbox to \wd0{\putwordAppendix{} #1\hss}} +% +\def\appentry#1#2#3#4{\dochapentry{\appendixbox{#2}\labelspace#1}{#4}} + +% Unnumbered chapters. +\def\unnchapentry#1#2#3#4{\dochapentry{#1}{#4}} +\def\shortunnchapentry#1#2#3#4{\tocentry{#1}{\doshortpageno\bgroup#4\egroup}} + +% Sections. +\def\numsecentry#1#2#3#4{\dosecentry{#2\labelspace#1}{#4}} +\let\appsecentry=\numsecentry +\def\unnsecentry#1#2#3#4{\dosecentry{#1}{#4}} + +% Subsections. +\def\numsubsecentry#1#2#3#4{\dosubsecentry{#2\labelspace#1}{#4}} +\let\appsubsecentry=\numsubsecentry +\def\unnsubsecentry#1#2#3#4{\dosubsecentry{#1}{#4}} + +% And subsubsections. +\def\numsubsubsecentry#1#2#3#4{\dosubsubsecentry{#2\labelspace#1}{#4}} +\let\appsubsubsecentry=\numsubsubsecentry +\def\unnsubsubsecentry#1#2#3#4{\dosubsubsecentry{#1}{#4}} + +% This parameter controls the indentation of the various levels. +% Same as \defaultparindent. +\newdimen\tocindent \tocindent = 15pt + +% Now for the actual typesetting. In all these, #1 is the text and #2 is the +% page number. +% +% If the toc has to be broken over pages, we want it to be at chapters +% if at all possible; hence the \penalty. +\def\dochapentry#1#2{% + \penalty-300 \vskip1\baselineskip plus.33\baselineskip minus.25\baselineskip + \begingroup + \chapentryfonts + \tocentry{#1}{\dopageno\bgroup#2\egroup}% + \endgroup + \nobreak\vskip .25\baselineskip plus.1\baselineskip +} + +\def\dosecentry#1#2{\begingroup + \secentryfonts \leftskip=\tocindent + \tocentry{#1}{\dopageno\bgroup#2\egroup}% +\endgroup} + +\def\dosubsecentry#1#2{\begingroup + \subsecentryfonts \leftskip=2\tocindent + \tocentry{#1}{\dopageno\bgroup#2\egroup}% +\endgroup} + +\def\dosubsubsecentry#1#2{\begingroup + \subsubsecentryfonts \leftskip=3\tocindent + \tocentry{#1}{\dopageno\bgroup#2\egroup}% +\endgroup} + +% We use the same \entry macro as for the index entries. +\let\tocentry = \entry + +% Space between chapter (or whatever) number and the title. +\def\labelspace{\hskip1em \relax} + +\def\dopageno#1{{\rm #1}} +\def\doshortpageno#1{{\rm #1}} + +\def\chapentryfonts{\secfonts \rm} +\def\secentryfonts{\textfonts} +\def\subsecentryfonts{\textfonts} +\def\subsubsecentryfonts{\textfonts} + + +\message{environments,} +% @foo ... @end foo. + +% @tex ... @end tex escapes into raw Tex temporarily. +% One exception: @ is still an escape character, so that @end tex works. +% But \@ or @@ will get a plain tex @ character. + +\envdef\tex{% + \setupmarkupstyle{tex}% + \catcode `\\=0 \catcode `\{=1 \catcode `\}=2 + \catcode `\$=3 \catcode `\&=4 \catcode `\#=6 + \catcode `\^=7 \catcode `\_=8 \catcode `\~=\active \let~=\tie + \catcode `\%=14 + \catcode `\+=\other + \catcode `\"=\other + \catcode `\|=\other + \catcode `\<=\other + \catcode `\>=\other + \catcode`\`=\other + \catcode`\'=\other + \escapechar=`\\ + % + \let\b=\ptexb + \let\bullet=\ptexbullet + \let\c=\ptexc + \let\,=\ptexcomma + \let\.=\ptexdot + \let\dots=\ptexdots + \let\equiv=\ptexequiv + \let\!=\ptexexclam + \let\i=\ptexi + \let\indent=\ptexindent + \let\noindent=\ptexnoindent + \let\{=\ptexlbrace + \let\+=\tabalign + \let\}=\ptexrbrace + \let\/=\ptexslash + \let\*=\ptexstar + \let\t=\ptext + \expandafter \let\csname top\endcsname=\ptextop % outer + \let\frenchspacing=\plainfrenchspacing + % + \def\endldots{\mathinner{\ldots\ldots\ldots\ldots}}% + \def\enddots{\relax\ifmmode\endldots\else$\mathsurround=0pt \endldots\,$\fi}% + \def\@{@}% +} +% There is no need to define \Etex. + +% Define @lisp ... @end lisp. +% @lisp environment forms a group so it can rebind things, +% including the definition of @end lisp (which normally is erroneous). + +% Amount to narrow the margins by for @lisp. +\newskip\lispnarrowing \lispnarrowing=0.4in + +% This is the definition that ^^M gets inside @lisp, @example, and other +% such environments. \null is better than a space, since it doesn't +% have any width. +\def\lisppar{\null\endgraf} + +% This space is always present above and below environments. +\newskip\envskipamount \envskipamount = 0pt + +% Make spacing and below environment symmetrical. We use \parskip here +% to help in doing that, since in @example-like environments \parskip +% is reset to zero; thus the \afterenvbreak inserts no space -- but the +% start of the next paragraph will insert \parskip. +% +\def\aboveenvbreak{{% + % =10000 instead of <10000 because of a special case in \itemzzz and + % \sectionheading, q.v. + \ifnum \lastpenalty=10000 \else + \advance\envskipamount by \parskip + \endgraf + \ifdim\lastskip<\envskipamount + \removelastskip + % it's not a good place to break if the last penalty was \nobreak + % or better ... + \ifnum\lastpenalty<10000 \penalty-50 \fi + \vskip\envskipamount + \fi + \fi +}} + +\let\afterenvbreak = \aboveenvbreak + +% \nonarrowing is a flag. If "set", @lisp etc don't narrow margins; it will +% also clear it, so that its embedded environments do the narrowing again. +\let\nonarrowing=\relax + +% @cartouche ... @end cartouche: draw rectangle w/rounded corners around +% environment contents. +\font\circle=lcircle10 +\newdimen\circthick +\newdimen\cartouter\newdimen\cartinner +\newskip\normbskip\newskip\normpskip\newskip\normlskip +\circthick=\fontdimen8\circle +% +\def\ctl{{\circle\char'013\hskip -6pt}}% 6pt from pl file: 1/2charwidth +\def\ctr{{\hskip 6pt\circle\char'010}} +\def\cbl{{\circle\char'012\hskip -6pt}} +\def\cbr{{\hskip 6pt\circle\char'011}} +\def\carttop{\hbox to \cartouter{\hskip\lskip + \ctl\leaders\hrule height\circthick\hfil\ctr + \hskip\rskip}} +\def\cartbot{\hbox to \cartouter{\hskip\lskip + \cbl\leaders\hrule height\circthick\hfil\cbr + \hskip\rskip}} +% +\newskip\lskip\newskip\rskip + +\envdef\cartouche{% + \ifhmode\par\fi % can't be in the midst of a paragraph. + \startsavinginserts + \lskip=\leftskip \rskip=\rightskip + \leftskip=0pt\rightskip=0pt % we want these *outside*. + \cartinner=\hsize \advance\cartinner by-\lskip + \advance\cartinner by-\rskip + \cartouter=\hsize + \advance\cartouter by 18.4pt % allow for 3pt kerns on either + % side, and for 6pt waste from + % each corner char, and rule thickness + \normbskip=\baselineskip \normpskip=\parskip \normlskip=\lineskip + % Flag to tell @lisp, etc., not to narrow margin. + \let\nonarrowing = t% + \vbox\bgroup + \baselineskip=0pt\parskip=0pt\lineskip=0pt + \carttop + \hbox\bgroup + \hskip\lskip + \vrule\kern3pt + \vbox\bgroup + \kern3pt + \hsize=\cartinner + \baselineskip=\normbskip + \lineskip=\normlskip + \parskip=\normpskip + \vskip -\parskip + \comment % For explanation, see the end of \def\group. +} +\def\Ecartouche{% + \ifhmode\par\fi + \kern3pt + \egroup + \kern3pt\vrule + \hskip\rskip + \egroup + \cartbot + \egroup + \checkinserts +} + + +% This macro is called at the beginning of all the @example variants, +% inside a group. +\newdimen\nonfillparindent +\def\nonfillstart{% + \aboveenvbreak + \hfuzz = 12pt % Don't be fussy + \sepspaces % Make spaces be word-separators rather than space tokens. + \let\par = \lisppar % don't ignore blank lines + \obeylines % each line of input is a line of output + \parskip = 0pt + % Turn off paragraph indentation but redefine \indent to emulate + % the normal \indent. + \nonfillparindent=\parindent + \parindent = 0pt + \let\indent\nonfillindent + % + \emergencystretch = 0pt % don't try to avoid overfull boxes + \ifx\nonarrowing\relax + \advance \leftskip by \lispnarrowing + \exdentamount=\lispnarrowing + \else + \let\nonarrowing = \relax + \fi + \let\exdent=\nofillexdent +} + +\begingroup +\obeyspaces +% We want to swallow spaces (but not other tokens) after the fake +% @indent in our nonfill-environments, where spaces are normally +% active and set to @tie, resulting in them not being ignored after +% @indent. +\gdef\nonfillindent{\futurelet\temp\nonfillindentcheck}% +\gdef\nonfillindentcheck{% +\ifx\temp % +\expandafter\nonfillindentgobble% +\else% +\leavevmode\nonfillindentbox% +\fi% +}% +\endgroup +\def\nonfillindentgobble#1{\nonfillindent} +\def\nonfillindentbox{\hbox to \nonfillparindent{\hss}} + +% If you want all examples etc. small: @set dispenvsize small. +% If you want even small examples the full size: @set dispenvsize nosmall. +% This affects the following displayed environments: +% @example, @display, @format, @lisp +% +\def\smallword{small} +\def\nosmallword{nosmall} +\let\SETdispenvsize\relax +\def\setnormaldispenv{% + \ifx\SETdispenvsize\smallword + % end paragraph for sake of leading, in case document has no blank + % line. This is redundant with what happens in \aboveenvbreak, but + % we need to do it before changing the fonts, and it's inconvenient + % to change the fonts afterward. + \ifnum \lastpenalty=10000 \else \endgraf \fi + \smallexamplefonts \rm + \fi +} +\def\setsmalldispenv{% + \ifx\SETdispenvsize\nosmallword + \else + \ifnum \lastpenalty=10000 \else \endgraf \fi + \smallexamplefonts \rm + \fi +} + +% We often define two environments, @foo and @smallfoo. +% Let's do it by one command: +\def\makedispenv #1#2{ + \expandafter\envdef\csname#1\endcsname {\setnormaldispenv #2} + \expandafter\envdef\csname small#1\endcsname {\setsmalldispenv #2} + \expandafter\let\csname E#1\endcsname \afterenvbreak + \expandafter\let\csname Esmall#1\endcsname \afterenvbreak +} + +% Define two synonyms: +\def\maketwodispenvs #1#2#3{ + \makedispenv{#1}{#3} + \makedispenv{#2}{#3} +} + +% @lisp: indented, narrowed, typewriter font; @example: same as @lisp. +% +% @smallexample and @smalllisp: use smaller fonts. +% Originally contributed by Pavel@xerox. +% +\maketwodispenvs {lisp}{example}{% + \nonfillstart + \tt\setupmarkupstyle{example}% + \let\kbdfont = \kbdexamplefont % Allow @kbd to do something special. + \gobble % eat return +} +% @display/@smalldisplay: same as @lisp except keep current font. +% +\makedispenv {display}{% + \nonfillstart + \gobble +} + +% @format/@smallformat: same as @display except don't narrow margins. +% +\makedispenv{format}{% + \let\nonarrowing = t% + \nonfillstart + \gobble +} + +% @flushleft: same as @format, but doesn't obey \SETdispenvsize. +\envdef\flushleft{% + \let\nonarrowing = t% + \nonfillstart + \gobble +} +\let\Eflushleft = \afterenvbreak + +% @flushright. +% +\envdef\flushright{% + \let\nonarrowing = t% + \nonfillstart + \advance\leftskip by 0pt plus 1fill + \gobble +} +\let\Eflushright = \afterenvbreak + + +% @raggedright does more-or-less normal line breaking but no right +% justification. From plain.tex. +\envdef\raggedright{% + \rightskip0pt plus2em \spaceskip.3333em \xspaceskip.5em\relax +} +\let\Eraggedright\par + +\envdef\raggedleft{% + \parindent=0pt \leftskip0pt plus2em + \spaceskip.3333em \xspaceskip.5em \parfillskip=0pt + \hbadness=10000 % Last line will usually be underfull, so turn off + % badness reporting. +} +\let\Eraggedleft\par + +\envdef\raggedcenter{% + \parindent=0pt \rightskip0pt plus1em \leftskip0pt plus1em + \spaceskip.3333em \xspaceskip.5em \parfillskip=0pt + \hbadness=10000 % Last line will usually be underfull, so turn off + % badness reporting. +} +\let\Eraggedcenter\par + + +% @quotation does normal linebreaking (hence we can't use \nonfillstart) +% and narrows the margins. We keep \parskip nonzero in general, since +% we're doing normal filling. So, when using \aboveenvbreak and +% \afterenvbreak, temporarily make \parskip 0. +% +\def\quotationstart{% + {\parskip=0pt \aboveenvbreak}% because \aboveenvbreak inserts \parskip + \parindent=0pt + % + % @cartouche defines \nonarrowing to inhibit narrowing at next level down. + \ifx\nonarrowing\relax + \advance\leftskip by \lispnarrowing + \advance\rightskip by \lispnarrowing + \exdentamount = \lispnarrowing + \else + \let\nonarrowing = \relax + \fi + \parsearg\quotationlabel +} + +\envdef\quotation{% + \setnormaldispenv + \quotationstart +} + +\envdef\smallquotation{% + \setsmalldispenv + \quotationstart +} +\let\Esmallquotation = \Equotation + +% We have retained a nonzero parskip for the environment, since we're +% doing normal filling. +% +\def\Equotation{% + \par + \ifx\quotationauthor\undefined\else + % indent a bit. + \leftline{\kern 2\leftskip \sl ---\quotationauthor}% + \fi + {\parskip=0pt \afterenvbreak}% +} + +% If we're given an argument, typeset it in bold with a colon after. +\def\quotationlabel#1{% + \def\temp{#1}% + \ifx\temp\empty \else + {\bf #1: }% + \fi +} + + +% LaTeX-like @verbatim...@end verbatim and @verb{...} +% If we want to allow any as delimiter, +% we need the curly braces so that makeinfo sees the @verb command, eg: +% `@verbx...x' would look like the '@verbx' command. --janneke@gnu.org +% +% [Knuth]: Donald Ervin Knuth, 1996. The TeXbook. +% +% [Knuth] p.344; only we need to do the other characters Texinfo sets +% active too. Otherwise, they get lost as the first character on a +% verbatim line. +\def\dospecials{% + \do\ \do\\\do\{\do\}\do\$\do\&% + \do\#\do\^\do\^^K\do\_\do\^^A\do\%\do\~% + \do\<\do\>\do\|\do\@\do+\do\"% + % Don't do the quotes -- if we do, @set txicodequoteundirected and + % @set txicodequotebacktick will not have effect on @verb and + % @verbatim, and ?` and !` ligatures won't get disabled. + %\do\`\do\'% +} +% +% [Knuth] p. 380 +\def\uncatcodespecials{% + \def\do##1{\catcode`##1=\other}\dospecials} +% +% Setup for the @verb command. +% +% Eight spaces for a tab +\begingroup + \catcode`\^^I=\active + \gdef\tabeightspaces{\catcode`\^^I=\active\def^^I{\ \ \ \ \ \ \ \ }} +\endgroup +% +\def\setupverb{% + \tt % easiest (and conventionally used) font for verbatim + \def\par{\leavevmode\endgraf}% + \setupmarkupstyle{verb}% + \tabeightspaces + % Respect line breaks, + % print special symbols as themselves, and + % make each space count + % must do in this order: + \obeylines \uncatcodespecials \sepspaces +} + +% Setup for the @verbatim environment +% +% Real tab expansion +\newdimen\tabw \setbox0=\hbox{\tt\space} \tabw=8\wd0 % tab amount +% +\def\starttabbox{\setbox0=\hbox\bgroup} +% +\begingroup + \catcode`\^^I=\active + \gdef\tabexpand{% + \catcode`\^^I=\active + \def^^I{\leavevmode\egroup + \dimen0=\wd0 % the width so far, or since the previous tab + \divide\dimen0 by\tabw + \multiply\dimen0 by\tabw % compute previous multiple of \tabw + \advance\dimen0 by\tabw % advance to next multiple of \tabw + \wd0=\dimen0 \box0 \starttabbox + }% + } +\endgroup + +% start the verbatim environment. +\def\setupverbatim{% + \let\nonarrowing = t% + \nonfillstart + % Easiest (and conventionally used) font for verbatim + \tt + \def\par{\leavevmode\egroup\box0\endgraf}% + \tabexpand + \setupmarkupstyle{verbatim}% + % Respect line breaks, + % print special symbols as themselves, and + % make each space count + % must do in this order: + \obeylines \uncatcodespecials \sepspaces + \everypar{\starttabbox}% +} + +% Do the @verb magic: verbatim text is quoted by unique +% delimiter characters. Before first delimiter expect a +% right brace, after last delimiter expect closing brace: +% +% \def\doverb'{'#1'}'{#1} +% +% [Knuth] p. 382; only eat outer {} +\begingroup + \catcode`[=1\catcode`]=2\catcode`\{=\other\catcode`\}=\other + \gdef\doverb{#1[\def\next##1#1}[##1\endgroup]\next] +\endgroup +% +\def\verb{\begingroup\setupverb\doverb} +% +% +% Do the @verbatim magic: define the macro \doverbatim so that +% the (first) argument ends when '@end verbatim' is reached, ie: +% +% \def\doverbatim#1@end verbatim{#1} +% +% For Texinfo it's a lot easier than for LaTeX, +% because texinfo's \verbatim doesn't stop at '\end{verbatim}': +% we need not redefine '\', '{' and '}'. +% +% Inspired by LaTeX's verbatim command set [latex.ltx] +% +\begingroup + \catcode`\ =\active + \obeylines % + % ignore everything up to the first ^^M, that's the newline at the end + % of the @verbatim input line itself. Otherwise we get an extra blank + % line in the output. + \xdef\doverbatim#1^^M#2@end verbatim{#2\noexpand\end\gobble verbatim}% + % We really want {...\end verbatim} in the body of the macro, but + % without the active space; thus we have to use \xdef and \gobble. +\endgroup +% +\envdef\verbatim{% + \setupverbatim\doverbatim +} +\let\Everbatim = \afterenvbreak + + +% @verbatiminclude FILE - insert text of file in verbatim environment. +% +\def\verbatiminclude{\parseargusing\filenamecatcodes\doverbatiminclude} +% +\def\doverbatiminclude#1{% + {% + \makevalueexpandable + \setupverbatim + \indexnofonts % Allow `@@' and other weird things in file names. + \input #1 + \afterenvbreak + }% +} + +% @copying ... @end copying. +% Save the text away for @insertcopying later. +% +% We save the uninterpreted tokens, rather than creating a box. +% Saving the text in a box would be much easier, but then all the +% typesetting commands (@smallbook, font changes, etc.) have to be done +% beforehand -- and a) we want @copying to be done first in the source +% file; b) letting users define the frontmatter in as flexible order as +% possible is very desirable. +% +\def\copying{\checkenv{}\begingroup\scanargctxt\docopying} +\def\docopying#1@end copying{\endgroup\def\copyingtext{#1}} +% +\def\insertcopying{% + \begingroup + \parindent = 0pt % paragraph indentation looks wrong on title page + \scanexp\copyingtext + \endgroup +} + + +\message{defuns,} +% @defun etc. + +\newskip\defbodyindent \defbodyindent=.4in +\newskip\defargsindent \defargsindent=50pt +\newskip\deflastargmargin \deflastargmargin=18pt +\newcount\defunpenalty + +% Start the processing of @deffn: +\def\startdefun{% + \ifnum\lastpenalty<10000 + \medbreak + \defunpenalty=10003 % Will keep this @deffn together with the + % following @def command, see below. + \else + % If there are two @def commands in a row, we'll have a \nobreak, + % which is there to keep the function description together with its + % header. But if there's nothing but headers, we need to allow a + % break somewhere. Check specifically for penalty 10002, inserted + % by \printdefunline, instead of 10000, since the sectioning + % commands also insert a nobreak penalty, and we don't want to allow + % a break between a section heading and a defun. + % + % As a minor refinement, we avoid "club" headers by signalling + % with penalty of 10003 after the very first @deffn in the + % sequence (see above), and penalty of 10002 after any following + % @def command. + \ifnum\lastpenalty=10002 \penalty2000 \else \defunpenalty=10002 \fi + % + % Similarly, after a section heading, do not allow a break. + % But do insert the glue. + \medskip % preceded by discardable penalty, so not a breakpoint + \fi + % + \parindent=0in + \advance\leftskip by \defbodyindent + \exdentamount=\defbodyindent +} + +\def\dodefunx#1{% + % First, check whether we are in the right environment: + \checkenv#1% + % + % As above, allow line break if we have multiple x headers in a row. + % It's not a great place, though. + \ifnum\lastpenalty=10002 \penalty3000 \else \defunpenalty=10002 \fi + % + % And now, it's time to reuse the body of the original defun: + \expandafter\gobbledefun#1% +} +\def\gobbledefun#1\startdefun{} + +% \printdefunline \deffnheader{text} +% +\def\printdefunline#1#2{% + \begingroup + % call \deffnheader: + #1#2 \endheader + % common ending: + \interlinepenalty = 10000 + \advance\rightskip by 0pt plus 1fil + \endgraf + \nobreak\vskip -\parskip + \penalty\defunpenalty % signal to \startdefun and \dodefunx + % Some of the @defun-type tags do not enable magic parentheses, + % rendering the following check redundant. But we don't optimize. + \checkparencounts + \endgroup +} + +\def\Edefun{\endgraf\medbreak} + +% \makedefun{deffn} creates \deffn, \deffnx and \Edeffn; +% the only thing remaining is to define \deffnheader. +% +\def\makedefun#1{% + \expandafter\let\csname E#1\endcsname = \Edefun + \edef\temp{\noexpand\domakedefun + \makecsname{#1}\makecsname{#1x}\makecsname{#1header}}% + \temp +} + +% \domakedefun \deffn \deffnx \deffnheader +% +% Define \deffn and \deffnx, without parameters. +% \deffnheader has to be defined explicitly. +% +\def\domakedefun#1#2#3{% + \envdef#1{% + \startdefun + \parseargusing\activeparens{\printdefunline#3}% + }% + \def#2{\dodefunx#1}% + \def#3% +} + +%%% Untyped functions: + +% @deffn category name args +\makedefun{deffn}{\deffngeneral{}} + +% @deffn category class name args +\makedefun{defop}#1 {\defopon{#1\ \putwordon}} + +% \defopon {category on}class name args +\def\defopon#1#2 {\deffngeneral{\putwordon\ \code{#2}}{#1\ \code{#2}} } + +% \deffngeneral {subind}category name args +% +\def\deffngeneral#1#2 #3 #4\endheader{% + % Remember that \dosubind{fn}{foo}{} is equivalent to \doind{fn}{foo}. + \dosubind{fn}{\code{#3}}{#1}% + \defname{#2}{}{#3}\magicamp\defunargs{#4\unskip}% +} + +%%% Typed functions: + +% @deftypefn category type name args +\makedefun{deftypefn}{\deftypefngeneral{}} + +% @deftypeop category class type name args +\makedefun{deftypeop}#1 {\deftypeopon{#1\ \putwordon}} + +% \deftypeopon {category on}class type name args +\def\deftypeopon#1#2 {\deftypefngeneral{\putwordon\ \code{#2}}{#1\ \code{#2}} } + +% \deftypefngeneral {subind}category type name args +% +\def\deftypefngeneral#1#2 #3 #4 #5\endheader{% + \dosubind{fn}{\code{#4}}{#1}% + \defname{#2}{#3}{#4}\defunargs{#5\unskip}% +} + +%%% Typed variables: + +% @deftypevr category type var args +\makedefun{deftypevr}{\deftypecvgeneral{}} + +% @deftypecv category class type var args +\makedefun{deftypecv}#1 {\deftypecvof{#1\ \putwordof}} + +% \deftypecvof {category of}class type var args +\def\deftypecvof#1#2 {\deftypecvgeneral{\putwordof\ \code{#2}}{#1\ \code{#2}} } + +% \deftypecvgeneral {subind}category type var args +% +\def\deftypecvgeneral#1#2 #3 #4 #5\endheader{% + \dosubind{vr}{\code{#4}}{#1}% + \defname{#2}{#3}{#4}\defunargs{#5\unskip}% +} + +%%% Untyped variables: + +% @defvr category var args +\makedefun{defvr}#1 {\deftypevrheader{#1} {} } + +% @defcv category class var args +\makedefun{defcv}#1 {\defcvof{#1\ \putwordof}} + +% \defcvof {category of}class var args +\def\defcvof#1#2 {\deftypecvof{#1}#2 {} } + +%%% Type: +% @deftp category name args +\makedefun{deftp}#1 #2 #3\endheader{% + \doind{tp}{\code{#2}}% + \defname{#1}{}{#2}\defunargs{#3\unskip}% +} + +% Remaining @defun-like shortcuts: +\makedefun{defun}{\deffnheader{\putwordDeffunc} } +\makedefun{defmac}{\deffnheader{\putwordDefmac} } +\makedefun{defspec}{\deffnheader{\putwordDefspec} } +\makedefun{deftypefun}{\deftypefnheader{\putwordDeffunc} } +\makedefun{defvar}{\defvrheader{\putwordDefvar} } +\makedefun{defopt}{\defvrheader{\putwordDefopt} } +\makedefun{deftypevar}{\deftypevrheader{\putwordDefvar} } +\makedefun{defmethod}{\defopon\putwordMethodon} +\makedefun{deftypemethod}{\deftypeopon\putwordMethodon} +\makedefun{defivar}{\defcvof\putwordInstanceVariableof} +\makedefun{deftypeivar}{\deftypecvof\putwordInstanceVariableof} + +% \defname, which formats the name of the @def (not the args). +% #1 is the category, such as "Function". +% #2 is the return type, if any. +% #3 is the function name. +% +% We are followed by (but not passed) the arguments, if any. +% +\def\defname#1#2#3{% + % Get the values of \leftskip and \rightskip as they were outside the @def... + \advance\leftskip by -\defbodyindent + % + % How we'll format the type name. Putting it in brackets helps + % distinguish it from the body text that may end up on the next line + % just below it. + \def\temp{#1}% + \setbox0=\hbox{\kern\deflastargmargin \ifx\temp\empty\else [\rm\temp]\fi} + % + % Figure out line sizes for the paragraph shape. + % The first line needs space for \box0; but if \rightskip is nonzero, + % we need only space for the part of \box0 which exceeds it: + \dimen0=\hsize \advance\dimen0 by -\wd0 \advance\dimen0 by \rightskip + % The continuations: + \dimen2=\hsize \advance\dimen2 by -\defargsindent + % (plain.tex says that \dimen1 should be used only as global.) + \parshape 2 0in \dimen0 \defargsindent \dimen2 + % + % Put the type name to the right margin. + \noindent + \hbox to 0pt{% + \hfil\box0 \kern-\hsize + % \hsize has to be shortened this way: + \kern\leftskip + % Intentionally do not respect \rightskip, since we need the space. + }% + % + % Allow all lines to be underfull without complaint: + \tolerance=10000 \hbadness=10000 + \exdentamount=\defbodyindent + {% + % defun fonts. We use typewriter by default (used to be bold) because: + % . we're printing identifiers, they should be in tt in principle. + % . in languages with many accents, such as Czech or French, it's + % common to leave accents off identifiers. The result looks ok in + % tt, but exceedingly strange in rm. + % . we don't want -- and --- to be treated as ligatures. + % . this still does not fix the ?` and !` ligatures, but so far no + % one has made identifiers using them :). + \df \tt + \def\temp{#2}% return value type + \ifx\temp\empty\else \tclose{\temp} \fi + #3% output function name + }% + {\rm\enskip}% hskip 0.5 em of \tenrm + % + \boldbrax + % arguments will be output next, if any. +} + +% Print arguments in slanted roman (not ttsl), inconsistently with using +% tt for the name. This is because literal text is sometimes needed in +% the argument list (groff manual), and ttsl and tt are not very +% distinguishable. Prevent hyphenation at `-' chars. +% +\def\defunargs#1{% + % use sl by default (not ttsl), + % tt for the names. + \df \sl \hyphenchar\font=0 + % + % On the other hand, if an argument has two dashes (for instance), we + % want a way to get ttsl. Let's try @var for that. + \def\var##1{{\setupmarkupstyle{var}\ttslanted{##1}}}% + #1% + \sl\hyphenchar\font=45 +} + +% We want ()&[] to print specially on the defun line. +% +\def\activeparens{% + \catcode`\(=\active \catcode`\)=\active + \catcode`\[=\active \catcode`\]=\active + \catcode`\&=\active +} + +% Make control sequences which act like normal parenthesis chars. +\let\lparen = ( \let\rparen = ) + +% Be sure that we always have a definition for `(', etc. For example, +% if the fn name has parens in it, \boldbrax will not be in effect yet, +% so TeX would otherwise complain about undefined control sequence. +{ + \activeparens + \global\let(=\lparen \global\let)=\rparen + \global\let[=\lbrack \global\let]=\rbrack + \global\let& = \& + + \gdef\boldbrax{\let(=\opnr\let)=\clnr\let[=\lbrb\let]=\rbrb} + \gdef\magicamp{\let&=\amprm} +} + +\newcount\parencount + +% If we encounter &foo, then turn on ()-hacking afterwards +\newif\ifampseen +\def\amprm#1 {\ampseentrue{\bf\ }} + +\def\parenfont{% + \ifampseen + % At the first level, print parens in roman, + % otherwise use the default font. + \ifnum \parencount=1 \rm \fi + \else + % The \sf parens (in \boldbrax) actually are a little bolder than + % the contained text. This is especially needed for [ and ] . + \sf + \fi +} +\def\infirstlevel#1{% + \ifampseen + \ifnum\parencount=1 + #1% + \fi + \fi +} +\def\bfafterword#1 {#1 \bf} + +\def\opnr{% + \global\advance\parencount by 1 + {\parenfont(}% + \infirstlevel \bfafterword +} +\def\clnr{% + {\parenfont)}% + \infirstlevel \sl + \global\advance\parencount by -1 +} + +\newcount\brackcount +\def\lbrb{% + \global\advance\brackcount by 1 + {\bf[}% +} +\def\rbrb{% + {\bf]}% + \global\advance\brackcount by -1 +} + +\def\checkparencounts{% + \ifnum\parencount=0 \else \badparencount \fi + \ifnum\brackcount=0 \else \badbrackcount \fi +} +% these should not use \errmessage; the glibc manual, at least, actually +% has such constructs (when documenting function pointers). +\def\badparencount{% + \message{Warning: unbalanced parentheses in @def...}% + \global\parencount=0 +} +\def\badbrackcount{% + \message{Warning: unbalanced square brackets in @def...}% + \global\brackcount=0 +} + + +\message{macros,} +% @macro. + +% To do this right we need a feature of e-TeX, \scantokens, +% which we arrange to emulate with a temporary file in ordinary TeX. +\ifx\eTeXversion\undefined + \newwrite\macscribble + \def\scantokens#1{% + \toks0={#1}% + \immediate\openout\macscribble=\jobname.tmp + \immediate\write\macscribble{\the\toks0}% + \immediate\closeout\macscribble + \input \jobname.tmp + } +\fi + +\def\scanmacro#1{% + \begingroup + \newlinechar`\^^M + \let\xeatspaces\eatspaces + % Undo catcode changes of \startcontents and \doprintindex + % When called from @insertcopying or (short)caption, we need active + % backslash to get it printed correctly. Previously, we had + % \catcode`\\=\other instead. We'll see whether a problem appears + % with macro expansion. --kasal, 19aug04 + \catcode`\@=0 \catcode`\\=\active \escapechar=`\@ + % ... and \example + \spaceisspace + % + % Append \endinput to make sure that TeX does not see the ending newline. + % I've verified that it is necessary both for e-TeX and for ordinary TeX + % --kasal, 29nov03 + \scantokens{#1\endinput}% + \endgroup +} + +\def\scanexp#1{% + \edef\temp{\noexpand\scanmacro{#1}}% + \temp +} + +\newcount\paramno % Count of parameters +\newtoks\macname % Macro name +\newif\ifrecursive % Is it recursive? + +% List of all defined macros in the form +% \definedummyword\macro1\definedummyword\macro2... +% Currently is also contains all @aliases; the list can be split +% if there is a need. +\def\macrolist{} + +% Add the macro to \macrolist +\def\addtomacrolist#1{\expandafter \addtomacrolistxxx \csname#1\endcsname} +\def\addtomacrolistxxx#1{% + \toks0 = \expandafter{\macrolist\definedummyword#1}% + \xdef\macrolist{\the\toks0}% +} + +% Utility routines. +% This does \let #1 = #2, with \csnames; that is, +% \let \csname#1\endcsname = \csname#2\endcsname +% (except of course we have to play expansion games). +% +\def\cslet#1#2{% + \expandafter\let + \csname#1\expandafter\endcsname + \csname#2\endcsname +} + +% Trim leading and trailing spaces off a string. +% Concepts from aro-bend problem 15 (see CTAN). +{\catcode`\@=11 +\gdef\eatspaces #1{\expandafter\trim@\expandafter{#1 }} +\gdef\trim@ #1{\trim@@ @#1 @ #1 @ @@} +\gdef\trim@@ #1@ #2@ #3@@{\trim@@@\empty #2 @} +\def\unbrace#1{#1} +\unbrace{\gdef\trim@@@ #1 } #2@{#1} +} + +% Trim a single trailing ^^M off a string. +{\catcode`\^^M=\other \catcode`\Q=3% +\gdef\eatcr #1{\eatcra #1Q^^MQ}% +\gdef\eatcra#1^^MQ{\eatcrb#1Q}% +\gdef\eatcrb#1Q#2Q{#1}% +} + +% Macro bodies are absorbed as an argument in a context where +% all characters are catcode 10, 11 or 12, except \ which is active +% (as in normal texinfo). It is necessary to change the definition of \. + +% Non-ASCII encodings make 8-bit characters active, so un-activate +% them to avoid their expansion. Must do this non-globally, to +% confine the change to the current group. + +% It's necessary to have hard CRs when the macro is executed. This is +% done by making ^^M (\endlinechar) catcode 12 when reading the macro +% body, and then making it the \newlinechar in \scanmacro. + +\def\scanctxt{% + \catcode`\"=\other + \catcode`\+=\other + \catcode`\<=\other + \catcode`\>=\other + \catcode`\@=\other + \catcode`\^=\other + \catcode`\_=\other + \catcode`\|=\other + \catcode`\~=\other + \ifx\declaredencoding\ascii \else \setnonasciicharscatcodenonglobal\other \fi +} + +\def\scanargctxt{% + \scanctxt + \catcode`\\=\other + \catcode`\^^M=\other +} + +\def\macrobodyctxt{% + \scanctxt + \catcode`\{=\other + \catcode`\}=\other + \catcode`\^^M=\other + \usembodybackslash +} + +\def\macroargctxt{% + \scanctxt + \catcode`\\=\other +} + +% \mbodybackslash is the definition of \ in @macro bodies. +% It maps \foo\ => \csname macarg.foo\endcsname => #N +% where N is the macro parameter number. +% We define \csname macarg.\endcsname to be \realbackslash, so +% \\ in macro replacement text gets you a backslash. + +{\catcode`@=0 @catcode`@\=@active + @gdef@usembodybackslash{@let\=@mbodybackslash} + @gdef@mbodybackslash#1\{@csname macarg.#1@endcsname} +} +\expandafter\def\csname macarg.\endcsname{\realbackslash} + +\def\macro{\recursivefalse\parsearg\macroxxx} +\def\rmacro{\recursivetrue\parsearg\macroxxx} + +\def\macroxxx#1{% + \getargs{#1}% now \macname is the macname and \argl the arglist + \ifx\argl\empty % no arguments + \paramno=0% + \else + \expandafter\parsemargdef \argl;% + \fi + \if1\csname ismacro.\the\macname\endcsname + \message{Warning: redefining \the\macname}% + \else + \expandafter\ifx\csname \the\macname\endcsname \relax + \else \errmessage{Macro name \the\macname\space already defined}\fi + \global\cslet{macsave.\the\macname}{\the\macname}% + \global\expandafter\let\csname ismacro.\the\macname\endcsname=1% + \addtomacrolist{\the\macname}% + \fi + \begingroup \macrobodyctxt + \ifrecursive \expandafter\parsermacbody + \else \expandafter\parsemacbody + \fi} + +\parseargdef\unmacro{% + \if1\csname ismacro.#1\endcsname + \global\cslet{#1}{macsave.#1}% + \global\expandafter\let \csname ismacro.#1\endcsname=0% + % Remove the macro name from \macrolist: + \begingroup + \expandafter\let\csname#1\endcsname \relax + \let\definedummyword\unmacrodo + \xdef\macrolist{\macrolist}% + \endgroup + \else + \errmessage{Macro #1 not defined}% + \fi +} + +% Called by \do from \dounmacro on each macro. The idea is to omit any +% macro definitions that have been changed to \relax. +% +\def\unmacrodo#1{% + \ifx #1\relax + % remove this + \else + \noexpand\definedummyword \noexpand#1% + \fi +} + +% This makes use of the obscure feature that if the last token of a +% is #, then the preceding argument is delimited by +% an opening brace, and that opening brace is not consumed. +\def\getargs#1{\getargsxxx#1{}} +\def\getargsxxx#1#{\getmacname #1 \relax\getmacargs} +\def\getmacname #1 #2\relax{\macname={#1}} +\def\getmacargs#1{\def\argl{#1}} + +% Parse the optional {params} list. Set up \paramno and \paramlist +% so \defmacro knows what to do. Define \macarg.blah for each blah +% in the params list, to be ##N where N is the position in that list. +% That gets used by \mbodybackslash (above). + +% We need to get `macro parameter char #' into several definitions. +% The technique used is stolen from LaTeX: let \hash be something +% unexpandable, insert that wherever you need a #, and then redefine +% it to # just before using the token list produced. +% +% The same technique is used to protect \eatspaces till just before +% the macro is used. + +\def\parsemargdef#1;{\paramno=0\def\paramlist{}% + \let\hash\relax\let\xeatspaces\relax\parsemargdefxxx#1,;,} +\def\parsemargdefxxx#1,{% + \if#1;\let\next=\relax + \else \let\next=\parsemargdefxxx + \advance\paramno by 1% + \expandafter\edef\csname macarg.\eatspaces{#1}\endcsname + {\xeatspaces{\hash\the\paramno}}% + \edef\paramlist{\paramlist\hash\the\paramno,}% + \fi\next} + +% These two commands read recursive and nonrecursive macro bodies. +% (They're different since rec and nonrec macros end differently.) + +\long\def\parsemacbody#1@end macro% +{\xdef\temp{\eatcr{#1}}\endgroup\defmacro}% +\long\def\parsermacbody#1@end rmacro% +{\xdef\temp{\eatcr{#1}}\endgroup\defmacro}% + +% This defines the macro itself. There are six cases: recursive and +% nonrecursive macros of zero, one, and many arguments. +% Much magic with \expandafter here. +% \xdef is used so that macro definitions will survive the file +% they're defined in; @include reads the file inside a group. +\def\defmacro{% + \let\hash=##% convert placeholders to macro parameter chars + \ifrecursive + \ifcase\paramno + % 0 + \expandafter\xdef\csname\the\macname\endcsname{% + \noexpand\scanmacro{\temp}}% + \or % 1 + \expandafter\xdef\csname\the\macname\endcsname{% + \bgroup\noexpand\macroargctxt + \noexpand\braceorline + \expandafter\noexpand\csname\the\macname xxx\endcsname}% + \expandafter\xdef\csname\the\macname xxx\endcsname##1{% + \egroup\noexpand\scanmacro{\temp}}% + \else % many + \expandafter\xdef\csname\the\macname\endcsname{% + \bgroup\noexpand\macroargctxt + \noexpand\csname\the\macname xx\endcsname}% + \expandafter\xdef\csname\the\macname xx\endcsname##1{% + \expandafter\noexpand\csname\the\macname xxx\endcsname ##1,}% + \expandafter\expandafter + \expandafter\xdef + \expandafter\expandafter + \csname\the\macname xxx\endcsname + \paramlist{\egroup\noexpand\scanmacro{\temp}}% + \fi + \else + \ifcase\paramno + % 0 + \expandafter\xdef\csname\the\macname\endcsname{% + \noexpand\norecurse{\the\macname}% + \noexpand\scanmacro{\temp}\egroup}% + \or % 1 + \expandafter\xdef\csname\the\macname\endcsname{% + \bgroup\noexpand\macroargctxt + \noexpand\braceorline + \expandafter\noexpand\csname\the\macname xxx\endcsname}% + \expandafter\xdef\csname\the\macname xxx\endcsname##1{% + \egroup + \noexpand\norecurse{\the\macname}% + \noexpand\scanmacro{\temp}\egroup}% + \else % many + \expandafter\xdef\csname\the\macname\endcsname{% + \bgroup\noexpand\macroargctxt + \expandafter\noexpand\csname\the\macname xx\endcsname}% + \expandafter\xdef\csname\the\macname xx\endcsname##1{% + \expandafter\noexpand\csname\the\macname xxx\endcsname ##1,}% + \expandafter\expandafter + \expandafter\xdef + \expandafter\expandafter + \csname\the\macname xxx\endcsname + \paramlist{% + \egroup + \noexpand\norecurse{\the\macname}% + \noexpand\scanmacro{\temp}\egroup}% + \fi + \fi} + +\def\norecurse#1{\bgroup\cslet{#1}{macsave.#1}} + +% \braceorline decides whether the next nonwhitespace character is a +% {. If so it reads up to the closing }, if not, it reads the whole +% line. Whatever was read is then fed to the next control sequence +% as an argument (by \parsebrace or \parsearg) +\def\braceorline#1{\let\macnamexxx=#1\futurelet\nchar\braceorlinexxx} +\def\braceorlinexxx{% + \ifx\nchar\bgroup\else + \expandafter\parsearg + \fi \macnamexxx} + + +% @alias. +% We need some trickery to remove the optional spaces around the equal +% sign. Just make them active and then expand them all to nothing. +\def\alias{\parseargusing\obeyspaces\aliasxxx} +\def\aliasxxx #1{\aliasyyy#1\relax} +\def\aliasyyy #1=#2\relax{% + {% + \expandafter\let\obeyedspace=\empty + \addtomacrolist{#1}% + \xdef\next{\global\let\makecsname{#1}=\makecsname{#2}}% + }% + \next +} + + +\message{cross references,} + +\newwrite\auxfile +\newif\ifhavexrefs % True if xref values are known. +\newif\ifwarnedxrefs % True if we warned once that they aren't known. + +% @inforef is relatively simple. +\def\inforef #1{\inforefzzz #1,,,,**} +\def\inforefzzz #1,#2,#3,#4**{\putwordSee{} \putwordInfo{} \putwordfile{} \file{\ignorespaces #3{}}, + node \samp{\ignorespaces#1{}}} + +% @node's only job in TeX is to define \lastnode, which is used in +% cross-references. The @node line might or might not have commas, and +% might or might not have spaces before the first comma, like: +% @node foo , bar , ... +% We don't want such trailing spaces in the node name. +% +\parseargdef\node{\checkenv{}\donode #1 ,\finishnodeparse} +% +% also remove a trailing comma, in case of something like this: +% @node Help-Cross, , , Cross-refs +\def\donode#1 ,#2\finishnodeparse{\dodonode #1,\finishnodeparse} +\def\dodonode#1,#2\finishnodeparse{\gdef\lastnode{#1}} + +\let\nwnode=\node +\let\lastnode=\empty + +% Write a cross-reference definition for the current node. #1 is the +% type (Ynumbered, Yappendix, Ynothing). +% +\def\donoderef#1{% + \ifx\lastnode\empty\else + \setref{\lastnode}{#1}% + \global\let\lastnode=\empty + \fi +} + +% @anchor{NAME} -- define xref target at arbitrary point. +% +\newcount\savesfregister +% +\def\savesf{\relax \ifhmode \savesfregister=\spacefactor \fi} +\def\restoresf{\relax \ifhmode \spacefactor=\savesfregister \fi} +\def\anchor#1{\savesf \setref{#1}{Ynothing}\restoresf \ignorespaces} + +% \setref{NAME}{SNT} defines a cross-reference point NAME (a node or an +% anchor), which consists of three parts: +% 1) NAME-title - the current sectioning name taken from \lastsection, +% or the anchor name. +% 2) NAME-snt - section number and type, passed as the SNT arg, or +% empty for anchors. +% 3) NAME-pg - the page number. +% +% This is called from \donoderef, \anchor, and \dofloat. In the case of +% floats, there is an additional part, which is not written here: +% 4) NAME-lof - the text as it should appear in a @listoffloats. +% +\def\setref#1#2{% + \pdfmkdest{#1}% + \iflinks + {% + \atdummies % preserve commands, but don't expand them + \edef\writexrdef##1##2{% + \write\auxfile{@xrdef{#1-% #1 of \setref, expanded by the \edef + ##1}{##2}}% these are parameters of \writexrdef + }% + \toks0 = \expandafter{\lastsection}% + \immediate \writexrdef{title}{\the\toks0 }% + \immediate \writexrdef{snt}{\csname #2\endcsname}% \Ynumbered etc. + \safewhatsit{\writexrdef{pg}{\folio}}% will be written later, during \shipout + }% + \fi +} + +% @xref, @pxref, and @ref generate cross-references. For \xrefX, #1 is +% the node name, #2 the name of the Info cross-reference, #3 the printed +% node name, #4 the name of the Info file, #5 the name of the printed +% manual. All but the node name can be omitted. +% +\def\pxref#1{\putwordsee{} \xrefX[#1,,,,,,,]} +\def\xref#1{\putwordSee{} \xrefX[#1,,,,,,,]} +\def\ref#1{\xrefX[#1,,,,,,,]} +\def\xrefX[#1,#2,#3,#4,#5,#6]{\begingroup + \unsepspaces + \def\printedmanual{\ignorespaces #5}% + \def\printedrefname{\ignorespaces #3}% + \setbox1=\hbox{\printedmanual\unskip}% + \setbox0=\hbox{\printedrefname\unskip}% + \ifdim \wd0 = 0pt + % No printed node name was explicitly given. + \expandafter\ifx\csname SETxref-automatic-section-title\endcsname\relax + % Use the node name inside the square brackets. + \def\printedrefname{\ignorespaces #1}% + \else + % Use the actual chapter/section title appear inside + % the square brackets. Use the real section title if we have it. + \ifdim \wd1 > 0pt + % It is in another manual, so we don't have it. + \def\printedrefname{\ignorespaces #1}% + \else + \ifhavexrefs + % We know the real title if we have the xref values. + \def\printedrefname{\refx{#1-title}{}}% + \else + % Otherwise just copy the Info node name. + \def\printedrefname{\ignorespaces #1}% + \fi% + \fi + \fi + \fi + % + % Make link in pdf output. + \ifpdf + {\indexnofonts + \turnoffactive + % This expands tokens, so do it after making catcode changes, so _ + % etc. don't get their TeX definitions. + \getfilename{#4}% + % + % See comments at \activebackslashdouble. + {\activebackslashdouble \xdef\pdfxrefdest{#1}% + \backslashparens\pdfxrefdest}% + % + \leavevmode + \startlink attr{/Border [0 0 0]}% + \ifnum\filenamelength>0 + goto file{\the\filename.pdf} name{\pdfxrefdest}% + \else + goto name{\pdfmkpgn{\pdfxrefdest}}% + \fi + }% + \setcolor{\linkcolor}% + \fi + % + % Float references are printed completely differently: "Figure 1.2" + % instead of "[somenode], p.3". We distinguish them by the + % LABEL-title being set to a magic string. + {% + % Have to otherify everything special to allow the \csname to + % include an _ in the xref name, etc. + \indexnofonts + \turnoffactive + \expandafter\global\expandafter\let\expandafter\Xthisreftitle + \csname XR#1-title\endcsname + }% + \iffloat\Xthisreftitle + % If the user specified the print name (third arg) to the ref, + % print it instead of our usual "Figure 1.2". + \ifdim\wd0 = 0pt + \refx{#1-snt}{}% + \else + \printedrefname + \fi + % + % if the user also gave the printed manual name (fifth arg), append + % "in MANUALNAME". + \ifdim \wd1 > 0pt + \space \putwordin{} \cite{\printedmanual}% + \fi + \else + % node/anchor (non-float) references. + % + % If we use \unhbox0 and \unhbox1 to print the node names, TeX does not + % insert empty discretionaries after hyphens, which means that it will + % not find a line break at a hyphen in a node names. Since some manuals + % are best written with fairly long node names, containing hyphens, this + % is a loss. Therefore, we give the text of the node name again, so it + % is as if TeX is seeing it for the first time. + \ifdim \wd1 > 0pt + \putwordSection{} ``\printedrefname'' \putwordin{} \cite{\printedmanual}% + \else + % _ (for example) has to be the character _ for the purposes of the + % control sequence corresponding to the node, but it has to expand + % into the usual \leavevmode...\vrule stuff for purposes of + % printing. So we \turnoffactive for the \refx-snt, back on for the + % printing, back off for the \refx-pg. + {\turnoffactive + % Only output a following space if the -snt ref is nonempty; for + % @unnumbered and @anchor, it won't be. + \setbox2 = \hbox{\ignorespaces \refx{#1-snt}{}}% + \ifdim \wd2 > 0pt \refx{#1-snt}\space\fi + }% + % output the `[mynode]' via a macro so it can be overridden. + \xrefprintnodename\printedrefname + % + % But we always want a comma and a space: + ,\space + % + % output the `page 3'. + \turnoffactive \putwordpage\tie\refx{#1-pg}{}% + \fi + \fi + \endlink +\endgroup} + +% This macro is called from \xrefX for the `[nodename]' part of xref +% output. It's a separate macro only so it can be changed more easily, +% since square brackets don't work well in some documents. Particularly +% one that Bob is working on :). +% +\def\xrefprintnodename#1{[#1]} + +% Things referred to by \setref. +% +\def\Ynothing{} +\def\Yomitfromtoc{} +\def\Ynumbered{% + \ifnum\secno=0 + \putwordChapter@tie \the\chapno + \else \ifnum\subsecno=0 + \putwordSection@tie \the\chapno.\the\secno + \else \ifnum\subsubsecno=0 + \putwordSection@tie \the\chapno.\the\secno.\the\subsecno + \else + \putwordSection@tie \the\chapno.\the\secno.\the\subsecno.\the\subsubsecno + \fi\fi\fi +} +\def\Yappendix{% + \ifnum\secno=0 + \putwordAppendix@tie @char\the\appendixno{}% + \else \ifnum\subsecno=0 + \putwordSection@tie @char\the\appendixno.\the\secno + \else \ifnum\subsubsecno=0 + \putwordSection@tie @char\the\appendixno.\the\secno.\the\subsecno + \else + \putwordSection@tie + @char\the\appendixno.\the\secno.\the\subsecno.\the\subsubsecno + \fi\fi\fi +} + +% Define \refx{NAME}{SUFFIX} to reference a cross-reference string named NAME. +% If its value is nonempty, SUFFIX is output afterward. +% +\def\refx#1#2{% + {% + \indexnofonts + \otherbackslash + \expandafter\global\expandafter\let\expandafter\thisrefX + \csname XR#1\endcsname + }% + \ifx\thisrefX\relax + % If not defined, say something at least. + \angleleft un\-de\-fined\angleright + \iflinks + \ifhavexrefs + \message{\linenumber Undefined cross reference `#1'.}% + \else + \ifwarnedxrefs\else + \global\warnedxrefstrue + \message{Cross reference values unknown; you must run TeX again.}% + \fi + \fi + \fi + \else + % It's defined, so just use it. + \thisrefX + \fi + #2% Output the suffix in any case. +} + +% This is the macro invoked by entries in the aux file. Usually it's +% just a \def (we prepend XR to the control sequence name to avoid +% collisions). But if this is a float type, we have more work to do. +% +\def\xrdef#1#2{% + {% The node name might contain 8-bit characters, which in our current + % implementation are changed to commands like @'e. Don't let these + % mess up the control sequence name. + \indexnofonts + \turnoffactive + \xdef\safexrefname{#1}% + }% + % + \expandafter\gdef\csname XR\safexrefname\endcsname{#2}% remember this xref + % + % Was that xref control sequence that we just defined for a float? + \expandafter\iffloat\csname XR\safexrefname\endcsname + % it was a float, and we have the (safe) float type in \iffloattype. + \expandafter\let\expandafter\floatlist + \csname floatlist\iffloattype\endcsname + % + % Is this the first time we've seen this float type? + \expandafter\ifx\floatlist\relax + \toks0 = {\do}% yes, so just \do + \else + % had it before, so preserve previous elements in list. + \toks0 = \expandafter{\floatlist\do}% + \fi + % + % Remember this xref in the control sequence \floatlistFLOATTYPE, + % for later use in \listoffloats. + \expandafter\xdef\csname floatlist\iffloattype\endcsname{\the\toks0 + {\safexrefname}}% + \fi +} + +% Read the last existing aux file, if any. No error if none exists. +% +\def\tryauxfile{% + \openin 1 \jobname.aux + \ifeof 1 \else + \readdatafile{aux}% + \global\havexrefstrue + \fi + \closein 1 +} + +\def\setupdatafile{% + \catcode`\^^@=\other + \catcode`\^^A=\other + \catcode`\^^B=\other + \catcode`\^^C=\other + \catcode`\^^D=\other + \catcode`\^^E=\other + \catcode`\^^F=\other + \catcode`\^^G=\other + \catcode`\^^H=\other + \catcode`\^^K=\other + \catcode`\^^L=\other + \catcode`\^^N=\other + \catcode`\^^P=\other + \catcode`\^^Q=\other + \catcode`\^^R=\other + \catcode`\^^S=\other + \catcode`\^^T=\other + \catcode`\^^U=\other + \catcode`\^^V=\other + \catcode`\^^W=\other + \catcode`\^^X=\other + \catcode`\^^Z=\other + \catcode`\^^[=\other + \catcode`\^^\=\other + \catcode`\^^]=\other + \catcode`\^^^=\other + \catcode`\^^_=\other + % It was suggested to set the catcode of ^ to 7, which would allow ^^e4 etc. + % in xref tags, i.e., node names. But since ^^e4 notation isn't + % supported in the main text, it doesn't seem desirable. Furthermore, + % that is not enough: for node names that actually contain a ^ + % character, we would end up writing a line like this: 'xrdef {'hat + % b-title}{'hat b} and \xrdef does a \csname...\endcsname on the first + % argument, and \hat is not an expandable control sequence. It could + % all be worked out, but why? Either we support ^^ or we don't. + % + % The other change necessary for this was to define \auxhat: + % \def\auxhat{\def^{'hat }}% extra space so ok if followed by letter + % and then to call \auxhat in \setq. + % + \catcode`\^=\other + % + % Special characters. Should be turned off anyway, but... + \catcode`\~=\other + \catcode`\[=\other + \catcode`\]=\other + \catcode`\"=\other + \catcode`\_=\other + \catcode`\|=\other + \catcode`\<=\other + \catcode`\>=\other + \catcode`\$=\other + \catcode`\#=\other + \catcode`\&=\other + \catcode`\%=\other + \catcode`+=\other % avoid \+ for paranoia even though we've turned it off + % + % This is to support \ in node names and titles, since the \ + % characters end up in a \csname. It's easier than + % leaving it active and making its active definition an actual \ + % character. What I don't understand is why it works in the *value* + % of the xrdef. Seems like it should be a catcode12 \, and that + % should not typeset properly. But it works, so I'm moving on for + % now. --karl, 15jan04. + \catcode`\\=\other + % + % Make the characters 128-255 be printing characters. + {% + \count1=128 + \def\loop{% + \catcode\count1=\other + \advance\count1 by 1 + \ifnum \count1<256 \loop \fi + }% + }% + % + % @ is our escape character in .aux files, and we need braces. + \catcode`\{=1 + \catcode`\}=2 + \catcode`\@=0 +} + +\def\readdatafile#1{% +\begingroup + \setupdatafile + \input\jobname.#1 +\endgroup} + + +\message{insertions,} +% including footnotes. + +\newcount \footnoteno + +% The trailing space in the following definition for supereject is +% vital for proper filling; pages come out unaligned when you do a +% pagealignmacro call if that space before the closing brace is +% removed. (Generally, numeric constants should always be followed by a +% space to prevent strange expansion errors.) +\def\supereject{\par\penalty -20000\footnoteno =0 } + +% @footnotestyle is meaningful for info output only. +\let\footnotestyle=\comment + +{\catcode `\@=11 +% +% Auto-number footnotes. Otherwise like plain. +\gdef\footnote{% + \let\indent=\ptexindent + \let\noindent=\ptexnoindent + \global\advance\footnoteno by \@ne + \edef\thisfootno{$^{\the\footnoteno}$}% + % + % In case the footnote comes at the end of a sentence, preserve the + % extra spacing after we do the footnote number. + \let\@sf\empty + \ifhmode\edef\@sf{\spacefactor\the\spacefactor}\ptexslash\fi + % + % Remove inadvertent blank space before typesetting the footnote number. + \unskip + \thisfootno\@sf + \dofootnote +}% + +% Don't bother with the trickery in plain.tex to not require the +% footnote text as a parameter. Our footnotes don't need to be so general. +% +% Oh yes, they do; otherwise, @ifset (and anything else that uses +% \parseargline) fails inside footnotes because the tokens are fixed when +% the footnote is read. --karl, 16nov96. +% +\gdef\dofootnote{% + \insert\footins\bgroup + % We want to typeset this text as a normal paragraph, even if the + % footnote reference occurs in (for example) a display environment. + % So reset some parameters. + \hsize=\pagewidth + \interlinepenalty\interfootnotelinepenalty + \splittopskip\ht\strutbox % top baseline for broken footnotes + \splitmaxdepth\dp\strutbox + \floatingpenalty\@MM + \leftskip\z@skip + \rightskip\z@skip + \spaceskip\z@skip + \xspaceskip\z@skip + \parindent\defaultparindent + % + \smallfonts \rm + % + % Because we use hanging indentation in footnotes, a @noindent appears + % to exdent this text, so make it be a no-op. makeinfo does not use + % hanging indentation so @noindent can still be needed within footnote + % text after an @example or the like (not that this is good style). + \let\noindent = \relax + % + % Hang the footnote text off the number. Use \everypar in case the + % footnote extends for more than one paragraph. + \everypar = {\hang}% + \textindent{\thisfootno}% + % + % Don't crash into the line above the footnote text. Since this + % expands into a box, it must come within the paragraph, lest it + % provide a place where TeX can split the footnote. + \footstrut + \futurelet\next\fo@t +} +}%end \catcode `\@=11 + +% In case a @footnote appears in a vbox, save the footnote text and create +% the real \insert just after the vbox finished. Otherwise, the insertion +% would be lost. +% Similarly, if a @footnote appears inside an alignment, save the footnote +% text to a box and make the \insert when a row of the table is finished. +% And the same can be done for other insert classes. --kasal, 16nov03. + +% Replace the \insert primitive by a cheating macro. +% Deeper inside, just make sure that the saved insertions are not spilled +% out prematurely. +% +\def\startsavinginserts{% + \ifx \insert\ptexinsert + \let\insert\saveinsert + \else + \let\checkinserts\relax + \fi +} + +% This \insert replacement works for both \insert\footins{foo} and +% \insert\footins\bgroup foo\egroup, but it doesn't work for \insert27{foo}. +% +\def\saveinsert#1{% + \edef\next{\noexpand\savetobox \makeSAVEname#1}% + \afterassignment\next + % swallow the left brace + \let\temp = +} +\def\makeSAVEname#1{\makecsname{SAVE\expandafter\gobble\string#1}} +\def\savetobox#1{\global\setbox#1 = \vbox\bgroup \unvbox#1} + +\def\checksaveins#1{\ifvoid#1\else \placesaveins#1\fi} + +\def\placesaveins#1{% + \ptexinsert \csname\expandafter\gobblesave\string#1\endcsname + {\box#1}% +} + +% eat @SAVE -- beware, all of them have catcode \other: +{ + \def\dospecials{\do S\do A\do V\do E} \uncatcodespecials % ;-) + \gdef\gobblesave @SAVE{} +} + +% initialization: +\def\newsaveins #1{% + \edef\next{\noexpand\newsaveinsX \makeSAVEname#1}% + \next +} +\def\newsaveinsX #1{% + \csname newbox\endcsname #1% + \expandafter\def\expandafter\checkinserts\expandafter{\checkinserts + \checksaveins #1}% +} + +% initialize: +\let\checkinserts\empty +\newsaveins\footins +\newsaveins\margin + + +% @image. We use the macros from epsf.tex to support this. +% If epsf.tex is not installed and @image is used, we complain. +% +% Check for and read epsf.tex up front. If we read it only at @image +% time, we might be inside a group, and then its definitions would get +% undone and the next image would fail. +\openin 1 = epsf.tex +\ifeof 1 \else + % Do not bother showing banner with epsf.tex v2.7k (available in + % doc/epsf.tex and on ctan). + \def\epsfannounce{\toks0 = }% + \input epsf.tex +\fi +\closein 1 +% +% We will only complain once about lack of epsf.tex. +\newif\ifwarnednoepsf +\newhelp\noepsfhelp{epsf.tex must be installed for images to + work. It is also included in the Texinfo distribution, or you can get + it from ftp://tug.org/tex/epsf.tex.} +% +\def\image#1{% + \ifx\epsfbox\undefined + \ifwarnednoepsf \else + \errhelp = \noepsfhelp + \errmessage{epsf.tex not found, images will be ignored}% + \global\warnednoepsftrue + \fi + \else + \imagexxx #1,,,,,\finish + \fi +} +% +% Arguments to @image: +% #1 is (mandatory) image filename; we tack on .eps extension. +% #2 is (optional) width, #3 is (optional) height. +% #4 is (ignored optional) html alt text. +% #5 is (ignored optional) extension. +% #6 is just the usual extra ignored arg for parsing this stuff. +\newif\ifimagevmode +\def\imagexxx#1,#2,#3,#4,#5,#6\finish{\begingroup + \catcode`\^^M = 5 % in case we're inside an example + \normalturnoffactive % allow _ et al. in names + % If the image is by itself, center it. + \ifvmode + \imagevmodetrue + \nobreak\medskip + % Usually we'll have text after the image which will insert + % \parskip glue, so insert it here too to equalize the space + % above and below. + \nobreak\vskip\parskip + \nobreak + \fi + % + % Leave vertical mode so that indentation from an enclosing + % environment such as @quotation is respected. On the other hand, if + % it's at the top level, we don't want the normal paragraph indentation. + \noindent + % + % Output the image. + \ifpdf + \dopdfimage{#1}{#2}{#3}% + \else + % \epsfbox itself resets \epsf?size at each figure. + \setbox0 = \hbox{\ignorespaces #2}\ifdim\wd0 > 0pt \epsfxsize=#2\relax \fi + \setbox0 = \hbox{\ignorespaces #3}\ifdim\wd0 > 0pt \epsfysize=#3\relax \fi + \epsfbox{#1.eps}% + \fi + % + \ifimagevmode \medskip \fi % space after the standalone image +\endgroup} + + +% @float FLOATTYPE,LABEL,LOC ... @end float for displayed figures, tables, +% etc. We don't actually implement floating yet, we always include the +% float "here". But it seemed the best name for the future. +% +\envparseargdef\float{\eatcommaspace\eatcommaspace\dofloat#1, , ,\finish} + +% There may be a space before second and/or third parameter; delete it. +\def\eatcommaspace#1, {#1,} + +% #1 is the optional FLOATTYPE, the text label for this float, typically +% "Figure", "Table", "Example", etc. Can't contain commas. If omitted, +% this float will not be numbered and cannot be referred to. +% +% #2 is the optional xref label. Also must be present for the float to +% be referable. +% +% #3 is the optional positioning argument; for now, it is ignored. It +% will somehow specify the positions allowed to float to (here, top, bottom). +% +% We keep a separate counter for each FLOATTYPE, which we reset at each +% chapter-level command. +\let\resetallfloatnos=\empty +% +\def\dofloat#1,#2,#3,#4\finish{% + \let\thiscaption=\empty + \let\thisshortcaption=\empty + % + % don't lose footnotes inside @float. + % + % BEWARE: when the floats start float, we have to issue warning whenever an + % insert appears inside a float which could possibly float. --kasal, 26may04 + % + \startsavinginserts + % + % We can't be used inside a paragraph. + \par + % + \vtop\bgroup + \def\floattype{#1}% + \def\floatlabel{#2}% + \def\floatloc{#3}% we do nothing with this yet. + % + \ifx\floattype\empty + \let\safefloattype=\empty + \else + {% + % the floattype might have accents or other special characters, + % but we need to use it in a control sequence name. + \indexnofonts + \turnoffactive + \xdef\safefloattype{\floattype}% + }% + \fi + % + % If label is given but no type, we handle that as the empty type. + \ifx\floatlabel\empty \else + % We want each FLOATTYPE to be numbered separately (Figure 1, + % Table 1, Figure 2, ...). (And if no label, no number.) + % + \expandafter\getfloatno\csname\safefloattype floatno\endcsname + \global\advance\floatno by 1 + % + {% + % This magic value for \lastsection is output by \setref as the + % XREFLABEL-title value. \xrefX uses it to distinguish float + % labels (which have a completely different output format) from + % node and anchor labels. And \xrdef uses it to construct the + % lists of floats. + % + \edef\lastsection{\floatmagic=\safefloattype}% + \setref{\floatlabel}{Yfloat}% + }% + \fi + % + % start with \parskip glue, I guess. + \vskip\parskip + % + % Don't suppress indentation if a float happens to start a section. + \restorefirstparagraphindent +} + +% we have these possibilities: +% @float Foo,lbl & @caption{Cap}: Foo 1.1: Cap +% @float Foo,lbl & no caption: Foo 1.1 +% @float Foo & @caption{Cap}: Foo: Cap +% @float Foo & no caption: Foo +% @float ,lbl & Caption{Cap}: 1.1: Cap +% @float ,lbl & no caption: 1.1 +% @float & @caption{Cap}: Cap +% @float & no caption: +% +\def\Efloat{% + \let\floatident = \empty + % + % In all cases, if we have a float type, it comes first. + \ifx\floattype\empty \else \def\floatident{\floattype}\fi + % + % If we have an xref label, the number comes next. + \ifx\floatlabel\empty \else + \ifx\floattype\empty \else % if also had float type, need tie first. + \appendtomacro\floatident{\tie}% + \fi + % the number. + \appendtomacro\floatident{\chaplevelprefix\the\floatno}% + \fi + % + % Start the printed caption with what we've constructed in + % \floatident, but keep it separate; we need \floatident again. + \let\captionline = \floatident + % + \ifx\thiscaption\empty \else + \ifx\floatident\empty \else + \appendtomacro\captionline{: }% had ident, so need a colon between + \fi + % + % caption text. + \appendtomacro\captionline{\scanexp\thiscaption}% + \fi + % + % If we have anything to print, print it, with space before. + % Eventually this needs to become an \insert. + \ifx\captionline\empty \else + \vskip.5\parskip + \captionline + % + % Space below caption. + \vskip\parskip + \fi + % + % If have an xref label, write the list of floats info. Do this + % after the caption, to avoid chance of it being a breakpoint. + \ifx\floatlabel\empty \else + % Write the text that goes in the lof to the aux file as + % \floatlabel-lof. Besides \floatident, we include the short + % caption if specified, else the full caption if specified, else nothing. + {% + \atdummies + % + % since we read the caption text in the macro world, where ^^M + % is turned into a normal character, we have to scan it back, so + % we don't write the literal three characters "^^M" into the aux file. + \scanexp{% + \xdef\noexpand\gtemp{% + \ifx\thisshortcaption\empty + \thiscaption + \else + \thisshortcaption + \fi + }% + }% + \immediate\write\auxfile{@xrdef{\floatlabel-lof}{\floatident + \ifx\gtemp\empty \else : \gtemp \fi}}% + }% + \fi + \egroup % end of \vtop + % + % place the captured inserts + % + % BEWARE: when the floats start floating, we have to issue warning + % whenever an insert appears inside a float which could possibly + % float. --kasal, 26may04 + % + \checkinserts +} + +% Append the tokens #2 to the definition of macro #1, not expanding either. +% +\def\appendtomacro#1#2{% + \expandafter\def\expandafter#1\expandafter{#1#2}% +} + +% @caption, @shortcaption +% +\def\caption{\docaption\thiscaption} +\def\shortcaption{\docaption\thisshortcaption} +\def\docaption{\checkenv\float \bgroup\scanargctxt\defcaption} +\def\defcaption#1#2{\egroup \def#1{#2}} + +% The parameter is the control sequence identifying the counter we are +% going to use. Create it if it doesn't exist and assign it to \floatno. +\def\getfloatno#1{% + \ifx#1\relax + % Haven't seen this figure type before. + \csname newcount\endcsname #1% + % + % Remember to reset this floatno at the next chap. + \expandafter\gdef\expandafter\resetallfloatnos + \expandafter{\resetallfloatnos #1=0 }% + \fi + \let\floatno#1% +} + +% \setref calls this to get the XREFLABEL-snt value. We want an @xref +% to the FLOATLABEL to expand to "Figure 3.1". We call \setref when we +% first read the @float command. +% +\def\Yfloat{\floattype@tie \chaplevelprefix\the\floatno}% + +% Magic string used for the XREFLABEL-title value, so \xrefX can +% distinguish floats from other xref types. +\def\floatmagic{!!float!!} + +% #1 is the control sequence we are passed; we expand into a conditional +% which is true if #1 represents a float ref. That is, the magic +% \lastsection value which we \setref above. +% +\def\iffloat#1{\expandafter\doiffloat#1==\finish} +% +% #1 is (maybe) the \floatmagic string. If so, #2 will be the +% (safe) float type for this float. We set \iffloattype to #2. +% +\def\doiffloat#1=#2=#3\finish{% + \def\temp{#1}% + \def\iffloattype{#2}% + \ifx\temp\floatmagic +} + +% @listoffloats FLOATTYPE - print a list of floats like a table of contents. +% +\parseargdef\listoffloats{% + \def\floattype{#1}% floattype + {% + % the floattype might have accents or other special characters, + % but we need to use it in a control sequence name. + \indexnofonts + \turnoffactive + \xdef\safefloattype{\floattype}% + }% + % + % \xrdef saves the floats as a \do-list in \floatlistSAFEFLOATTYPE. + \expandafter\ifx\csname floatlist\safefloattype\endcsname \relax + \ifhavexrefs + % if the user said @listoffloats foo but never @float foo. + \message{\linenumber No `\safefloattype' floats to list.}% + \fi + \else + \begingroup + \leftskip=\tocindent % indent these entries like a toc + \let\do=\listoffloatsdo + \csname floatlist\safefloattype\endcsname + \endgroup + \fi +} + +% This is called on each entry in a list of floats. We're passed the +% xref label, in the form LABEL-title, which is how we save it in the +% aux file. We strip off the -title and look up \XRLABEL-lof, which +% has the text we're supposed to typeset here. +% +% Figures without xref labels will not be included in the list (since +% they won't appear in the aux file). +% +\def\listoffloatsdo#1{\listoffloatsdoentry#1\finish} +\def\listoffloatsdoentry#1-title\finish{{% + % Can't fully expand XR#1-lof because it can contain anything. Just + % pass the control sequence. On the other hand, XR#1-pg is just the + % page number, and we want to fully expand that so we can get a link + % in pdf output. + \toksA = \expandafter{\csname XR#1-lof\endcsname}% + % + % use the same \entry macro we use to generate the TOC and index. + \edef\writeentry{\noexpand\entry{\the\toksA}{\csname XR#1-pg\endcsname}}% + \writeentry +}} + + +\message{localization,} + +% For single-language documents, @documentlanguage is usually given very +% early, just after @documentencoding. Single argument is the language +% (de) or locale (de_DE) abbreviation. +% +{ + \catcode`\_ = \active + \globaldefs=1 +\parseargdef\documentlanguage{\begingroup + \let_=\normalunderscore % normal _ character for filenames + \tex % read txi-??.tex file in plain TeX. + % Read the file by the name they passed if it exists. + \openin 1 txi-#1.tex + \ifeof 1 + \documentlanguagetrywithoutunderscore{#1_\finish}% + \else + \globaldefs = 1 % everything in the txi-LL files needs to persist + \input txi-#1.tex + \fi + \closein 1 + \endgroup % end raw TeX +\endgroup} +% +% If they passed de_DE, and txi-de_DE.tex doesn't exist, +% try txi-de.tex. +% +\gdef\documentlanguagetrywithoutunderscore#1_#2\finish{% + \openin 1 txi-#1.tex + \ifeof 1 + \errhelp = \nolanghelp + \errmessage{Cannot read language file txi-#1.tex}% + \else + \globaldefs = 1 % everything in the txi-LL files needs to persist + \input txi-#1.tex + \fi + \closein 1 +} +}% end of special _ catcode +% +\newhelp\nolanghelp{The given language definition file cannot be found or +is empty. Maybe you need to install it? Putting it in the current +directory should work if nowhere else does.} + +% This macro is called from txi-??.tex files; the first argument is the +% \language name to set (without the "\lang@" prefix), the second and +% third args are \{left,right}hyphenmin. +% +% The language names to pass are determined when the format is built. +% See the etex.log file created at that time, e.g., +% /usr/local/texlive/2008/texmf-var/web2c/pdftex/etex.log. +% +% With TeX Live 2008, etex now includes hyphenation patterns for all +% available languages. This means we can support hyphenation in +% Texinfo, at least to some extent. (This still doesn't solve the +% accented characters problem.) +% +\catcode`@=11 +\def\txisetlanguage#1#2#3{% + % do not set the language if the name is undefined in the current TeX. + \expandafter\ifx\csname lang@#1\endcsname \relax + \message{no patterns for #1}% + \else + \global\language = \csname lang@#1\endcsname + \fi + % but there is no harm in adjusting the hyphenmin values regardless. + \global\lefthyphenmin = #2\relax + \global\righthyphenmin = #3\relax +} + +% Helpers for encodings. +% Set the catcode of characters 128 through 255 to the specified number. +% +\def\setnonasciicharscatcode#1{% + \count255=128 + \loop\ifnum\count255<256 + \global\catcode\count255=#1\relax + \advance\count255 by 1 + \repeat +} + +\def\setnonasciicharscatcodenonglobal#1{% + \count255=128 + \loop\ifnum\count255<256 + \catcode\count255=#1\relax + \advance\count255 by 1 + \repeat +} + +% @documentencoding sets the definition of non-ASCII characters +% according to the specified encoding. +% +\parseargdef\documentencoding{% + % Encoding being declared for the document. + \def\declaredencoding{\csname #1.enc\endcsname}% + % + % Supported encodings: names converted to tokens in order to be able + % to compare them with \ifx. + \def\ascii{\csname US-ASCII.enc\endcsname}% + \def\latnine{\csname ISO-8859-15.enc\endcsname}% + \def\latone{\csname ISO-8859-1.enc\endcsname}% + \def\lattwo{\csname ISO-8859-2.enc\endcsname}% + \def\utfeight{\csname UTF-8.enc\endcsname}% + % + \ifx \declaredencoding \ascii + \asciichardefs + % + \else \ifx \declaredencoding \lattwo + \setnonasciicharscatcode\active + \lattwochardefs + % + \else \ifx \declaredencoding \latone + \setnonasciicharscatcode\active + \latonechardefs + % + \else \ifx \declaredencoding \latnine + \setnonasciicharscatcode\active + \latninechardefs + % + \else \ifx \declaredencoding \utfeight + \setnonasciicharscatcode\active + \utfeightchardefs + % + \else + \message{Unknown document encoding #1, ignoring.}% + % + \fi % utfeight + \fi % latnine + \fi % latone + \fi % lattwo + \fi % ascii +} + +% A message to be logged when using a character that isn't available +% the default font encoding (OT1). +% +\def\missingcharmsg#1{\message{Character missing in OT1 encoding: #1.}} + +% Take account of \c (plain) vs. \, (Texinfo) difference. +\def\cedilla#1{\ifx\c\ptexc\c{#1}\else\,{#1}\fi} + +% First, make active non-ASCII characters in order for them to be +% correctly categorized when TeX reads the replacement text of +% macros containing the character definitions. +\setnonasciicharscatcode\active +% +% Latin1 (ISO-8859-1) character definitions. +\def\latonechardefs{% + \gdef^^a0{~} + \gdef^^a1{\exclamdown} + \gdef^^a2{\missingcharmsg{CENT SIGN}} + \gdef^^a3{{\pounds}} + \gdef^^a4{\missingcharmsg{CURRENCY SIGN}} + \gdef^^a5{\missingcharmsg{YEN SIGN}} + \gdef^^a6{\missingcharmsg{BROKEN BAR}} + \gdef^^a7{\S} + \gdef^^a8{\"{}} + \gdef^^a9{\copyright} + \gdef^^aa{\ordf} + \gdef^^ab{\guillemetleft} + \gdef^^ac{$\lnot$} + \gdef^^ad{\-} + \gdef^^ae{\registeredsymbol} + \gdef^^af{\={}} + % + \gdef^^b0{\textdegree} + \gdef^^b1{$\pm$} + \gdef^^b2{$^2$} + \gdef^^b3{$^3$} + \gdef^^b4{\'{}} + \gdef^^b5{$\mu$} + \gdef^^b6{\P} + % + \gdef^^b7{$^.$} + \gdef^^b8{\cedilla\ } + \gdef^^b9{$^1$} + \gdef^^ba{\ordm} + % + \gdef^^bb{\guilletright} + \gdef^^bc{$1\over4$} + \gdef^^bd{$1\over2$} + \gdef^^be{$3\over4$} + \gdef^^bf{\questiondown} + % + \gdef^^c0{\`A} + \gdef^^c1{\'A} + \gdef^^c2{\^A} + \gdef^^c3{\~A} + \gdef^^c4{\"A} + \gdef^^c5{\ringaccent A} + \gdef^^c6{\AE} + \gdef^^c7{\cedilla C} + \gdef^^c8{\`E} + \gdef^^c9{\'E} + \gdef^^ca{\^E} + \gdef^^cb{\"E} + \gdef^^cc{\`I} + \gdef^^cd{\'I} + \gdef^^ce{\^I} + \gdef^^cf{\"I} + % + \gdef^^d0{\DH} + \gdef^^d1{\~N} + \gdef^^d2{\`O} + \gdef^^d3{\'O} + \gdef^^d4{\^O} + \gdef^^d5{\~O} + \gdef^^d6{\"O} + \gdef^^d7{$\times$} + \gdef^^d8{\O} + \gdef^^d9{\`U} + \gdef^^da{\'U} + \gdef^^db{\^U} + \gdef^^dc{\"U} + \gdef^^dd{\'Y} + \gdef^^de{\TH} + \gdef^^df{\ss} + % + \gdef^^e0{\`a} + \gdef^^e1{\'a} + \gdef^^e2{\^a} + \gdef^^e3{\~a} + \gdef^^e4{\"a} + \gdef^^e5{\ringaccent a} + \gdef^^e6{\ae} + \gdef^^e7{\cedilla c} + \gdef^^e8{\`e} + \gdef^^e9{\'e} + \gdef^^ea{\^e} + \gdef^^eb{\"e} + \gdef^^ec{\`{\dotless i}} + \gdef^^ed{\'{\dotless i}} + \gdef^^ee{\^{\dotless i}} + \gdef^^ef{\"{\dotless i}} + % + \gdef^^f0{\dh} + \gdef^^f1{\~n} + \gdef^^f2{\`o} + \gdef^^f3{\'o} + \gdef^^f4{\^o} + \gdef^^f5{\~o} + \gdef^^f6{\"o} + \gdef^^f7{$\div$} + \gdef^^f8{\o} + \gdef^^f9{\`u} + \gdef^^fa{\'u} + \gdef^^fb{\^u} + \gdef^^fc{\"u} + \gdef^^fd{\'y} + \gdef^^fe{\th} + \gdef^^ff{\"y} +} + +% Latin9 (ISO-8859-15) encoding character definitions. +\def\latninechardefs{% + % Encoding is almost identical to Latin1. + \latonechardefs + % + \gdef^^a4{\euro} + \gdef^^a6{\v S} + \gdef^^a8{\v s} + \gdef^^b4{\v Z} + \gdef^^b8{\v z} + \gdef^^bc{\OE} + \gdef^^bd{\oe} + \gdef^^be{\"Y} +} + +% Latin2 (ISO-8859-2) character definitions. +\def\lattwochardefs{% + \gdef^^a0{~} + \gdef^^a1{\ogonek{A}} + \gdef^^a2{\u{}} + \gdef^^a3{\L} + \gdef^^a4{\missingcharmsg{CURRENCY SIGN}} + \gdef^^a5{\v L} + \gdef^^a6{\'S} + \gdef^^a7{\S} + \gdef^^a8{\"{}} + \gdef^^a9{\v S} + \gdef^^aa{\cedilla S} + \gdef^^ab{\v T} + \gdef^^ac{\'Z} + \gdef^^ad{\-} + \gdef^^ae{\v Z} + \gdef^^af{\dotaccent Z} + % + \gdef^^b0{\textdegree} + \gdef^^b1{\ogonek{a}} + \gdef^^b2{\ogonek{ }} + \gdef^^b3{\l} + \gdef^^b4{\'{}} + \gdef^^b5{\v l} + \gdef^^b6{\'s} + \gdef^^b7{\v{}} + \gdef^^b8{\cedilla\ } + \gdef^^b9{\v s} + \gdef^^ba{\cedilla s} + \gdef^^bb{\v t} + \gdef^^bc{\'z} + \gdef^^bd{\H{}} + \gdef^^be{\v z} + \gdef^^bf{\dotaccent z} + % + \gdef^^c0{\'R} + \gdef^^c1{\'A} + \gdef^^c2{\^A} + \gdef^^c3{\u A} + \gdef^^c4{\"A} + \gdef^^c5{\'L} + \gdef^^c6{\'C} + \gdef^^c7{\cedilla C} + \gdef^^c8{\v C} + \gdef^^c9{\'E} + \gdef^^ca{\ogonek{E}} + \gdef^^cb{\"E} + \gdef^^cc{\v E} + \gdef^^cd{\'I} + \gdef^^ce{\^I} + \gdef^^cf{\v D} + % + \gdef^^d0{\DH} + \gdef^^d1{\'N} + \gdef^^d2{\v N} + \gdef^^d3{\'O} + \gdef^^d4{\^O} + \gdef^^d5{\H O} + \gdef^^d6{\"O} + \gdef^^d7{$\times$} + \gdef^^d8{\v R} + \gdef^^d9{\ringaccent U} + \gdef^^da{\'U} + \gdef^^db{\H U} + \gdef^^dc{\"U} + \gdef^^dd{\'Y} + \gdef^^de{\cedilla T} + \gdef^^df{\ss} + % + \gdef^^e0{\'r} + \gdef^^e1{\'a} + \gdef^^e2{\^a} + \gdef^^e3{\u a} + \gdef^^e4{\"a} + \gdef^^e5{\'l} + \gdef^^e6{\'c} + \gdef^^e7{\cedilla c} + \gdef^^e8{\v c} + \gdef^^e9{\'e} + \gdef^^ea{\ogonek{e}} + \gdef^^eb{\"e} + \gdef^^ec{\v e} + \gdef^^ed{\'\i} + \gdef^^ee{\^\i} + \gdef^^ef{\v d} + % + \gdef^^f0{\dh} + \gdef^^f1{\'n} + \gdef^^f2{\v n} + \gdef^^f3{\'o} + \gdef^^f4{\^o} + \gdef^^f5{\H o} + \gdef^^f6{\"o} + \gdef^^f7{$\div$} + \gdef^^f8{\v r} + \gdef^^f9{\ringaccent u} + \gdef^^fa{\'u} + \gdef^^fb{\H u} + \gdef^^fc{\"u} + \gdef^^fd{\'y} + \gdef^^fe{\cedilla t} + \gdef^^ff{\dotaccent{}} +} + +% UTF-8 character definitions. +% +% This code to support UTF-8 is based on LaTeX's utf8.def, with some +% changes for Texinfo conventions. It is included here under the GPL by +% permission from Frank Mittelbach and the LaTeX team. +% +\newcount\countUTFx +\newcount\countUTFy +\newcount\countUTFz + +\gdef\UTFviiiTwoOctets#1#2{\expandafter + \UTFviiiDefined\csname u8:#1\string #2\endcsname} +% +\gdef\UTFviiiThreeOctets#1#2#3{\expandafter + \UTFviiiDefined\csname u8:#1\string #2\string #3\endcsname} +% +\gdef\UTFviiiFourOctets#1#2#3#4{\expandafter + \UTFviiiDefined\csname u8:#1\string #2\string #3\string #4\endcsname} + +\gdef\UTFviiiDefined#1{% + \ifx #1\relax + \message{\linenumber Unicode char \string #1 not defined for Texinfo}% + \else + \expandafter #1% + \fi +} + +\begingroup + \catcode`\~13 + \catcode`\"12 + + \def\UTFviiiLoop{% + \global\catcode\countUTFx\active + \uccode`\~\countUTFx + \uppercase\expandafter{\UTFviiiTmp}% + \advance\countUTFx by 1 + \ifnum\countUTFx < \countUTFy + \expandafter\UTFviiiLoop + \fi} + + \countUTFx = "C2 + \countUTFy = "E0 + \def\UTFviiiTmp{% + \xdef~{\noexpand\UTFviiiTwoOctets\string~}} + \UTFviiiLoop + + \countUTFx = "E0 + \countUTFy = "F0 + \def\UTFviiiTmp{% + \xdef~{\noexpand\UTFviiiThreeOctets\string~}} + \UTFviiiLoop + + \countUTFx = "F0 + \countUTFy = "F4 + \def\UTFviiiTmp{% + \xdef~{\noexpand\UTFviiiFourOctets\string~}} + \UTFviiiLoop +\endgroup + +\begingroup + \catcode`\"=12 + \catcode`\<=12 + \catcode`\.=12 + \catcode`\,=12 + \catcode`\;=12 + \catcode`\!=12 + \catcode`\~=13 + + \gdef\DeclareUnicodeCharacter#1#2{% + \countUTFz = "#1\relax + \wlog{\space\space defining Unicode char U+#1 (decimal \the\countUTFz)}% + \begingroup + \parseXMLCharref + \def\UTFviiiTwoOctets##1##2{% + \csname u8:##1\string ##2\endcsname}% + \def\UTFviiiThreeOctets##1##2##3{% + \csname u8:##1\string ##2\string ##3\endcsname}% + \def\UTFviiiFourOctets##1##2##3##4{% + \csname u8:##1\string ##2\string ##3\string ##4\endcsname}% + \expandafter\expandafter\expandafter\expandafter + \expandafter\expandafter\expandafter + \gdef\UTFviiiTmp{#2}% + \endgroup} + + \gdef\parseXMLCharref{% + \ifnum\countUTFz < "A0\relax + \errhelp = \EMsimple + \errmessage{Cannot define Unicode char value < 00A0}% + \else\ifnum\countUTFz < "800\relax + \parseUTFviiiA,% + \parseUTFviiiB C\UTFviiiTwoOctets.,% + \else\ifnum\countUTFz < "10000\relax + \parseUTFviiiA;% + \parseUTFviiiA,% + \parseUTFviiiB E\UTFviiiThreeOctets.{,;}% + \else + \parseUTFviiiA;% + \parseUTFviiiA,% + \parseUTFviiiA!% + \parseUTFviiiB F\UTFviiiFourOctets.{!,;}% + \fi\fi\fi + } + + \gdef\parseUTFviiiA#1{% + \countUTFx = \countUTFz + \divide\countUTFz by 64 + \countUTFy = \countUTFz + \multiply\countUTFz by 64 + \advance\countUTFx by -\countUTFz + \advance\countUTFx by 128 + \uccode `#1\countUTFx + \countUTFz = \countUTFy} + + \gdef\parseUTFviiiB#1#2#3#4{% + \advance\countUTFz by "#10\relax + \uccode `#3\countUTFz + \uppercase{\gdef\UTFviiiTmp{#2#3#4}}} +\endgroup + +\def\utfeightchardefs{% + \DeclareUnicodeCharacter{00A0}{\tie} + \DeclareUnicodeCharacter{00A1}{\exclamdown} + \DeclareUnicodeCharacter{00A3}{\pounds} + \DeclareUnicodeCharacter{00A8}{\"{ }} + \DeclareUnicodeCharacter{00A9}{\copyright} + \DeclareUnicodeCharacter{00AA}{\ordf} + \DeclareUnicodeCharacter{00AB}{\guillemetleft} + \DeclareUnicodeCharacter{00AD}{\-} + \DeclareUnicodeCharacter{00AE}{\registeredsymbol} + \DeclareUnicodeCharacter{00AF}{\={ }} + + \DeclareUnicodeCharacter{00B0}{\ringaccent{ }} + \DeclareUnicodeCharacter{00B4}{\'{ }} + \DeclareUnicodeCharacter{00B8}{\cedilla{ }} + \DeclareUnicodeCharacter{00BA}{\ordm} + \DeclareUnicodeCharacter{00BB}{\guillemetright} + \DeclareUnicodeCharacter{00BF}{\questiondown} + + \DeclareUnicodeCharacter{00C0}{\`A} + \DeclareUnicodeCharacter{00C1}{\'A} + \DeclareUnicodeCharacter{00C2}{\^A} + \DeclareUnicodeCharacter{00C3}{\~A} + \DeclareUnicodeCharacter{00C4}{\"A} + \DeclareUnicodeCharacter{00C5}{\AA} + \DeclareUnicodeCharacter{00C6}{\AE} + \DeclareUnicodeCharacter{00C7}{\cedilla{C}} + \DeclareUnicodeCharacter{00C8}{\`E} + \DeclareUnicodeCharacter{00C9}{\'E} + \DeclareUnicodeCharacter{00CA}{\^E} + \DeclareUnicodeCharacter{00CB}{\"E} + \DeclareUnicodeCharacter{00CC}{\`I} + \DeclareUnicodeCharacter{00CD}{\'I} + \DeclareUnicodeCharacter{00CE}{\^I} + \DeclareUnicodeCharacter{00CF}{\"I} + + \DeclareUnicodeCharacter{00D0}{\DH} + \DeclareUnicodeCharacter{00D1}{\~N} + \DeclareUnicodeCharacter{00D2}{\`O} + \DeclareUnicodeCharacter{00D3}{\'O} + \DeclareUnicodeCharacter{00D4}{\^O} + \DeclareUnicodeCharacter{00D5}{\~O} + \DeclareUnicodeCharacter{00D6}{\"O} + \DeclareUnicodeCharacter{00D8}{\O} + \DeclareUnicodeCharacter{00D9}{\`U} + \DeclareUnicodeCharacter{00DA}{\'U} + \DeclareUnicodeCharacter{00DB}{\^U} + \DeclareUnicodeCharacter{00DC}{\"U} + \DeclareUnicodeCharacter{00DD}{\'Y} + \DeclareUnicodeCharacter{00DE}{\TH} + \DeclareUnicodeCharacter{00DF}{\ss} + + \DeclareUnicodeCharacter{00E0}{\`a} + \DeclareUnicodeCharacter{00E1}{\'a} + \DeclareUnicodeCharacter{00E2}{\^a} + \DeclareUnicodeCharacter{00E3}{\~a} + \DeclareUnicodeCharacter{00E4}{\"a} + \DeclareUnicodeCharacter{00E5}{\aa} + \DeclareUnicodeCharacter{00E6}{\ae} + \DeclareUnicodeCharacter{00E7}{\cedilla{c}} + \DeclareUnicodeCharacter{00E8}{\`e} + \DeclareUnicodeCharacter{00E9}{\'e} + \DeclareUnicodeCharacter{00EA}{\^e} + \DeclareUnicodeCharacter{00EB}{\"e} + \DeclareUnicodeCharacter{00EC}{\`{\dotless{i}}} + \DeclareUnicodeCharacter{00ED}{\'{\dotless{i}}} + \DeclareUnicodeCharacter{00EE}{\^{\dotless{i}}} + \DeclareUnicodeCharacter{00EF}{\"{\dotless{i}}} + + \DeclareUnicodeCharacter{00F0}{\dh} + \DeclareUnicodeCharacter{00F1}{\~n} + \DeclareUnicodeCharacter{00F2}{\`o} + \DeclareUnicodeCharacter{00F3}{\'o} + \DeclareUnicodeCharacter{00F4}{\^o} + \DeclareUnicodeCharacter{00F5}{\~o} + \DeclareUnicodeCharacter{00F6}{\"o} + \DeclareUnicodeCharacter{00F8}{\o} + \DeclareUnicodeCharacter{00F9}{\`u} + \DeclareUnicodeCharacter{00FA}{\'u} + \DeclareUnicodeCharacter{00FB}{\^u} + \DeclareUnicodeCharacter{00FC}{\"u} + \DeclareUnicodeCharacter{00FD}{\'y} + \DeclareUnicodeCharacter{00FE}{\th} + \DeclareUnicodeCharacter{00FF}{\"y} + + \DeclareUnicodeCharacter{0100}{\=A} + \DeclareUnicodeCharacter{0101}{\=a} + \DeclareUnicodeCharacter{0102}{\u{A}} + \DeclareUnicodeCharacter{0103}{\u{a}} + \DeclareUnicodeCharacter{0104}{\ogonek{A}} + \DeclareUnicodeCharacter{0105}{\ogonek{a}} + \DeclareUnicodeCharacter{0106}{\'C} + \DeclareUnicodeCharacter{0107}{\'c} + \DeclareUnicodeCharacter{0108}{\^C} + \DeclareUnicodeCharacter{0109}{\^c} + \DeclareUnicodeCharacter{0118}{\ogonek{E}} + \DeclareUnicodeCharacter{0119}{\ogonek{e}} + \DeclareUnicodeCharacter{010A}{\dotaccent{C}} + \DeclareUnicodeCharacter{010B}{\dotaccent{c}} + \DeclareUnicodeCharacter{010C}{\v{C}} + \DeclareUnicodeCharacter{010D}{\v{c}} + \DeclareUnicodeCharacter{010E}{\v{D}} + + \DeclareUnicodeCharacter{0112}{\=E} + \DeclareUnicodeCharacter{0113}{\=e} + \DeclareUnicodeCharacter{0114}{\u{E}} + \DeclareUnicodeCharacter{0115}{\u{e}} + \DeclareUnicodeCharacter{0116}{\dotaccent{E}} + \DeclareUnicodeCharacter{0117}{\dotaccent{e}} + \DeclareUnicodeCharacter{011A}{\v{E}} + \DeclareUnicodeCharacter{011B}{\v{e}} + \DeclareUnicodeCharacter{011C}{\^G} + \DeclareUnicodeCharacter{011D}{\^g} + \DeclareUnicodeCharacter{011E}{\u{G}} + \DeclareUnicodeCharacter{011F}{\u{g}} + + \DeclareUnicodeCharacter{0120}{\dotaccent{G}} + \DeclareUnicodeCharacter{0121}{\dotaccent{g}} + \DeclareUnicodeCharacter{0124}{\^H} + \DeclareUnicodeCharacter{0125}{\^h} + \DeclareUnicodeCharacter{0128}{\~I} + \DeclareUnicodeCharacter{0129}{\~{\dotless{i}}} + \DeclareUnicodeCharacter{012A}{\=I} + \DeclareUnicodeCharacter{012B}{\={\dotless{i}}} + \DeclareUnicodeCharacter{012C}{\u{I}} + \DeclareUnicodeCharacter{012D}{\u{\dotless{i}}} + + \DeclareUnicodeCharacter{0130}{\dotaccent{I}} + \DeclareUnicodeCharacter{0131}{\dotless{i}} + \DeclareUnicodeCharacter{0132}{IJ} + \DeclareUnicodeCharacter{0133}{ij} + \DeclareUnicodeCharacter{0134}{\^J} + \DeclareUnicodeCharacter{0135}{\^{\dotless{j}}} + \DeclareUnicodeCharacter{0139}{\'L} + \DeclareUnicodeCharacter{013A}{\'l} + + \DeclareUnicodeCharacter{0141}{\L} + \DeclareUnicodeCharacter{0142}{\l} + \DeclareUnicodeCharacter{0143}{\'N} + \DeclareUnicodeCharacter{0144}{\'n} + \DeclareUnicodeCharacter{0147}{\v{N}} + \DeclareUnicodeCharacter{0148}{\v{n}} + \DeclareUnicodeCharacter{014C}{\=O} + \DeclareUnicodeCharacter{014D}{\=o} + \DeclareUnicodeCharacter{014E}{\u{O}} + \DeclareUnicodeCharacter{014F}{\u{o}} + + \DeclareUnicodeCharacter{0150}{\H{O}} + \DeclareUnicodeCharacter{0151}{\H{o}} + \DeclareUnicodeCharacter{0152}{\OE} + \DeclareUnicodeCharacter{0153}{\oe} + \DeclareUnicodeCharacter{0154}{\'R} + \DeclareUnicodeCharacter{0155}{\'r} + \DeclareUnicodeCharacter{0158}{\v{R}} + \DeclareUnicodeCharacter{0159}{\v{r}} + \DeclareUnicodeCharacter{015A}{\'S} + \DeclareUnicodeCharacter{015B}{\'s} + \DeclareUnicodeCharacter{015C}{\^S} + \DeclareUnicodeCharacter{015D}{\^s} + \DeclareUnicodeCharacter{015E}{\cedilla{S}} + \DeclareUnicodeCharacter{015F}{\cedilla{s}} + + \DeclareUnicodeCharacter{0160}{\v{S}} + \DeclareUnicodeCharacter{0161}{\v{s}} + \DeclareUnicodeCharacter{0162}{\cedilla{t}} + \DeclareUnicodeCharacter{0163}{\cedilla{T}} + \DeclareUnicodeCharacter{0164}{\v{T}} + + \DeclareUnicodeCharacter{0168}{\~U} + \DeclareUnicodeCharacter{0169}{\~u} + \DeclareUnicodeCharacter{016A}{\=U} + \DeclareUnicodeCharacter{016B}{\=u} + \DeclareUnicodeCharacter{016C}{\u{U}} + \DeclareUnicodeCharacter{016D}{\u{u}} + \DeclareUnicodeCharacter{016E}{\ringaccent{U}} + \DeclareUnicodeCharacter{016F}{\ringaccent{u}} + + \DeclareUnicodeCharacter{0170}{\H{U}} + \DeclareUnicodeCharacter{0171}{\H{u}} + \DeclareUnicodeCharacter{0174}{\^W} + \DeclareUnicodeCharacter{0175}{\^w} + \DeclareUnicodeCharacter{0176}{\^Y} + \DeclareUnicodeCharacter{0177}{\^y} + \DeclareUnicodeCharacter{0178}{\"Y} + \DeclareUnicodeCharacter{0179}{\'Z} + \DeclareUnicodeCharacter{017A}{\'z} + \DeclareUnicodeCharacter{017B}{\dotaccent{Z}} + \DeclareUnicodeCharacter{017C}{\dotaccent{z}} + \DeclareUnicodeCharacter{017D}{\v{Z}} + \DeclareUnicodeCharacter{017E}{\v{z}} + + \DeclareUnicodeCharacter{01C4}{D\v{Z}} + \DeclareUnicodeCharacter{01C5}{D\v{z}} + \DeclareUnicodeCharacter{01C6}{d\v{z}} + \DeclareUnicodeCharacter{01C7}{LJ} + \DeclareUnicodeCharacter{01C8}{Lj} + \DeclareUnicodeCharacter{01C9}{lj} + \DeclareUnicodeCharacter{01CA}{NJ} + \DeclareUnicodeCharacter{01CB}{Nj} + \DeclareUnicodeCharacter{01CC}{nj} + \DeclareUnicodeCharacter{01CD}{\v{A}} + \DeclareUnicodeCharacter{01CE}{\v{a}} + \DeclareUnicodeCharacter{01CF}{\v{I}} + + \DeclareUnicodeCharacter{01D0}{\v{\dotless{i}}} + \DeclareUnicodeCharacter{01D1}{\v{O}} + \DeclareUnicodeCharacter{01D2}{\v{o}} + \DeclareUnicodeCharacter{01D3}{\v{U}} + \DeclareUnicodeCharacter{01D4}{\v{u}} + + \DeclareUnicodeCharacter{01E2}{\={\AE}} + \DeclareUnicodeCharacter{01E3}{\={\ae}} + \DeclareUnicodeCharacter{01E6}{\v{G}} + \DeclareUnicodeCharacter{01E7}{\v{g}} + \DeclareUnicodeCharacter{01E8}{\v{K}} + \DeclareUnicodeCharacter{01E9}{\v{k}} + + \DeclareUnicodeCharacter{01F0}{\v{\dotless{j}}} + \DeclareUnicodeCharacter{01F1}{DZ} + \DeclareUnicodeCharacter{01F2}{Dz} + \DeclareUnicodeCharacter{01F3}{dz} + \DeclareUnicodeCharacter{01F4}{\'G} + \DeclareUnicodeCharacter{01F5}{\'g} + \DeclareUnicodeCharacter{01F8}{\`N} + \DeclareUnicodeCharacter{01F9}{\`n} + \DeclareUnicodeCharacter{01FC}{\'{\AE}} + \DeclareUnicodeCharacter{01FD}{\'{\ae}} + \DeclareUnicodeCharacter{01FE}{\'{\O}} + \DeclareUnicodeCharacter{01FF}{\'{\o}} + + \DeclareUnicodeCharacter{021E}{\v{H}} + \DeclareUnicodeCharacter{021F}{\v{h}} + + \DeclareUnicodeCharacter{0226}{\dotaccent{A}} + \DeclareUnicodeCharacter{0227}{\dotaccent{a}} + \DeclareUnicodeCharacter{0228}{\cedilla{E}} + \DeclareUnicodeCharacter{0229}{\cedilla{e}} + \DeclareUnicodeCharacter{022E}{\dotaccent{O}} + \DeclareUnicodeCharacter{022F}{\dotaccent{o}} + + \DeclareUnicodeCharacter{0232}{\=Y} + \DeclareUnicodeCharacter{0233}{\=y} + \DeclareUnicodeCharacter{0237}{\dotless{j}} + + \DeclareUnicodeCharacter{02DB}{\ogonek{ }} + + \DeclareUnicodeCharacter{1E02}{\dotaccent{B}} + \DeclareUnicodeCharacter{1E03}{\dotaccent{b}} + \DeclareUnicodeCharacter{1E04}{\udotaccent{B}} + \DeclareUnicodeCharacter{1E05}{\udotaccent{b}} + \DeclareUnicodeCharacter{1E06}{\ubaraccent{B}} + \DeclareUnicodeCharacter{1E07}{\ubaraccent{b}} + \DeclareUnicodeCharacter{1E0A}{\dotaccent{D}} + \DeclareUnicodeCharacter{1E0B}{\dotaccent{d}} + \DeclareUnicodeCharacter{1E0C}{\udotaccent{D}} + \DeclareUnicodeCharacter{1E0D}{\udotaccent{d}} + \DeclareUnicodeCharacter{1E0E}{\ubaraccent{D}} + \DeclareUnicodeCharacter{1E0F}{\ubaraccent{d}} + + \DeclareUnicodeCharacter{1E1E}{\dotaccent{F}} + \DeclareUnicodeCharacter{1E1F}{\dotaccent{f}} + + \DeclareUnicodeCharacter{1E20}{\=G} + \DeclareUnicodeCharacter{1E21}{\=g} + \DeclareUnicodeCharacter{1E22}{\dotaccent{H}} + \DeclareUnicodeCharacter{1E23}{\dotaccent{h}} + \DeclareUnicodeCharacter{1E24}{\udotaccent{H}} + \DeclareUnicodeCharacter{1E25}{\udotaccent{h}} + \DeclareUnicodeCharacter{1E26}{\"H} + \DeclareUnicodeCharacter{1E27}{\"h} + + \DeclareUnicodeCharacter{1E30}{\'K} + \DeclareUnicodeCharacter{1E31}{\'k} + \DeclareUnicodeCharacter{1E32}{\udotaccent{K}} + \DeclareUnicodeCharacter{1E33}{\udotaccent{k}} + \DeclareUnicodeCharacter{1E34}{\ubaraccent{K}} + \DeclareUnicodeCharacter{1E35}{\ubaraccent{k}} + \DeclareUnicodeCharacter{1E36}{\udotaccent{L}} + \DeclareUnicodeCharacter{1E37}{\udotaccent{l}} + \DeclareUnicodeCharacter{1E3A}{\ubaraccent{L}} + \DeclareUnicodeCharacter{1E3B}{\ubaraccent{l}} + \DeclareUnicodeCharacter{1E3E}{\'M} + \DeclareUnicodeCharacter{1E3F}{\'m} + + \DeclareUnicodeCharacter{1E40}{\dotaccent{M}} + \DeclareUnicodeCharacter{1E41}{\dotaccent{m}} + \DeclareUnicodeCharacter{1E42}{\udotaccent{M}} + \DeclareUnicodeCharacter{1E43}{\udotaccent{m}} + \DeclareUnicodeCharacter{1E44}{\dotaccent{N}} + \DeclareUnicodeCharacter{1E45}{\dotaccent{n}} + \DeclareUnicodeCharacter{1E46}{\udotaccent{N}} + \DeclareUnicodeCharacter{1E47}{\udotaccent{n}} + \DeclareUnicodeCharacter{1E48}{\ubaraccent{N}} + \DeclareUnicodeCharacter{1E49}{\ubaraccent{n}} + + \DeclareUnicodeCharacter{1E54}{\'P} + \DeclareUnicodeCharacter{1E55}{\'p} + \DeclareUnicodeCharacter{1E56}{\dotaccent{P}} + \DeclareUnicodeCharacter{1E57}{\dotaccent{p}} + \DeclareUnicodeCharacter{1E58}{\dotaccent{R}} + \DeclareUnicodeCharacter{1E59}{\dotaccent{r}} + \DeclareUnicodeCharacter{1E5A}{\udotaccent{R}} + \DeclareUnicodeCharacter{1E5B}{\udotaccent{r}} + \DeclareUnicodeCharacter{1E5E}{\ubaraccent{R}} + \DeclareUnicodeCharacter{1E5F}{\ubaraccent{r}} + + \DeclareUnicodeCharacter{1E60}{\dotaccent{S}} + \DeclareUnicodeCharacter{1E61}{\dotaccent{s}} + \DeclareUnicodeCharacter{1E62}{\udotaccent{S}} + \DeclareUnicodeCharacter{1E63}{\udotaccent{s}} + \DeclareUnicodeCharacter{1E6A}{\dotaccent{T}} + \DeclareUnicodeCharacter{1E6B}{\dotaccent{t}} + \DeclareUnicodeCharacter{1E6C}{\udotaccent{T}} + \DeclareUnicodeCharacter{1E6D}{\udotaccent{t}} + \DeclareUnicodeCharacter{1E6E}{\ubaraccent{T}} + \DeclareUnicodeCharacter{1E6F}{\ubaraccent{t}} + + \DeclareUnicodeCharacter{1E7C}{\~V} + \DeclareUnicodeCharacter{1E7D}{\~v} + \DeclareUnicodeCharacter{1E7E}{\udotaccent{V}} + \DeclareUnicodeCharacter{1E7F}{\udotaccent{v}} + + \DeclareUnicodeCharacter{1E80}{\`W} + \DeclareUnicodeCharacter{1E81}{\`w} + \DeclareUnicodeCharacter{1E82}{\'W} + \DeclareUnicodeCharacter{1E83}{\'w} + \DeclareUnicodeCharacter{1E84}{\"W} + \DeclareUnicodeCharacter{1E85}{\"w} + \DeclareUnicodeCharacter{1E86}{\dotaccent{W}} + \DeclareUnicodeCharacter{1E87}{\dotaccent{w}} + \DeclareUnicodeCharacter{1E88}{\udotaccent{W}} + \DeclareUnicodeCharacter{1E89}{\udotaccent{w}} + \DeclareUnicodeCharacter{1E8A}{\dotaccent{X}} + \DeclareUnicodeCharacter{1E8B}{\dotaccent{x}} + \DeclareUnicodeCharacter{1E8C}{\"X} + \DeclareUnicodeCharacter{1E8D}{\"x} + \DeclareUnicodeCharacter{1E8E}{\dotaccent{Y}} + \DeclareUnicodeCharacter{1E8F}{\dotaccent{y}} + + \DeclareUnicodeCharacter{1E90}{\^Z} + \DeclareUnicodeCharacter{1E91}{\^z} + \DeclareUnicodeCharacter{1E92}{\udotaccent{Z}} + \DeclareUnicodeCharacter{1E93}{\udotaccent{z}} + \DeclareUnicodeCharacter{1E94}{\ubaraccent{Z}} + \DeclareUnicodeCharacter{1E95}{\ubaraccent{z}} + \DeclareUnicodeCharacter{1E96}{\ubaraccent{h}} + \DeclareUnicodeCharacter{1E97}{\"t} + \DeclareUnicodeCharacter{1E98}{\ringaccent{w}} + \DeclareUnicodeCharacter{1E99}{\ringaccent{y}} + + \DeclareUnicodeCharacter{1EA0}{\udotaccent{A}} + \DeclareUnicodeCharacter{1EA1}{\udotaccent{a}} + + \DeclareUnicodeCharacter{1EB8}{\udotaccent{E}} + \DeclareUnicodeCharacter{1EB9}{\udotaccent{e}} + \DeclareUnicodeCharacter{1EBC}{\~E} + \DeclareUnicodeCharacter{1EBD}{\~e} + + \DeclareUnicodeCharacter{1ECA}{\udotaccent{I}} + \DeclareUnicodeCharacter{1ECB}{\udotaccent{i}} + \DeclareUnicodeCharacter{1ECC}{\udotaccent{O}} + \DeclareUnicodeCharacter{1ECD}{\udotaccent{o}} + + \DeclareUnicodeCharacter{1EE4}{\udotaccent{U}} + \DeclareUnicodeCharacter{1EE5}{\udotaccent{u}} + + \DeclareUnicodeCharacter{1EF2}{\`Y} + \DeclareUnicodeCharacter{1EF3}{\`y} + \DeclareUnicodeCharacter{1EF4}{\udotaccent{Y}} + + \DeclareUnicodeCharacter{1EF8}{\~Y} + \DeclareUnicodeCharacter{1EF9}{\~y} + + \DeclareUnicodeCharacter{2013}{--} + \DeclareUnicodeCharacter{2014}{---} + \DeclareUnicodeCharacter{2018}{\quoteleft} + \DeclareUnicodeCharacter{2019}{\quoteright} + \DeclareUnicodeCharacter{201A}{\quotesinglbase} + \DeclareUnicodeCharacter{201C}{\quotedblleft} + \DeclareUnicodeCharacter{201D}{\quotedblright} + \DeclareUnicodeCharacter{201E}{\quotedblbase} + \DeclareUnicodeCharacter{2022}{\bullet} + \DeclareUnicodeCharacter{2026}{\dots} + \DeclareUnicodeCharacter{2039}{\guilsinglleft} + \DeclareUnicodeCharacter{203A}{\guilsinglright} + \DeclareUnicodeCharacter{20AC}{\euro} + + \DeclareUnicodeCharacter{2192}{\expansion} + \DeclareUnicodeCharacter{21D2}{\result} + + \DeclareUnicodeCharacter{2212}{\minus} + \DeclareUnicodeCharacter{2217}{\point} + \DeclareUnicodeCharacter{2261}{\equiv} +}% end of \utfeightchardefs + + +% US-ASCII character definitions. +\def\asciichardefs{% nothing need be done + \relax +} + +% Make non-ASCII characters printable again for compatibility with +% existing Texinfo documents that may use them, even without declaring a +% document encoding. +% +\setnonasciicharscatcode \other + + +\message{formatting,} + +\newdimen\defaultparindent \defaultparindent = 15pt + +\chapheadingskip = 15pt plus 4pt minus 2pt +\secheadingskip = 12pt plus 3pt minus 2pt +\subsecheadingskip = 9pt plus 2pt minus 2pt + +% Prevent underfull vbox error messages. +\vbadness = 10000 + +% Don't be so finicky about underfull hboxes, either. +\hbadness = 2000 + +% Following George Bush, get rid of widows and orphans. +\widowpenalty=10000 +\clubpenalty=10000 + +% Use TeX 3.0's \emergencystretch to help line breaking, but if we're +% using an old version of TeX, don't do anything. We want the amount of +% stretch added to depend on the line length, hence the dependence on +% \hsize. We call this whenever the paper size is set. +% +\def\setemergencystretch{% + \ifx\emergencystretch\thisisundefined + % Allow us to assign to \emergencystretch anyway. + \def\emergencystretch{\dimen0}% + \else + \emergencystretch = .15\hsize + \fi +} + +% Parameters in order: 1) textheight; 2) textwidth; +% 3) voffset; 4) hoffset; 5) binding offset; 6) topskip; +% 7) physical page height; 8) physical page width. +% +% We also call \setleading{\textleading}, so the caller should define +% \textleading. The caller should also set \parskip. +% +\def\internalpagesizes#1#2#3#4#5#6#7#8{% + \voffset = #3\relax + \topskip = #6\relax + \splittopskip = \topskip + % + \vsize = #1\relax + \advance\vsize by \topskip + \outervsize = \vsize + \advance\outervsize by 2\topandbottommargin + \pageheight = \vsize + % + \hsize = #2\relax + \outerhsize = \hsize + \advance\outerhsize by 0.5in + \pagewidth = \hsize + % + \normaloffset = #4\relax + \bindingoffset = #5\relax + % + \ifpdf + \pdfpageheight #7\relax + \pdfpagewidth #8\relax + % if we don't reset these, they will remain at "1 true in" of + % whatever layout pdftex was dumped with. + \pdfhorigin = 1 true in + \pdfvorigin = 1 true in + \fi + % + \setleading{\textleading} + % + \parindent = \defaultparindent + \setemergencystretch +} + +% @letterpaper (the default). +\def\letterpaper{{\globaldefs = 1 + \parskip = 3pt plus 2pt minus 1pt + \textleading = 13.2pt + % + % If page is nothing but text, make it come out even. + \internalpagesizes{607.2pt}{6in}% that's 46 lines + {\voffset}{.25in}% + {\bindingoffset}{36pt}% + {11in}{8.5in}% +}} + +% Use @smallbook to reset parameters for 7x9.25 trim size. +\def\smallbook{{\globaldefs = 1 + \parskip = 2pt plus 1pt + \textleading = 12pt + % + \internalpagesizes{7.5in}{5in}% + {-.2in}{0in}% + {\bindingoffset}{16pt}% + {9.25in}{7in}% + % + \lispnarrowing = 0.3in + \tolerance = 700 + \hfuzz = 1pt + \contentsrightmargin = 0pt + \defbodyindent = .5cm +}} + +% Use @smallerbook to reset parameters for 6x9 trim size. +% (Just testing, parameters still in flux.) +\def\smallerbook{{\globaldefs = 1 + \parskip = 1.5pt plus 1pt + \textleading = 12pt + % + \internalpagesizes{7.4in}{4.8in}% + {-.2in}{-.4in}% + {0pt}{14pt}% + {9in}{6in}% + % + \lispnarrowing = 0.25in + \tolerance = 700 + \hfuzz = 1pt + \contentsrightmargin = 0pt + \defbodyindent = .4cm +}} + +% Use @afourpaper to print on European A4 paper. +\def\afourpaper{{\globaldefs = 1 + \parskip = 3pt plus 2pt minus 1pt + \textleading = 13.2pt + % + % Double-side printing via postscript on Laserjet 4050 + % prints double-sided nicely when \bindingoffset=10mm and \hoffset=-6mm. + % To change the settings for a different printer or situation, adjust + % \normaloffset until the front-side and back-side texts align. Then + % do the same for \bindingoffset. You can set these for testing in + % your texinfo source file like this: + % @tex + % \global\normaloffset = -6mm + % \global\bindingoffset = 10mm + % @end tex + \internalpagesizes{673.2pt}{160mm}% that's 51 lines + {\voffset}{\hoffset}% + {\bindingoffset}{44pt}% + {297mm}{210mm}% + % + \tolerance = 700 + \hfuzz = 1pt + \contentsrightmargin = 0pt + \defbodyindent = 5mm +}} + +% Use @afivepaper to print on European A5 paper. +% From romildo@urano.iceb.ufop.br, 2 July 2000. +% He also recommends making @example and @lisp be small. +\def\afivepaper{{\globaldefs = 1 + \parskip = 2pt plus 1pt minus 0.1pt + \textleading = 12.5pt + % + \internalpagesizes{160mm}{120mm}% + {\voffset}{\hoffset}% + {\bindingoffset}{8pt}% + {210mm}{148mm}% + % + \lispnarrowing = 0.2in + \tolerance = 800 + \hfuzz = 1.2pt + \contentsrightmargin = 0pt + \defbodyindent = 2mm + \tableindent = 12mm +}} + +% A specific text layout, 24x15cm overall, intended for A4 paper. +\def\afourlatex{{\globaldefs = 1 + \afourpaper + \internalpagesizes{237mm}{150mm}% + {\voffset}{4.6mm}% + {\bindingoffset}{7mm}% + {297mm}{210mm}% + % + % Must explicitly reset to 0 because we call \afourpaper. + \globaldefs = 0 +}} + +% Use @afourwide to print on A4 paper in landscape format. +\def\afourwide{{\globaldefs = 1 + \afourpaper + \internalpagesizes{241mm}{165mm}% + {\voffset}{-2.95mm}% + {\bindingoffset}{7mm}% + {297mm}{210mm}% + \globaldefs = 0 +}} + +% @pagesizes TEXTHEIGHT[,TEXTWIDTH] +% Perhaps we should allow setting the margins, \topskip, \parskip, +% and/or leading, also. Or perhaps we should compute them somehow. +% +\parseargdef\pagesizes{\pagesizesyyy #1,,\finish} +\def\pagesizesyyy#1,#2,#3\finish{{% + \setbox0 = \hbox{\ignorespaces #2}\ifdim\wd0 > 0pt \hsize=#2\relax \fi + \globaldefs = 1 + % + \parskip = 3pt plus 2pt minus 1pt + \setleading{\textleading}% + % + \dimen0 = #1\relax + \advance\dimen0 by \voffset + % + \dimen2 = \hsize + \advance\dimen2 by \normaloffset + % + \internalpagesizes{#1}{\hsize}% + {\voffset}{\normaloffset}% + {\bindingoffset}{44pt}% + {\dimen0}{\dimen2}% +}} + +% Set default to letter. +% +\letterpaper + + +\message{and turning on texinfo input format.} + +% DEL is a comment character, in case @c does not suffice. +\catcode`\^^? = 14 + +% Define macros to output various characters with catcode for normal text. +\catcode`\"=\other +\catcode`\~=\other +\catcode`\^=\other +\catcode`\_=\other +\catcode`\|=\other +\catcode`\<=\other +\catcode`\>=\other +\catcode`\+=\other +\catcode`\$=\other +\def\normaldoublequote{"} +\def\normaltilde{~} +\def\normalcaret{^} +\def\normalunderscore{_} +\def\normalverticalbar{|} +\def\normalless{<} +\def\normalgreater{>} +\def\normalplus{+} +\def\normaldollar{$}%$ font-lock fix + +% This macro is used to make a character print one way in \tt +% (where it can probably be output as-is), and another way in other fonts, +% where something hairier probably needs to be done. +% +% #1 is what to print if we are indeed using \tt; #2 is what to print +% otherwise. Since all the Computer Modern typewriter fonts have zero +% interword stretch (and shrink), and it is reasonable to expect all +% typewriter fonts to have this, we can check that font parameter. +% +\def\ifusingtt#1#2{\ifdim \fontdimen3\font=0pt #1\else #2\fi} + +% Same as above, but check for italic font. Actually this also catches +% non-italic slanted fonts since it is impossible to distinguish them from +% italic fonts. But since this is only used by $ and it uses \sl anyway +% this is not a problem. +\def\ifusingit#1#2{\ifdim \fontdimen1\font>0pt #1\else #2\fi} + +% Turn off all special characters except @ +% (and those which the user can use as if they were ordinary). +% Most of these we simply print from the \tt font, but for some, we can +% use math or other variants that look better in normal text. + +\catcode`\"=\active +\def\activedoublequote{{\tt\char34}} +\let"=\activedoublequote +\catcode`\~=\active +\def~{{\tt\char126}} +\chardef\hat=`\^ +\catcode`\^=\active +\def^{{\tt \hat}} + +\catcode`\_=\active +\def_{\ifusingtt\normalunderscore\_} +\let\realunder=_ +% Subroutine for the previous macro. +\def\_{\leavevmode \kern.07em \vbox{\hrule width.3em height.1ex}\kern .07em } + +\catcode`\|=\active +\def|{{\tt\char124}} +\chardef \less=`\< +\catcode`\<=\active +\def<{{\tt \less}} +\chardef \gtr=`\> +\catcode`\>=\active +\def>{{\tt \gtr}} +\catcode`\+=\active +\def+{{\tt \char 43}} +\catcode`\$=\active +\def${\ifusingit{{\sl\$}}\normaldollar}%$ font-lock fix + +% If a .fmt file is being used, characters that might appear in a file +% name cannot be active until we have parsed the command line. +% So turn them off again, and have \everyjob (or @setfilename) turn them on. +% \otherifyactive is called near the end of this file. +\def\otherifyactive{\catcode`+=\other \catcode`\_=\other} + +% Used sometimes to turn off (effectively) the active characters even after +% parsing them. +\def\turnoffactive{% + \normalturnoffactive + \otherbackslash +} + +\catcode`\@=0 + +% \backslashcurfont outputs one backslash character in current font, +% as in \char`\\. +\global\chardef\backslashcurfont=`\\ +\global\let\rawbackslashxx=\backslashcurfont % let existing .??s files work + +% \realbackslash is an actual character `\' with catcode other, and +% \doublebackslash is two of them (for the pdf outlines). +{\catcode`\\=\other @gdef@realbackslash{\} @gdef@doublebackslash{\\}} + +% In texinfo, backslash is an active character; it prints the backslash +% in fixed width font. +\catcode`\\=\active +@def@normalbackslash{{@tt@backslashcurfont}} +% On startup, @fixbackslash assigns: +% @let \ = @normalbackslash + +% \rawbackslash defines an active \ to do \backslashcurfont. +% \otherbackslash defines an active \ to be a literal `\' character with +% catcode other. +@gdef@rawbackslash{@let\=@backslashcurfont} +@gdef@otherbackslash{@let\=@realbackslash} + +% Same as @turnoffactive except outputs \ as {\tt\char`\\} instead of +% the literal character `\'. +% +@def@normalturnoffactive{% + @let\=@normalbackslash + @let"=@normaldoublequote + @let~=@normaltilde + @let^=@normalcaret + @let_=@normalunderscore + @let|=@normalverticalbar + @let<=@normalless + @let>=@normalgreater + @let+=@normalplus + @let$=@normaldollar %$ font-lock fix + @markupsetuplqdefault + @markupsetuprqdefault + @unsepspaces +} + +% Make _ and + \other characters, temporarily. +% This is canceled by @fixbackslash. +@otherifyactive + +% If a .fmt file is being used, we don't want the `\input texinfo' to show up. +% That is what \eatinput is for; after that, the `\' should revert to printing +% a backslash. +% +@gdef@eatinput input texinfo{@fixbackslash} +@global@let\ = @eatinput + +% On the other hand, perhaps the file did not have a `\input texinfo'. Then +% the first `\' in the file would cause an error. This macro tries to fix +% that, assuming it is called before the first `\' could plausibly occur. +% Also turn back on active characters that might appear in the input +% file name, in case not using a pre-dumped format. +% +@gdef@fixbackslash{% + @ifx\@eatinput @let\ = @normalbackslash @fi + @catcode`+=@active + @catcode`@_=@active +} + +% Say @foo, not \foo, in error messages. +@escapechar = `@@ + +% These look ok in all fonts, so just make them not special. +@catcode`@& = @other +@catcode`@# = @other +@catcode`@% = @other + +@c Finally, make ` and ' active, so that txicodequoteundirected and +@c txicodequotebacktick work right in, e.g., @w{@code{`foo'}}. If we +@c don't make ` and ' active, @code will not get them as active chars. +@c Do this last of all since we use ` in the previous @catcode assignments. +@catcode`@'=@active +@catcode`@`=@active +@markupsetuplqdefault +@markupsetuprqdefault + +@c Local variables: +@c eval: (add-hook 'write-file-hooks 'time-stamp) +@c page-delimiter: "^\\\\message" +@c time-stamp-start: "def\\\\texinfoversion{" +@c time-stamp-format: "%:y-%02m-%02d.%02H" +@c time-stamp-end: "}" +@c End: + +@c vim:sw=2: + +@ignore + arch-tag: e1b36e32-c96e-4135-a41a-0b2efa2ea115 +@end ignore diff --git a/libconfig-1.4.9/aux-build/ylwrap b/libconfig-1.4.9/aux-build/ylwrap new file mode 100755 index 0000000000000000000000000000000000000000..e66a95b603fad3fba1924914158cac45ee3c8a00 --- /dev/null +++ b/libconfig-1.4.9/aux-build/ylwrap @@ -0,0 +1,222 @@ +#! /bin/sh +# ylwrap - wrapper for lex/yacc invocations. + +scriptversion=2004-09-10.20 + +# Copyright (C) 1996, 1997, 1998, 1999, 2001, 2002, 2003, 2004 +# Free Software Foundation, Inc. +# +# Written by Tom Tromey . +# +# This program is free software; you can redistribute it and/or modify +# it under the terms of the GNU General Public License as published by +# the Free Software Foundation; either version 2, or (at your option) +# any later version. +# +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY; without even the implied warranty of +# MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +# GNU General Public License for more details. +# +# You should have received a copy of the GNU General Public License +# along with this program; if not, write to the Free Software +# Foundation, Inc., 59 Temple Place - Suite 330, Boston, MA 02111-1307, USA. + +# As a special exception to the GNU General Public License, if you +# distribute this file as part of a program that contains a +# configuration script generated by Autoconf, you may include it under +# the same distribution terms that you use for the rest of that program. + +# This file is maintained in Automake, please report +# bugs to or send patches to +# . + +case "$1" in + '') + echo "$0: No files given. Try \`$0 --help' for more information." 1>&2 + exit 1 + ;; + --basedir) + basedir=$2 + shift 2 + ;; + -h|--h*) + cat <<\EOF +Usage: ylwrap [--help|--version] INPUT [OUTPUT DESIRED]... -- PROGRAM [ARGS]... + +Wrapper for lex/yacc invocations, renaming files as desired. + + INPUT is the input file + OUTPUT is one file PROG generates + DESIRED is the file we actually want instead of OUTPUT + PROGRAM is program to run + ARGS are passed to PROG + +Any number of OUTPUT,DESIRED pairs may be used. + +Report bugs to . +EOF + exit 0 + ;; + -v|--v*) + echo "ylwrap $scriptversion" + exit 0 + ;; +esac + + +# The input. +input="$1" +shift +case "$input" in + [\\/]* | ?:[\\/]*) + # Absolute path; do nothing. + ;; + *) + # Relative path. Make it absolute. + input="`pwd`/$input" + ;; +esac + +pairlist= +while test "$#" -ne 0; do + if test "$1" = "--"; then + shift + break + fi + pairlist="$pairlist $1" + shift +done + +# The program to run. +prog="$1" +shift +# Make any relative path in $prog absolute. +case "$prog" in + [\\/]* | ?:[\\/]*) ;; + *[\\/]*) prog="`pwd`/$prog" ;; +esac + +# FIXME: add hostname here for parallel makes that run commands on +# other machines. But that might take us over the 14-char limit. +dirname=ylwrap$$ +trap "cd `pwd`; rm -rf $dirname > /dev/null 2>&1" 1 2 3 15 +mkdir $dirname || exit 1 + +cd $dirname + +case $# in + 0) $prog "$input" ;; + *) $prog "$@" "$input" ;; +esac +ret=$? + +if test $ret -eq 0; then + set X $pairlist + shift + first=yes + # Since DOS filename conventions don't allow two dots, + # the DOS version of Bison writes out y_tab.c instead of y.tab.c + # and y_tab.h instead of y.tab.h. Test to see if this is the case. + y_tab_nodot="no" + if test -f y_tab.c || test -f y_tab.h; then + y_tab_nodot="yes" + fi + + # The directory holding the input. + input_dir=`echo "$input" | sed -e 's,\([\\/]\)[^\\/]*$,\1,'` + # Quote $INPUT_DIR so we can use it in a regexp. + # FIXME: really we should care about more than `.' and `\'. + input_rx=`echo "$input_dir" | sed 's,\\\\,\\\\\\\\,g;s,\\.,\\\\.,g'` + + while test "$#" -ne 0; do + from="$1" + # Handle y_tab.c and y_tab.h output by DOS + if test $y_tab_nodot = "yes"; then + if test $from = "y.tab.c"; then + from="y_tab.c" + else + if test $from = "y.tab.h"; then + from="y_tab.h" + fi + fi + fi + if test -f "$from"; then + # If $2 is an absolute path name, then just use that, + # otherwise prepend `../'. + case "$2" in + [\\/]* | ?:[\\/]*) target="$2";; + *) target="../$2";; + esac + + # We do not want to overwrite a header file if it hasn't + # changed. This avoid useless recompilations. However the + # parser itself (the first file) should always be updated, + # because it is the destination of the .y.c rule in the + # Makefile. Divert the output of all other files to a temporary + # file so we can compare them to existing versions. + if test $first = no; then + realtarget="$target" + target="tmp-`echo $target | sed s/.*[\\/]//g`" + fi + # Edit out `#line' or `#' directives. + # + # We don't want the resulting debug information to point at + # an absolute srcdir; it is better for it to just mention the + # .y file with no path. + # + # We want to use the real output file name, not yy.lex.c for + # instance. + # + # We want the include guards to be adjusted too. + FROM=`echo "$from" | sed \ + -e 'y/abcdefghijklmnopqrstuvwxyz/ABCDEFGHIJKLMNOPQRSTUVWXYZ/'\ + -e 's/[^ABCDEFGHIJKLMNOPQRSTUVWXYZ]/_/g'` + TARGET=`echo "$2" | sed \ + -e 'y/abcdefghijklmnopqrstuvwxyz/ABCDEFGHIJKLMNOPQRSTUVWXYZ/'\ + -e 's/[^ABCDEFGHIJKLMNOPQRSTUVWXYZ]/_/g'` + + sed -e "/^#/!b" -e "s,$input_rx,," -e "s,$from,$2," \ + -e "s,$FROM,$TARGET," "$from" >"$target" || ret=$? + + # Check whether header files must be updated. + if test $first = no; then + if test -f "$realtarget" && cmp -s "$realtarget" "$target"; then + echo "$2" is unchanged + rm -f "$target" + else + echo updating "$2" + mv -f "$target" "$realtarget" + fi + fi + else + # A missing file is only an error for the first file. This + # is a blatant hack to let us support using "yacc -d". If -d + # is not specified, we don't want an error when the header + # file is "missing". + if test $first = yes; then + ret=1 + fi + fi + shift + shift + first=no + done +else + ret=$? +fi + +# Remove the directory. +cd .. +rm -rf $dirname + +exit $ret + +# Local Variables: +# mode: shell-script +# sh-indentation: 2 +# eval: (add-hook 'write-file-hooks 'time-stamp) +# time-stamp-start: "scriptversion=" +# time-stamp-format: "%:y-%02m-%02d.%02H" +# time-stamp-end: "$" +# End: diff --git a/libconfig-1.4.9/config.log b/libconfig-1.4.9/config.log new file mode 100644 index 0000000000000000000000000000000000000000..068cfe591d9b624259a6f50961e35a70ed35fc75 --- /dev/null +++ b/libconfig-1.4.9/config.log @@ -0,0 +1,8251 @@ +This file contains any messages produced by compilers while +running configure, to aid debugging if configure makes a mistake. + +It was created by libconfig configure 1.4.9, which was +generated by GNU Autoconf 2.68. Invocation command line was + + $ ./configure --disable-cxx + +## --------- ## +## Platform. ## +## --------- ## + +hostname = timor.sen.cwi.nl +uname -m = x86_64 +uname -r = 3.14.3-200.fc20.x86_64 +uname -s = Linux +uname -v = #1 SMP Tue May 6 19:00:18 UTC 2014 + +/usr/bin/uname -p = x86_64 +/bin/uname -X = unknown + +/bin/arch = x86_64 +/usr/bin/arch -k = unknown +/usr/convex/getsysinfo = unknown +/usr/bin/hostinfo = unknown +/bin/machine = unknown +/usr/bin/oslevel = unknown +/bin/universe = unknown + +PATH: /ufs/gollum/bin +PATH: . +PATH: /usr/lib64/qt-3.3/bin +PATH: /usr/local/bin +PATH: /usr/bin +PATH: /bin +PATH: /usr/games +PATH: /usr/local/sbin +PATH: /usr/sbin +PATH: /ufs/greta/visit2_6_3.linux-x86_64/bin +PATH: /opt/sw/matlab-2012b/bin +PATH: /usr/lib64/openmpi/bin +PATH: /ufs/greta/hdf5-1.8.11/bin +PATH: /ufs/greta/visit2_6_3.linux-x86_64/bin +PATH: /opt/sw/matlab-2012b/bin +PATH: /usr/lib64/openmpi/bin +PATH: /ufs/greta/hdf5-1.8.11/bin +PATH: /ufs/greta/visit2_6_3.linux-x86_64/bin +PATH: /opt/sw/matlab-2012b/bin +PATH: /usr/lib64/openmpi/bin +PATH: /ufs/greta/hdf5-1.8.11/bin + + +## ----------- ## +## Core tests. ## +## ----------- ## + +configure:2375: checking build system type +configure:2389: result: x86_64-unknown-linux-gnu +configure:2409: checking host system type +configure:2422: result: x86_64-unknown-linux-gnu +configure:2442: checking target system type +configure:2455: result: x86_64-unknown-linux-gnu +configure:2497: checking for a BSD-compatible install +configure:2565: result: /usr/bin/install -c +configure:2576: checking whether build environment is sane +configure:2626: result: yes +configure:2767: checking for a thread-safe mkdir -p +configure:2806: result: /usr/bin/mkdir -p +configure:2819: checking for gawk +configure:2835: found /usr/bin/gawk +configure:2846: result: gawk +configure:2857: checking whether make sets $(MAKE) +configure:2879: result: yes +configure:2962: libconfig - made with pride in California +configure:2985: checking for style of include used by make +configure:3013: result: GNU +configure:3083: checking for gcc +configure:3099: found /usr/bin/gcc +configure:3110: result: gcc +configure:3339: checking for C compiler version +configure:3348: gcc --version >&5 +gcc (GCC) 4.8.3 20140624 (Red Hat 4.8.3-1) +Copyright (C) 2013 Free Software Foundation, Inc. +This is free software; see the source for copying conditions. There is NO +warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. + +configure:3359: $? = 0 +configure:3348: gcc -v >&5 +Using built-in specs. +COLLECT_GCC=gcc +COLLECT_LTO_WRAPPER=/usr/libexec/gcc/x86_64-redhat-linux/4.8.3/lto-wrapper +Target: x86_64-redhat-linux +Configured with: ../configure --prefix=/usr --mandir=/usr/share/man --infodir=/usr/share/info --with-bugurl=http://bugzilla.redhat.com/bugzilla --enable-bootstrap --enable-shared --enable-threads=posix --enable-checking=release --with-system-zlib --enable-__cxa_atexit --disable-libunwind-exceptions --enable-gnu-unique-object --enable-linker-build-id --with-linker-hash-style=gnu --enable-languages=c,c++,objc,obj-c++,java,fortran,ada,go,lto --enable-plugin --enable-initfini-array --enable-java-awt=gtk --disable-dssi --with-java-home=/usr/lib/jvm/java-1.5.0-gcj-1.5.0.0/jre --enable-libgcj-multifile --enable-java-maintainer-mode --with-ecj-jar=/usr/share/java/eclipse-ecj.jar --disable-libjava-multilib --with-isl=/builddir/build/BUILD/gcc-4.8.3-20140624/obj-x86_64-redhat-linux/isl-install --with-cloog=/builddir/build/BUILD/gcc-4.8.3-20140624/obj-x86_64-redhat-linux/cloog-install --with-tune=generic --with-arch_32=i686 --build=x86_64-redhat-linux +Thread model: posix +gcc version 4.8.3 20140624 (Red Hat 4.8.3-1) (GCC) +configure:3359: $? = 0 +configure:3348: gcc -V >&5 +gcc: error: unrecognized command line option '-V' +gcc: fatal error: no input files +compilation terminated. +configure:3359: $? = 4 +configure:3348: gcc -qversion >&5 +gcc: error: unrecognized command line option '-qversion' +gcc: fatal error: no input files +compilation terminated. +configure:3359: $? = 4 +configure:3379: checking whether the C compiler works +configure:3401: gcc conftest.c >&5 +configure:3405: $? = 0 +configure:3453: result: yes +configure:3456: checking for C compiler default output file name +configure:3458: result: a.out +configure:3464: checking for suffix of executables +configure:3471: gcc -o conftest conftest.c >&5 +configure:3475: $? = 0 +configure:3497: result: +configure:3519: checking whether we are cross compiling +configure:3527: gcc -o conftest conftest.c >&5 +configure:3531: $? = 0 +configure:3538: ./conftest +configure:3542: $? = 0 +configure:3557: result: no +configure:3562: checking for suffix of object files +configure:3584: gcc -c conftest.c >&5 +configure:3588: $? = 0 +configure:3609: result: o +configure:3613: checking whether we are using the GNU C compiler +configure:3632: gcc -c conftest.c >&5 +configure:3632: $? = 0 +configure:3641: result: yes +configure:3650: checking whether gcc accepts -g +configure:3670: gcc -c -g conftest.c >&5 +configure:3670: $? = 0 +configure:3711: result: yes +configure:3728: checking for gcc option to accept ISO C89 +configure:3792: gcc -c -g -O2 conftest.c >&5 +configure:3792: $? = 0 +configure:3805: result: none needed +configure:3827: checking dependency style of gcc +configure:3937: result: gcc3 +configure:3958: checking how to run the C preprocessor +configure:3989: gcc -E conftest.c +configure:3989: $? = 0 +configure:4003: gcc -E conftest.c +conftest.c:12:28: fatal error: ac_nonexistent.h: No such file or directory + #include + ^ +compilation terminated. +configure:4003: $? = 1 +configure: failed program was: +| /* confdefs.h */ +| #define PACKAGE_NAME "libconfig" +| #define PACKAGE_TARNAME "libconfig" +| #define PACKAGE_VERSION "1.4.9" +| #define PACKAGE_STRING "libconfig 1.4.9" +| #define PACKAGE_BUGREPORT "hyperrealm@gmail.com" +| #define PACKAGE_URL "http://www.hyperrealm.com/main.php?s=libconfig" +| #define PACKAGE "libconfig" +| #define VERSION "1.4.9" +| #define TARGET "x86_64-unknown-linux-gnu" +| /* end confdefs.h. */ +| #include +configure:4028: result: gcc -E +configure:4048: gcc -E conftest.c +configure:4048: $? = 0 +configure:4062: gcc -E conftest.c +conftest.c:12:28: fatal error: ac_nonexistent.h: No such file or directory + #include + ^ +compilation terminated. +configure:4062: $? = 1 +configure: failed program was: +| /* confdefs.h */ +| #define PACKAGE_NAME "libconfig" +| #define PACKAGE_TARNAME "libconfig" +| #define PACKAGE_VERSION "1.4.9" +| #define PACKAGE_STRING "libconfig 1.4.9" +| #define PACKAGE_BUGREPORT "hyperrealm@gmail.com" +| #define PACKAGE_URL "http://www.hyperrealm.com/main.php?s=libconfig" +| #define PACKAGE "libconfig" +| #define VERSION "1.4.9" +| #define TARGET "x86_64-unknown-linux-gnu" +| /* end confdefs.h. */ +| #include +configure:4091: checking for grep that handles long lines and -e +configure:4149: result: /usr/bin/grep +configure:4154: checking for egrep +configure:4216: result: /usr/bin/grep -E +configure:4221: checking for ANSI C header files +configure:4241: gcc -c -g -O2 conftest.c >&5 +configure:4241: $? = 0 +configure:4314: gcc -o conftest -g -O2 conftest.c >&5 +configure:4314: $? = 0 +configure:4314: ./conftest +configure:4314: $? = 0 +configure:4325: result: yes +configure:4338: checking for sys/types.h +configure:4338: gcc -c -g -O2 conftest.c >&5 +configure:4338: $? = 0 +configure:4338: result: yes +configure:4338: checking for sys/stat.h +configure:4338: gcc -c -g -O2 conftest.c >&5 +configure:4338: $? = 0 +configure:4338: result: yes +configure:4338: checking for stdlib.h +configure:4338: gcc -c -g -O2 conftest.c >&5 +configure:4338: $? = 0 +configure:4338: result: yes +configure:4338: checking for string.h +configure:4338: gcc -c -g -O2 conftest.c >&5 +configure:4338: $? = 0 +configure:4338: result: yes +configure:4338: checking for memory.h +configure:4338: gcc -c -g -O2 conftest.c >&5 +configure:4338: $? = 0 +configure:4338: result: yes +configure:4338: checking for strings.h +configure:4338: gcc -c -g -O2 conftest.c >&5 +configure:4338: $? = 0 +configure:4338: result: yes +configure:4338: checking for inttypes.h +configure:4338: gcc -c -g -O2 conftest.c >&5 +configure:4338: $? = 0 +configure:4338: result: yes +configure:4338: checking for stdint.h +configure:4338: gcc -c -g -O2 conftest.c >&5 +configure:4338: $? = 0 +configure:4338: result: yes +configure:4338: checking for unistd.h +configure:4338: gcc -c -g -O2 conftest.c >&5 +configure:4338: $? = 0 +configure:4338: result: yes +configure:4351: checking minix/config.h usability +configure:4351: gcc -c -g -O2 conftest.c >&5 +conftest.c:55:26: fatal error: minix/config.h: No such file or directory + #include + ^ +compilation terminated. +configure:4351: $? = 1 +configure: failed program was: +| /* confdefs.h */ +| #define PACKAGE_NAME "libconfig" +| #define PACKAGE_TARNAME "libconfig" +| #define PACKAGE_VERSION "1.4.9" +| #define PACKAGE_STRING "libconfig 1.4.9" +| #define PACKAGE_BUGREPORT "hyperrealm@gmail.com" +| #define PACKAGE_URL "http://www.hyperrealm.com/main.php?s=libconfig" +| #define PACKAGE "libconfig" +| #define VERSION "1.4.9" +| #define TARGET "x86_64-unknown-linux-gnu" +| #define STDC_HEADERS 1 +| #define HAVE_SYS_TYPES_H 1 +| #define HAVE_SYS_STAT_H 1 +| #define HAVE_STDLIB_H 1 +| #define HAVE_STRING_H 1 +| #define HAVE_MEMORY_H 1 +| #define HAVE_STRINGS_H 1 +| #define HAVE_INTTYPES_H 1 +| #define HAVE_STDINT_H 1 +| #define HAVE_UNISTD_H 1 +| /* end confdefs.h. */ +| #include +| #ifdef HAVE_SYS_TYPES_H +| # include +| #endif +| #ifdef HAVE_SYS_STAT_H +| # include +| #endif +| #ifdef STDC_HEADERS +| # include +| # include +| #else +| # ifdef HAVE_STDLIB_H +| # include +| # endif +| #endif +| #ifdef HAVE_STRING_H +| # if !defined STDC_HEADERS && defined HAVE_MEMORY_H +| # include +| # endif +| # include +| #endif +| #ifdef HAVE_STRINGS_H +| # include +| #endif +| #ifdef HAVE_INTTYPES_H +| # include +| #endif +| #ifdef HAVE_STDINT_H +| # include +| #endif +| #ifdef HAVE_UNISTD_H +| # include +| #endif +| #include +configure:4351: result: no +configure:4351: checking minix/config.h presence +configure:4351: gcc -E conftest.c +conftest.c:22:26: fatal error: minix/config.h: No such file or directory + #include + ^ +compilation terminated. +configure:4351: $? = 1 +configure: failed program was: +| /* confdefs.h */ +| #define PACKAGE_NAME "libconfig" +| #define PACKAGE_TARNAME "libconfig" +| #define PACKAGE_VERSION "1.4.9" +| #define PACKAGE_STRING "libconfig 1.4.9" +| #define PACKAGE_BUGREPORT "hyperrealm@gmail.com" +| #define PACKAGE_URL "http://www.hyperrealm.com/main.php?s=libconfig" +| #define PACKAGE "libconfig" +| #define VERSION "1.4.9" +| #define TARGET "x86_64-unknown-linux-gnu" +| #define STDC_HEADERS 1 +| #define HAVE_SYS_TYPES_H 1 +| #define HAVE_SYS_STAT_H 1 +| #define HAVE_STDLIB_H 1 +| #define HAVE_STRING_H 1 +| #define HAVE_MEMORY_H 1 +| #define HAVE_STRINGS_H 1 +| #define HAVE_INTTYPES_H 1 +| #define HAVE_STDINT_H 1 +| #define HAVE_UNISTD_H 1 +| /* end confdefs.h. */ +| #include +configure:4351: result: no +configure:4351: checking for minix/config.h +configure:4351: result: no +configure:4372: checking whether it is safe to define __EXTENSIONS__ +configure:4390: gcc -c -g -O2 conftest.c >&5 +configure:4390: $? = 0 +configure:4397: result: yes +configure:4459: checking how to print strings +configure:4486: result: printf +configure:4507: checking for a sed that does not truncate output +configure:4571: result: /usr/bin/sed +configure:4589: checking for fgrep +configure:4651: result: /usr/bin/grep -F +configure:4686: checking for ld used by gcc +configure:4753: result: /usr/bin/ld +configure:4760: checking if the linker (/usr/bin/ld) is GNU ld +configure:4775: result: yes +configure:4787: checking for BSD- or MS-compatible name lister (nm) +configure:4836: result: /usr/bin/nm -B +configure:4966: checking the name lister (/usr/bin/nm -B) interface +configure:4973: gcc -c -g -O2 conftest.c >&5 +configure:4976: /usr/bin/nm -B "conftest.o" +configure:4979: output +0000000000000000 B some_variable +configure:4986: result: BSD nm +configure:4989: checking whether ln -s works +configure:4993: result: yes +configure:5001: checking the maximum length of command line arguments +configure:5131: result: 1572864 +configure:5148: checking whether the shell understands some XSI constructs +configure:5158: result: yes +configure:5162: checking whether the shell understands "+=" +configure:5168: result: yes +configure:5203: checking how to convert x86_64-unknown-linux-gnu file names to x86_64-unknown-linux-gnu format +configure:5243: result: func_convert_file_noop +configure:5250: checking how to convert x86_64-unknown-linux-gnu file names to toolchain format +configure:5270: result: func_convert_file_noop +configure:5277: checking for /usr/bin/ld option to reload object files +configure:5284: result: -r +configure:5358: checking for objdump +configure:5374: found /usr/bin/objdump +configure:5385: result: objdump +configure:5417: checking how to recognize dependent libraries +configure:5619: result: pass_all +configure:5704: checking for dlltool +configure:5734: result: no +configure:5764: checking how to associate runtime and link libraries +configure:5791: result: printf %s\n +configure:5851: checking for ar +configure:5867: found /usr/bin/ar +configure:5878: result: ar +configure:5915: checking for archiver @FILE support +configure:5932: gcc -c -g -O2 conftest.c >&5 +configure:5932: $? = 0 +configure:5935: ar cru libconftest.a @conftest.lst >&5 +configure:5938: $? = 0 +configure:5943: ar cru libconftest.a @conftest.lst >&5 +ar: conftest.o: No such file or directory +configure:5946: $? = 1 +configure:5958: result: @ +configure:6016: checking for strip +configure:6032: found /usr/bin/strip +configure:6043: result: strip +configure:6115: checking for ranlib +configure:6131: found /usr/bin/ranlib +configure:6142: result: ranlib +configure:6244: checking command to parse /usr/bin/nm -B output from gcc object +configure:6364: gcc -c -g -O2 conftest.c >&5 +configure:6367: $? = 0 +configure:6371: /usr/bin/nm -B conftest.o \| sed -n -e 's/^.*[ ]\([ABCDGIRSTW][ABCDGIRSTW]*\)[ ][ ]*\([_A-Za-z][_A-Za-z0-9]*\)$/\1 \2 \2/p' | sed '/ __gnu_lto/d' \> conftest.nm +configure:6374: $? = 0 +configure:6440: gcc -o conftest -g -O2 conftest.c conftstm.o >&5 +configure:6443: $? = 0 +configure:6481: result: ok +configure:6518: checking for sysroot +configure:6548: result: no +configure:6625: gcc -c -g -O2 conftest.c >&5 +configure:6628: $? = 0 +configure:6804: checking for mt +configure:6834: result: no +configure:6854: checking if : is a manifest tool +configure:6860: : '-?' +configure:6868: result: no +configure:7507: checking for dlfcn.h +configure:7507: gcc -c -g -O2 conftest.c >&5 +configure:7507: $? = 0 +configure:7507: result: yes +configure:7713: checking for objdir +configure:7728: result: .libs +configure:7995: checking if gcc supports -fno-rtti -fno-exceptions +configure:8013: gcc -c -g -O2 -fno-rtti -fno-exceptions conftest.c >&5 +cc1: warning: command line option '-fno-rtti' is valid for C++/ObjC++ but not for C [enabled by default] +configure:8017: $? = 0 +configure:8030: result: no +configure:8357: checking for gcc option to produce PIC +configure:8364: result: -fPIC -DPIC +configure:8372: checking if gcc PIC flag -fPIC -DPIC works +configure:8390: gcc -c -g -O2 -fPIC -DPIC -DPIC conftest.c >&5 +configure:8394: $? = 0 +configure:8407: result: yes +configure:8436: checking if gcc static flag -static works +configure:8464: result: yes +configure:8479: checking if gcc supports -c -o file.o +configure:8500: gcc -c -g -O2 -o out/conftest2.o conftest.c >&5 +configure:8504: $? = 0 +configure:8526: result: yes +configure:8534: checking if gcc supports -c -o file.o +configure:8581: result: yes +configure:8614: checking whether the gcc linker (/usr/bin/ld -m elf_x86_64) supports shared libraries +configure:9767: result: yes +configure:9804: checking whether -lc should be explicitly linked in +configure:9812: gcc -c -g -O2 conftest.c >&5 +configure:9815: $? = 0 +configure:9830: gcc -shared -fPIC -DPIC conftest.o -v -Wl,-soname -Wl,conftest -o conftest 2\>\&1 \| /usr/bin/grep -lc \>/dev/null 2\>\&1 +configure:9833: $? = 0 +configure:9847: result: no +configure:10007: checking dynamic linker characteristics +configure:10518: gcc -o conftest -g -O2 -Wl,-rpath -Wl,/foo conftest.c >&5 +configure:10518: $? = 0 +configure:10740: result: GNU/Linux ld.so +configure:10847: checking how to hardcode library paths into programs +configure:10872: result: immediate +configure:11412: checking whether stripping libraries is possible +configure:11417: result: yes +configure:11452: checking if libtool supports shared libraries +configure:11454: result: yes +configure:11457: checking whether to build shared libraries +configure:11478: result: yes +configure:11481: checking whether to build static libraries +configure:11485: result: yes +configure:11571: checking for gcc +configure:11598: result: gcc +configure:11827: checking for C compiler version +configure:11836: gcc --version >&5 +gcc (GCC) 4.8.3 20140624 (Red Hat 4.8.3-1) +Copyright (C) 2013 Free Software Foundation, Inc. +This is free software; see the source for copying conditions. There is NO +warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. + +configure:11847: $? = 0 +configure:11836: gcc -v >&5 +Using built-in specs. +COLLECT_GCC=gcc +COLLECT_LTO_WRAPPER=/usr/libexec/gcc/x86_64-redhat-linux/4.8.3/lto-wrapper +Target: x86_64-redhat-linux +Configured with: ../configure --prefix=/usr --mandir=/usr/share/man --infodir=/usr/share/info --with-bugurl=http://bugzilla.redhat.com/bugzilla --enable-bootstrap --enable-shared --enable-threads=posix --enable-checking=release --with-system-zlib --enable-__cxa_atexit --disable-libunwind-exceptions --enable-gnu-unique-object --enable-linker-build-id --with-linker-hash-style=gnu --enable-languages=c,c++,objc,obj-c++,java,fortran,ada,go,lto --enable-plugin --enable-initfini-array --enable-java-awt=gtk --disable-dssi --with-java-home=/usr/lib/jvm/java-1.5.0-gcj-1.5.0.0/jre --enable-libgcj-multifile --enable-java-maintainer-mode --with-ecj-jar=/usr/share/java/eclipse-ecj.jar --disable-libjava-multilib --with-isl=/builddir/build/BUILD/gcc-4.8.3-20140624/obj-x86_64-redhat-linux/isl-install --with-cloog=/builddir/build/BUILD/gcc-4.8.3-20140624/obj-x86_64-redhat-linux/cloog-install --with-tune=generic --with-arch_32=i686 --build=x86_64-redhat-linux +Thread model: posix +gcc version 4.8.3 20140624 (Red Hat 4.8.3-1) (GCC) +configure:11847: $? = 0 +configure:11836: gcc -V >&5 +gcc: error: unrecognized command line option '-V' +gcc: fatal error: no input files +compilation terminated. +configure:11847: $? = 4 +configure:11836: gcc -qversion >&5 +gcc: error: unrecognized command line option '-qversion' +gcc: fatal error: no input files +compilation terminated. +configure:11847: $? = 4 +configure:11851: checking whether we are using the GNU C compiler +configure:11879: result: yes +configure:11888: checking whether gcc accepts -g +configure:11949: result: yes +configure:11966: checking for gcc option to accept ISO C89 +configure:12043: result: none needed +configure:12065: checking dependency style of gcc +configure:12175: result: gcc3 +configure:12191: checking whether gcc and cc understand -c and -o together +configure:12222: gcc -c conftest.c -o conftest2.o >&5 +configure:12226: $? = 0 +configure:12232: gcc -c conftest.c -o conftest2.o >&5 +configure:12236: $? = 0 +configure:12247: cc -c conftest.c >&5 +configure:12251: $? = 0 +configure:12259: cc -c conftest.c -o conftest2.o >&5 +configure:12263: $? = 0 +configure:12269: cc -c conftest.c -o conftest2.o >&5 +configure:12273: $? = 0 +configure:12291: result: yes +configure:12374: checking for g++ +configure:12390: found /usr/bin/g++ +configure:12401: result: g++ +configure:12428: checking for C++ compiler version +configure:12437: g++ --version >&5 +g++ (GCC) 4.8.3 20140624 (Red Hat 4.8.3-1) +Copyright (C) 2013 Free Software Foundation, Inc. +This is free software; see the source for copying conditions. There is NO +warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. + +configure:12448: $? = 0 +configure:12437: g++ -v >&5 +Using built-in specs. +COLLECT_GCC=g++ +COLLECT_LTO_WRAPPER=/usr/libexec/gcc/x86_64-redhat-linux/4.8.3/lto-wrapper +Target: x86_64-redhat-linux +Configured with: ../configure --prefix=/usr --mandir=/usr/share/man --infodir=/usr/share/info --with-bugurl=http://bugzilla.redhat.com/bugzilla --enable-bootstrap --enable-shared --enable-threads=posix --enable-checking=release --with-system-zlib --enable-__cxa_atexit --disable-libunwind-exceptions --enable-gnu-unique-object --enable-linker-build-id --with-linker-hash-style=gnu --enable-languages=c,c++,objc,obj-c++,java,fortran,ada,go,lto --enable-plugin --enable-initfini-array --enable-java-awt=gtk --disable-dssi --with-java-home=/usr/lib/jvm/java-1.5.0-gcj-1.5.0.0/jre --enable-libgcj-multifile --enable-java-maintainer-mode --with-ecj-jar=/usr/share/java/eclipse-ecj.jar --disable-libjava-multilib --with-isl=/builddir/build/BUILD/gcc-4.8.3-20140624/obj-x86_64-redhat-linux/isl-install --with-cloog=/builddir/build/BUILD/gcc-4.8.3-20140624/obj-x86_64-redhat-linux/cloog-install --with-tune=generic --with-arch_32=i686 --build=x86_64-redhat-linux +Thread model: posix +gcc version 4.8.3 20140624 (Red Hat 4.8.3-1) (GCC) +configure:12448: $? = 0 +configure:12437: g++ -V >&5 +g++: error: unrecognized command line option '-V' +g++: fatal error: no input files +compilation terminated. +configure:12448: $? = 4 +configure:12437: g++ -qversion >&5 +g++: error: unrecognized command line option '-qversion' +g++: fatal error: no input files +compilation terminated. +configure:12448: $? = 4 +configure:12452: checking whether we are using the GNU C++ compiler +configure:12471: g++ -c conftest.cpp >&5 +configure:12471: $? = 0 +configure:12480: result: yes +configure:12489: checking whether g++ accepts -g +configure:12509: g++ -c -g conftest.cpp >&5 +configure:12509: $? = 0 +configure:12550: result: yes +configure:12575: checking dependency style of g++ +configure:12685: result: gcc3 +configure:12718: checking how to run the C++ preprocessor +configure:12745: g++ -E conftest.cpp +configure:12745: $? = 0 +configure:12759: g++ -E conftest.cpp +conftest.cpp:29:28: fatal error: ac_nonexistent.h: No such file or directory + #include + ^ +compilation terminated. +configure:12759: $? = 1 +configure: failed program was: +| /* confdefs.h */ +| #define PACKAGE_NAME "libconfig" +| #define PACKAGE_TARNAME "libconfig" +| #define PACKAGE_VERSION "1.4.9" +| #define PACKAGE_STRING "libconfig 1.4.9" +| #define PACKAGE_BUGREPORT "hyperrealm@gmail.com" +| #define PACKAGE_URL "http://www.hyperrealm.com/main.php?s=libconfig" +| #define PACKAGE "libconfig" +| #define VERSION "1.4.9" +| #define TARGET "x86_64-unknown-linux-gnu" +| #define STDC_HEADERS 1 +| #define HAVE_SYS_TYPES_H 1 +| #define HAVE_SYS_STAT_H 1 +| #define HAVE_STDLIB_H 1 +| #define HAVE_STRING_H 1 +| #define HAVE_MEMORY_H 1 +| #define HAVE_STRINGS_H 1 +| #define HAVE_INTTYPES_H 1 +| #define HAVE_STDINT_H 1 +| #define HAVE_UNISTD_H 1 +| #define __EXTENSIONS__ 1 +| #define _ALL_SOURCE 1 +| #define _GNU_SOURCE 1 +| #define _POSIX_PTHREAD_SEMANTICS 1 +| #define _TANDEM_SOURCE 1 +| #define HAVE_DLFCN_H 1 +| #define LT_OBJDIR ".libs/" +| /* end confdefs.h. */ +| #include +configure:12784: result: g++ -E +configure:12804: g++ -E conftest.cpp +configure:12804: $? = 0 +configure:12818: g++ -E conftest.cpp +conftest.cpp:29:28: fatal error: ac_nonexistent.h: No such file or directory + #include + ^ +compilation terminated. +configure:12818: $? = 1 +configure: failed program was: +| /* confdefs.h */ +| #define PACKAGE_NAME "libconfig" +| #define PACKAGE_TARNAME "libconfig" +| #define PACKAGE_VERSION "1.4.9" +| #define PACKAGE_STRING "libconfig 1.4.9" +| #define PACKAGE_BUGREPORT "hyperrealm@gmail.com" +| #define PACKAGE_URL "http://www.hyperrealm.com/main.php?s=libconfig" +| #define PACKAGE "libconfig" +| #define VERSION "1.4.9" +| #define TARGET "x86_64-unknown-linux-gnu" +| #define STDC_HEADERS 1 +| #define HAVE_SYS_TYPES_H 1 +| #define HAVE_SYS_STAT_H 1 +| #define HAVE_STDLIB_H 1 +| #define HAVE_STRING_H 1 +| #define HAVE_MEMORY_H 1 +| #define HAVE_STRINGS_H 1 +| #define HAVE_INTTYPES_H 1 +| #define HAVE_STDINT_H 1 +| #define HAVE_UNISTD_H 1 +| #define __EXTENSIONS__ 1 +| #define _ALL_SOURCE 1 +| #define _GNU_SOURCE 1 +| #define _POSIX_PTHREAD_SEMANTICS 1 +| #define _TANDEM_SOURCE 1 +| #define HAVE_DLFCN_H 1 +| #define LT_OBJDIR ".libs/" +| /* end confdefs.h. */ +| #include +configure:12987: checking for ld used by g++ +configure:13054: result: /usr/bin/ld -m elf_x86_64 +configure:13061: checking if the linker (/usr/bin/ld -m elf_x86_64) is GNU ld +configure:13076: result: yes +configure:13131: checking whether the g++ linker (/usr/bin/ld -m elf_x86_64) supports shared libraries +configure:14136: result: yes +configure:14172: g++ -c -g -O2 conftest.cpp >&5 +configure:14175: $? = 0 +configure:14695: checking for g++ option to produce PIC +configure:14702: result: -fPIC -DPIC +configure:14710: checking if g++ PIC flag -fPIC -DPIC works +configure:14728: g++ -c -g -O2 -fPIC -DPIC -DPIC conftest.cpp >&5 +configure:14732: $? = 0 +configure:14745: result: yes +configure:14768: checking if g++ static flag -static works +configure:14796: result: no +configure:14808: checking if g++ supports -c -o file.o +configure:14829: g++ -c -g -O2 -o out/conftest2.o conftest.cpp >&5 +configure:14833: $? = 0 +configure:14855: result: yes +configure:14860: checking if g++ supports -c -o file.o +configure:14907: result: yes +configure:14937: checking whether the g++ linker (/usr/bin/ld -m elf_x86_64) supports shared libraries +configure:14973: result: yes +configure:15114: checking dynamic linker characteristics +configure:15781: result: GNU/Linux ld.so +configure:15834: checking how to hardcode library paths into programs +configure:15859: result: immediate +configure:16202: checking for flex +configure:16218: found /usr/bin/flex +configure:16229: result: flex +configure:16266: flex conftest.l +configure:16270: $? = 0 +configure:16272: checking lex output file root +configure:16286: result: lex.yy +configure:16291: checking lex library +configure:16305: gcc -o conftest -g -O2 conftest.c >&5 +/var/tmp/ccBIauWQ.o: In function `input': +/ufs/greta/zomer/pharcos/libconfig-1.4.9/lex.yy.c:1169: undefined reference to `yywrap' +/var/tmp/ccBIauWQ.o: In function `yylex': +/ufs/greta/zomer/pharcos/libconfig-1.4.9/lex.yy.c:868: undefined reference to `yywrap' +/var/tmp/ccBIauWQ.o: In function `main': +/ufs/greta/zomer/pharcos/libconfig-1.4.9/conftest.l:17: undefined reference to `yywrap' +collect2: error: ld returned 1 exit status +configure:16305: $? = 1 +configure: failed program was: +| /* confdefs.h */ +| #define PACKAGE_NAME "libconfig" +| #define PACKAGE_TARNAME "libconfig" +| #define PACKAGE_VERSION "1.4.9" +| #define PACKAGE_STRING "libconfig 1.4.9" +| #define PACKAGE_BUGREPORT "hyperrealm@gmail.com" +| #define PACKAGE_URL "http://www.hyperrealm.com/main.php?s=libconfig" +| #define PACKAGE "libconfig" +| #define VERSION "1.4.9" +| #define TARGET "x86_64-unknown-linux-gnu" +| #define STDC_HEADERS 1 +| #define HAVE_SYS_TYPES_H 1 +| #define HAVE_SYS_STAT_H 1 +| #define HAVE_STDLIB_H 1 +| #define HAVE_STRING_H 1 +| #define HAVE_MEMORY_H 1 +| #define HAVE_STRINGS_H 1 +| #define HAVE_INTTYPES_H 1 +| #define HAVE_STDINT_H 1 +| #define HAVE_UNISTD_H 1 +| #define __EXTENSIONS__ 1 +| #define _ALL_SOURCE 1 +| #define _GNU_SOURCE 1 +| #define _POSIX_PTHREAD_SEMANTICS 1 +| #define _TANDEM_SOURCE 1 +| #define HAVE_DLFCN_H 1 +| #define LT_OBJDIR ".libs/" +| /* end confdefs.h. */ +| +| #line 3 "lex.yy.c" +| +| #define YY_INT_ALIGNED short int +| +| /* A lexical scanner generated by flex */ +| +| #define FLEX_SCANNER +| #define YY_FLEX_MAJOR_VERSION 2 +| #define YY_FLEX_MINOR_VERSION 5 +| #define YY_FLEX_SUBMINOR_VERSION 37 +| #if YY_FLEX_SUBMINOR_VERSION > 0 +| #define FLEX_BETA +| #endif +| +| /* First, we deal with platform-specific or compiler-specific issues. */ +| +| /* begin standard C headers. */ +| #include +| #include +| #include +| #include +| +| /* end standard C headers. */ +| +| /* flex integer type definitions */ +| +| #ifndef FLEXINT_H +| #define FLEXINT_H +| +| /* C99 systems have . Non-C99 systems may or may not. */ +| +| #if defined (__STDC_VERSION__) && __STDC_VERSION__ >= 199901L +| +| /* C99 says to define __STDC_LIMIT_MACROS before including stdint.h, +| * if you want the limit (max/min) macros for int types. +| */ +| #ifndef __STDC_LIMIT_MACROS +| #define __STDC_LIMIT_MACROS 1 +| #endif +| +| #include +| typedef int8_t flex_int8_t; +| typedef uint8_t flex_uint8_t; +| typedef int16_t flex_int16_t; +| typedef uint16_t flex_uint16_t; +| typedef int32_t flex_int32_t; +| typedef uint32_t flex_uint32_t; +| #else +| typedef signed char flex_int8_t; +| typedef short int flex_int16_t; +| typedef int flex_int32_t; +| typedef unsigned char flex_uint8_t; +| typedef unsigned short int flex_uint16_t; +| typedef unsigned int flex_uint32_t; +| +| /* Limits of integral types. */ +| #ifndef INT8_MIN +| #define INT8_MIN (-128) +| #endif +| #ifndef INT16_MIN +| #define INT16_MIN (-32767-1) +| #endif +| #ifndef INT32_MIN +| #define INT32_MIN (-2147483647-1) +| #endif +| #ifndef INT8_MAX +| #define INT8_MAX (127) +| #endif +| #ifndef INT16_MAX +| #define INT16_MAX (32767) +| #endif +| #ifndef INT32_MAX +| #define INT32_MAX (2147483647) +| #endif +| #ifndef UINT8_MAX +| #define UINT8_MAX (255U) +| #endif +| #ifndef UINT16_MAX +| #define UINT16_MAX (65535U) +| #endif +| #ifndef UINT32_MAX +| #define UINT32_MAX (4294967295U) +| #endif +| +| #endif /* ! C99 */ +| +| #endif /* ! FLEXINT_H */ +| +| #ifdef __cplusplus +| +| /* The "const" storage-class-modifier is valid. */ +| #define YY_USE_CONST +| +| #else /* ! __cplusplus */ +| +| /* C99 requires __STDC__ to be defined as 1. */ +| #if defined (__STDC__) +| +| #define YY_USE_CONST +| +| #endif /* defined (__STDC__) */ +| #endif /* ! __cplusplus */ +| +| #ifdef YY_USE_CONST +| #define yyconst const +| #else +| #define yyconst +| #endif +| +| /* Returned upon end-of-file. */ +| #define YY_NULL 0 +| +| /* Promotes a possibly negative, possibly signed char to an unsigned +| * integer for use as an array index. If the signed char is negative, +| * we want to instead treat it as an 8-bit unsigned char, hence the +| * double cast. +| */ +| #define YY_SC_TO_UI(c) ((unsigned int) (unsigned char) c) +| +| /* Enter a start condition. This macro really ought to take a parameter, +| * but we do it the disgusting crufty way forced on us by the ()-less +| * definition of BEGIN. +| */ +| #define BEGIN (yy_start) = 1 + 2 * +| +| /* Translate the current start state into a value that can be later handed +| * to BEGIN to return to the state. The YYSTATE alias is for lex +| * compatibility. +| */ +| #define YY_START (((yy_start) - 1) / 2) +| #define YYSTATE YY_START +| +| /* Action number for EOF rule of a given start state. */ +| #define YY_STATE_EOF(state) (YY_END_OF_BUFFER + state + 1) +| +| /* Special action meaning "start processing a new file". */ +| #define YY_NEW_FILE yyrestart(yyin ) +| +| #define YY_END_OF_BUFFER_CHAR 0 +| +| /* Size of default input buffer. */ +| #ifndef YY_BUF_SIZE +| #define YY_BUF_SIZE 16384 +| #endif +| +| /* The state buf must be large enough to hold one state per character in the main buffer. +| */ +| #define YY_STATE_BUF_SIZE ((YY_BUF_SIZE + 2) * sizeof(yy_state_type)) +| +| #ifndef YY_TYPEDEF_YY_BUFFER_STATE +| #define YY_TYPEDEF_YY_BUFFER_STATE +| typedef struct yy_buffer_state *YY_BUFFER_STATE; +| #endif +| +| #ifndef YY_TYPEDEF_YY_SIZE_T +| #define YY_TYPEDEF_YY_SIZE_T +| typedef size_t yy_size_t; +| #endif +| +| extern yy_size_t yyleng; +| +| extern FILE *yyin, *yyout; +| +| #define EOB_ACT_CONTINUE_SCAN 0 +| #define EOB_ACT_END_OF_FILE 1 +| #define EOB_ACT_LAST_MATCH 2 +| +| #define YY_LESS_LINENO(n) +| +| /* Return all but the first "n" matched characters back to the input stream. */ +| #define yyless(n) \ +| do \ +| { \ +| /* Undo effects of setting up yytext. */ \ +| int yyless_macro_arg = (n); \ +| YY_LESS_LINENO(yyless_macro_arg);\ +| *yy_cp = (yy_hold_char); \ +| YY_RESTORE_YY_MORE_OFFSET \ +| (yy_c_buf_p) = yy_cp = yy_bp + yyless_macro_arg - YY_MORE_ADJ; \ +| YY_DO_BEFORE_ACTION; /* set up yytext again */ \ +| } \ +| while ( 0 ) +| +| #define unput(c) yyunput( c, (yytext_ptr) ) +| +| #ifndef YY_STRUCT_YY_BUFFER_STATE +| #define YY_STRUCT_YY_BUFFER_STATE +| struct yy_buffer_state +| { +| FILE *yy_input_file; +| +| char *yy_ch_buf; /* input buffer */ +| char *yy_buf_pos; /* current position in input buffer */ +| +| /* Size of input buffer in bytes, not including room for EOB +| * characters. +| */ +| yy_size_t yy_buf_size; +| +| /* Number of characters read into yy_ch_buf, not including EOB +| * characters. +| */ +| yy_size_t yy_n_chars; +| +| /* Whether we "own" the buffer - i.e., we know we created it, +| * and can realloc() it to grow it, and should free() it to +| * delete it. +| */ +| int yy_is_our_buffer; +| +| /* Whether this is an "interactive" input source; if so, and +| * if we're using stdio for input, then we want to use getc() +| * instead of fread(), to make sure we stop fetching input after +| * each newline. +| */ +| int yy_is_interactive; +| +| /* Whether we're considered to be at the beginning of a line. +| * If so, '^' rules will be active on the next match, otherwise +| * not. +| */ +| int yy_at_bol; +| +| int yy_bs_lineno; /**< The line count. */ +| int yy_bs_column; /**< The column count. */ +| +| /* Whether to try to fill the input buffer when we reach the +| * end of it. +| */ +| int yy_fill_buffer; +| +| int yy_buffer_status; +| +| #define YY_BUFFER_NEW 0 +| #define YY_BUFFER_NORMAL 1 +| /* When an EOF's been seen but there's still some text to process +| * then we mark the buffer as YY_EOF_PENDING, to indicate that we +| * shouldn't try reading from the input source any more. We might +| * still have a bunch of tokens to match, though, because of +| * possible backing-up. +| * +| * When we actually see the EOF, we change the status to "new" +| * (via yyrestart()), so that the user can continue scanning by +| * just pointing yyin at a new input file. +| */ +| #define YY_BUFFER_EOF_PENDING 2 +| +| }; +| #endif /* !YY_STRUCT_YY_BUFFER_STATE */ +| +| /* Stack of input buffers. */ +| static size_t yy_buffer_stack_top = 0; /**< index of top of stack. */ +| static size_t yy_buffer_stack_max = 0; /**< capacity of stack. */ +| static YY_BUFFER_STATE * yy_buffer_stack = 0; /**< Stack as an array. */ +| +| /* We provide macros for accessing buffer states in case in the +| * future we want to put the buffer states in a more general +| * "scanner state". +| * +| * Returns the top of the stack, or NULL. +| */ +| #define YY_CURRENT_BUFFER ( (yy_buffer_stack) \ +| ? (yy_buffer_stack)[(yy_buffer_stack_top)] \ +| : NULL) +| +| /* Same as previous macro, but useful when we know that the buffer stack is not +| * NULL or when we need an lvalue. For internal use only. +| */ +| #define YY_CURRENT_BUFFER_LVALUE (yy_buffer_stack)[(yy_buffer_stack_top)] +| +| /* yy_hold_char holds the character lost when yytext is formed. */ +| static char yy_hold_char; +| static yy_size_t yy_n_chars; /* number of characters read into yy_ch_buf */ +| yy_size_t yyleng; +| +| /* Points to current character in buffer. */ +| static char *yy_c_buf_p = (char *) 0; +| static int yy_init = 0; /* whether we need to initialize */ +| static int yy_start = 0; /* start state number */ +| +| /* Flag which is used to allow yywrap()'s to do buffer switches +| * instead of setting up a fresh yyin. A bit of a hack ... +| */ +| static int yy_did_buffer_switch_on_eof; +| +| void yyrestart (FILE *input_file ); +| void yy_switch_to_buffer (YY_BUFFER_STATE new_buffer ); +| YY_BUFFER_STATE yy_create_buffer (FILE *file,int size ); +| void yy_delete_buffer (YY_BUFFER_STATE b ); +| void yy_flush_buffer (YY_BUFFER_STATE b ); +| void yypush_buffer_state (YY_BUFFER_STATE new_buffer ); +| void yypop_buffer_state (void ); +| +| static void yyensure_buffer_stack (void ); +| static void yy_load_buffer_state (void ); +| static void yy_init_buffer (YY_BUFFER_STATE b,FILE *file ); +| +| #define YY_FLUSH_BUFFER yy_flush_buffer(YY_CURRENT_BUFFER ) +| +| YY_BUFFER_STATE yy_scan_buffer (char *base,yy_size_t size ); +| YY_BUFFER_STATE yy_scan_string (yyconst char *yy_str ); +| YY_BUFFER_STATE yy_scan_bytes (yyconst char *bytes,yy_size_t len ); +| +| void *yyalloc (yy_size_t ); +| void *yyrealloc (void *,yy_size_t ); +| void yyfree (void * ); +| +| #define yy_new_buffer yy_create_buffer +| +| #define yy_set_interactive(is_interactive) \ +| { \ +| if ( ! YY_CURRENT_BUFFER ){ \ +| yyensure_buffer_stack (); \ +| YY_CURRENT_BUFFER_LVALUE = \ +| yy_create_buffer(yyin,YY_BUF_SIZE ); \ +| } \ +| YY_CURRENT_BUFFER_LVALUE->yy_is_interactive = is_interactive; \ +| } +| +| #define yy_set_bol(at_bol) \ +| { \ +| if ( ! YY_CURRENT_BUFFER ){\ +| yyensure_buffer_stack (); \ +| YY_CURRENT_BUFFER_LVALUE = \ +| yy_create_buffer(yyin,YY_BUF_SIZE ); \ +| } \ +| YY_CURRENT_BUFFER_LVALUE->yy_at_bol = at_bol; \ +| } +| +| #define YY_AT_BOL() (YY_CURRENT_BUFFER_LVALUE->yy_at_bol) +| +| /* Begin user sect3 */ +| +| typedef unsigned char YY_CHAR; +| +| FILE *yyin = (FILE *) 0, *yyout = (FILE *) 0; +| +| typedef int yy_state_type; +| +| extern int yylineno; +| +| int yylineno = 1; +| +| extern char *yytext; +| #define yytext_ptr yytext +| +| static yy_state_type yy_get_previous_state (void ); +| static yy_state_type yy_try_NUL_trans (yy_state_type current_state ); +| static int yy_get_next_buffer (void ); +| static void yy_fatal_error (yyconst char msg[] ); +| +| /* Done after the current pattern has been matched and before the +| * corresponding action - sets up yytext. +| */ +| #define YY_DO_BEFORE_ACTION \ +| (yytext_ptr) = yy_bp; \ +| (yytext_ptr) -= (yy_more_len); \ +| yyleng = (size_t) (yy_cp - (yytext_ptr)); \ +| (yy_hold_char) = *yy_cp; \ +| *yy_cp = '\0'; \ +| (yy_c_buf_p) = yy_cp; +| +| #define YY_NUM_RULES 8 +| #define YY_END_OF_BUFFER 9 +| /* This struct is not used in this scanner, +| but its presence is necessary. */ +| struct yy_trans_info +| { +| flex_int32_t yy_verify; +| flex_int32_t yy_nxt; +| }; +| static yyconst flex_int16_t yy_acclist[23] = +| { 0, +| 9, 7, 8, 8, 1, 7, 8, 2, 7, 8, +| 3, 7, 8, 4, 7, 8, 5, 7, 8, 6, +| 7, 8 +| } ; +| +| static yyconst flex_int16_t yy_accept[14] = +| { 0, +| 1, 1, 1, 2, 4, 5, 8, 11, 14, 17, +| 20, 23, 23 +| } ; +| +| static yyconst flex_int32_t yy_ec[256] = +| { 0, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 2, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 3, 4, 5, 6, +| +| 7, 8, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1 +| } ; +| +| static yyconst flex_int32_t yy_meta[9] = +| { 0, +| 1, 1, 1, 1, 1, 1, 1, 1 +| } ; +| +| static yyconst flex_int16_t yy_base[13] = +| { 0, +| 0, 0, 9, 10, 10, 10, 10, 10, 10, 10, +| 10, 10 +| } ; +| +| static yyconst flex_int16_t yy_def[13] = +| { 0, +| 12, 1, 12, 12, 12, 12, 12, 12, 12, 12, +| 12, 0 +| } ; +| +| static yyconst flex_int16_t yy_nxt[19] = +| { 0, +| 4, 5, 6, 7, 8, 9, 10, 11, 12, 3, +| 12, 12, 12, 12, 12, 12, 12, 12 +| } ; +| +| static yyconst flex_int16_t yy_chk[19] = +| { 0, +| 1, 1, 1, 1, 1, 1, 1, 1, 3, 12, +| 12, 12, 12, 12, 12, 12, 12, 12 +| } ; +| +| extern int yy_flex_debug; +| int yy_flex_debug = 0; +| +| static yy_state_type *yy_state_buf=0, *yy_state_ptr=0; +| static char *yy_full_match; +| static int yy_lp; +| #define REJECT \ +| { \ +| *yy_cp = (yy_hold_char); /* undo effects of setting up yytext */ \ +| yy_cp = (yy_full_match); /* restore poss. backed-over text */ \ +| ++(yy_lp); \ +| goto find_rule; \ +| } +| +| static int yy_more_flag = 0; +| static int yy_more_len = 0; +| #define yymore() ((yy_more_flag) = 1) +| #define YY_MORE_ADJ (yy_more_len) +| #define YY_RESTORE_YY_MORE_OFFSET +| char *yytext; +| #line 1 "conftest.l" +| #line 469 "lex.yy.c" +| +| #define INITIAL 0 +| +| #ifndef YY_NO_UNISTD_H +| /* Special case for "unistd.h", since it is non-ANSI. We include it way +| * down here because we want the user's section 1 to have been scanned first. +| * The user has a chance to override it with an option. +| */ +| #include +| #endif +| +| #ifndef YY_EXTRA_TYPE +| #define YY_EXTRA_TYPE void * +| #endif +| +| static int yy_init_globals (void ); +| +| /* Accessor methods to globals. +| These are made visible to non-reentrant scanners for convenience. */ +| +| int yylex_destroy (void ); +| +| int yyget_debug (void ); +| +| void yyset_debug (int debug_flag ); +| +| YY_EXTRA_TYPE yyget_extra (void ); +| +| void yyset_extra (YY_EXTRA_TYPE user_defined ); +| +| FILE *yyget_in (void ); +| +| void yyset_in (FILE * in_str ); +| +| FILE *yyget_out (void ); +| +| void yyset_out (FILE * out_str ); +| +| yy_size_t yyget_leng (void ); +| +| char *yyget_text (void ); +| +| int yyget_lineno (void ); +| +| void yyset_lineno (int line_number ); +| +| /* Macros after this point can all be overridden by user definitions in +| * section 1. +| */ +| +| #ifndef YY_SKIP_YYWRAP +| #ifdef __cplusplus +| extern "C" int yywrap (void ); +| #else +| extern int yywrap (void ); +| #endif +| #endif +| +| static void yyunput (int c,char *buf_ptr ); +| +| #ifndef yytext_ptr +| static void yy_flex_strncpy (char *,yyconst char *,int ); +| #endif +| +| #ifdef YY_NEED_STRLEN +| static int yy_flex_strlen (yyconst char * ); +| #endif +| +| #ifndef YY_NO_INPUT +| +| #ifdef __cplusplus +| static int yyinput (void ); +| #else +| static int input (void ); +| #endif +| +| #endif +| +| /* Amount of stuff to slurp up with each read. */ +| #ifndef YY_READ_BUF_SIZE +| #define YY_READ_BUF_SIZE 8192 +| #endif +| +| /* Copy whatever the last rule matched to the standard output. */ +| #ifndef ECHO +| /* This used to be an fputs(), but since the string might contain NUL's, +| * we now use fwrite(). +| */ +| #define ECHO do { if (fwrite( yytext, yyleng, 1, yyout )) {} } while (0) +| #endif +| +| /* Gets input and stuffs it into "buf". number of characters read, or YY_NULL, +| * is returned in "result". +| */ +| #ifndef YY_INPUT +| #define YY_INPUT(buf,result,max_size) \ +| if ( YY_CURRENT_BUFFER_LVALUE->yy_is_interactive ) \ +| { \ +| int c = '*'; \ +| size_t n; \ +| for ( n = 0; n < max_size && \ +| (c = getc( yyin )) != EOF && c != '\n'; ++n ) \ +| buf[n] = (char) c; \ +| if ( c == '\n' ) \ +| buf[n++] = (char) c; \ +| if ( c == EOF && ferror( yyin ) ) \ +| YY_FATAL_ERROR( "input in flex scanner failed" ); \ +| result = n; \ +| } \ +| else \ +| { \ +| errno=0; \ +| while ( (result = fread(buf, 1, max_size, yyin))==0 && ferror(yyin)) \ +| { \ +| if( errno != EINTR) \ +| { \ +| YY_FATAL_ERROR( "input in flex scanner failed" ); \ +| break; \ +| } \ +| errno=0; \ +| clearerr(yyin); \ +| } \ +| }\ +| \ +| +| #endif +| +| /* No semi-colon after return; correct usage is to write "yyterminate();" - +| * we don't want an extra ';' after the "return" because that will cause +| * some compilers to complain about unreachable statements. +| */ +| #ifndef yyterminate +| #define yyterminate() return YY_NULL +| #endif +| +| /* Number of entries by which start-condition stack grows. */ +| #ifndef YY_START_STACK_INCR +| #define YY_START_STACK_INCR 25 +| #endif +| +| /* Report a fatal error. */ +| #ifndef YY_FATAL_ERROR +| #define YY_FATAL_ERROR(msg) yy_fatal_error( msg ) +| #endif +| +| /* end tables serialization structures and prototypes */ +| +| /* Default declaration of generated scanner - a define so the user can +| * easily add parameters. +| */ +| #ifndef YY_DECL +| #define YY_DECL_IS_OURS 1 +| +| extern int yylex (void); +| +| #define YY_DECL int yylex (void) +| #endif /* !YY_DECL */ +| +| /* Code executed at the beginning of each rule, after yytext and yyleng +| * have been set up. +| */ +| #ifndef YY_USER_ACTION +| #define YY_USER_ACTION +| #endif +| +| /* Code executed at the end of each rule. */ +| #ifndef YY_BREAK +| #define YY_BREAK break; +| #endif +| +| #define YY_RULE_SETUP \ +| YY_USER_ACTION +| +| /** The main scanner function which does all the work. +| */ +| YY_DECL +| { +| register yy_state_type yy_current_state; +| register char *yy_cp, *yy_bp; +| register int yy_act; +| +| #line 1 "conftest.l" +| +| #line 653 "lex.yy.c" +| +| if ( !(yy_init) ) +| { +| (yy_init) = 1; +| +| #ifdef YY_USER_INIT +| YY_USER_INIT; +| #endif +| +| /* Create the reject buffer large enough to save one state per allowed character. */ +| if ( ! (yy_state_buf) ) +| (yy_state_buf) = (yy_state_type *)yyalloc(YY_STATE_BUF_SIZE ); +| if ( ! (yy_state_buf) ) +| YY_FATAL_ERROR( "out of dynamic memory in yylex()" ); +| +| if ( ! (yy_start) ) +| (yy_start) = 1; /* first start state */ +| +| if ( ! yyin ) +| yyin = stdin; +| +| if ( ! yyout ) +| yyout = stdout; +| +| if ( ! YY_CURRENT_BUFFER ) { +| yyensure_buffer_stack (); +| YY_CURRENT_BUFFER_LVALUE = +| yy_create_buffer(yyin,YY_BUF_SIZE ); +| } +| +| yy_load_buffer_state( ); +| } +| +| while ( 1 ) /* loops until end-of-file is reached */ +| { +| (yy_more_len) = 0; +| if ( (yy_more_flag) ) +| { +| (yy_more_len) = (yy_c_buf_p) - (yytext_ptr); +| (yy_more_flag) = 0; +| } +| yy_cp = (yy_c_buf_p); +| +| /* Support of yytext. */ +| *yy_cp = (yy_hold_char); +| +| /* yy_bp points to the position in yy_ch_buf of the start of +| * the current run. +| */ +| yy_bp = yy_cp; +| +| yy_current_state = (yy_start); +| +| (yy_state_ptr) = (yy_state_buf); +| *(yy_state_ptr)++ = yy_current_state; +| +| yy_match: +| do +| { +| register YY_CHAR yy_c = yy_ec[YY_SC_TO_UI(*yy_cp)]; +| while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) +| { +| yy_current_state = (int) yy_def[yy_current_state]; +| if ( yy_current_state >= 13 ) +| yy_c = yy_meta[(unsigned int) yy_c]; +| } +| yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; +| *(yy_state_ptr)++ = yy_current_state; +| ++yy_cp; +| } +| while ( yy_base[yy_current_state] != 10 ); +| +| yy_find_action: +| yy_current_state = *--(yy_state_ptr); +| (yy_lp) = yy_accept[yy_current_state]; +| find_rule: /* we branch to this label when backing up */ +| for ( ; ; ) /* until we find what rule we matched */ +| { +| if ( (yy_lp) && (yy_lp) < yy_accept[yy_current_state + 1] ) +| { +| yy_act = yy_acclist[(yy_lp)]; +| { +| (yy_full_match) = yy_cp; +| break; +| } +| } +| --yy_cp; +| yy_current_state = *--(yy_state_ptr); +| (yy_lp) = yy_accept[yy_current_state]; +| } +| +| YY_DO_BEFORE_ACTION; +| +| do_action: /* This label is used only to access EOF actions. */ +| +| switch ( yy_act ) +| { /* beginning of action switch */ +| case 1: +| YY_RULE_SETUP +| #line 2 "conftest.l" +| { ECHO; } +| YY_BREAK +| case 2: +| YY_RULE_SETUP +| #line 3 "conftest.l" +| { REJECT; } +| YY_BREAK +| case 3: +| YY_RULE_SETUP +| #line 4 "conftest.l" +| { yymore (); } +| YY_BREAK +| case 4: +| YY_RULE_SETUP +| #line 5 "conftest.l" +| { yyless (1); } +| YY_BREAK +| case 5: +| YY_RULE_SETUP +| #line 6 "conftest.l" +| { yyless (input () != 0); } +| YY_BREAK +| case 6: +| YY_RULE_SETUP +| #line 7 "conftest.l" +| { unput (yytext[0]); } +| YY_BREAK +| case 7: +| YY_RULE_SETUP +| #line 8 "conftest.l" +| { BEGIN INITIAL; } +| YY_BREAK +| case 8: +| YY_RULE_SETUP +| #line 9 "conftest.l" +| ECHO; +| YY_BREAK +| #line 791 "lex.yy.c" +| case YY_STATE_EOF(INITIAL): +| yyterminate(); +| +| case YY_END_OF_BUFFER: +| { +| /* Amount of text matched not including the EOB char. */ +| int yy_amount_of_matched_text = (int) (yy_cp - (yytext_ptr)) - 1; +| +| /* Undo the effects of YY_DO_BEFORE_ACTION. */ +| *yy_cp = (yy_hold_char); +| YY_RESTORE_YY_MORE_OFFSET +| +| if ( YY_CURRENT_BUFFER_LVALUE->yy_buffer_status == YY_BUFFER_NEW ) +| { +| /* We're scanning a new file or input source. It's +| * possible that this happened because the user +| * just pointed yyin at a new source and called +| * yylex(). If so, then we have to assure +| * consistency between YY_CURRENT_BUFFER and our +| * globals. Here is the right place to do so, because +| * this is the first action (other than possibly a +| * back-up) that will match for the new input source. +| */ +| (yy_n_chars) = YY_CURRENT_BUFFER_LVALUE->yy_n_chars; +| YY_CURRENT_BUFFER_LVALUE->yy_input_file = yyin; +| YY_CURRENT_BUFFER_LVALUE->yy_buffer_status = YY_BUFFER_NORMAL; +| } +| +| /* Note that here we test for yy_c_buf_p "<=" to the position +| * of the first EOB in the buffer, since yy_c_buf_p will +| * already have been incremented past the NUL character +| * (since all states make transitions on EOB to the +| * end-of-buffer state). Contrast this with the test +| * in input(). +| */ +| if ( (yy_c_buf_p) <= &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)] ) +| { /* This was really a NUL. */ +| yy_state_type yy_next_state; +| +| (yy_c_buf_p) = (yytext_ptr) + yy_amount_of_matched_text; +| +| yy_current_state = yy_get_previous_state( ); +| +| /* Okay, we're now positioned to make the NUL +| * transition. We couldn't have +| * yy_get_previous_state() go ahead and do it +| * for us because it doesn't know how to deal +| * with the possibility of jamming (and we don't +| * want to build jamming into it because then it +| * will run more slowly). +| */ +| +| yy_next_state = yy_try_NUL_trans( yy_current_state ); +| +| yy_bp = (yytext_ptr) + YY_MORE_ADJ; +| +| if ( yy_next_state ) +| { +| /* Consume the NUL. */ +| yy_cp = ++(yy_c_buf_p); +| yy_current_state = yy_next_state; +| goto yy_match; +| } +| +| else +| { +| yy_cp = (yy_c_buf_p); +| goto yy_find_action; +| } +| } +| +| else switch ( yy_get_next_buffer( ) ) +| { +| case EOB_ACT_END_OF_FILE: +| { +| (yy_did_buffer_switch_on_eof) = 0; +| +| if ( yywrap( ) ) +| { +| /* Note: because we've taken care in +| * yy_get_next_buffer() to have set up +| * yytext, we can now set up +| * yy_c_buf_p so that if some total +| * hoser (like flex itself) wants to +| * call the scanner after we return the +| * YY_NULL, it'll still work - another +| * YY_NULL will get returned. +| */ +| (yy_c_buf_p) = (yytext_ptr) + YY_MORE_ADJ; +| +| yy_act = YY_STATE_EOF(YY_START); +| goto do_action; +| } +| +| else +| { +| if ( ! (yy_did_buffer_switch_on_eof) ) +| YY_NEW_FILE; +| } +| break; +| } +| +| case EOB_ACT_CONTINUE_SCAN: +| (yy_c_buf_p) = +| (yytext_ptr) + yy_amount_of_matched_text; +| +| yy_current_state = yy_get_previous_state( ); +| +| yy_cp = (yy_c_buf_p); +| yy_bp = (yytext_ptr) + YY_MORE_ADJ; +| goto yy_match; +| +| case EOB_ACT_LAST_MATCH: +| (yy_c_buf_p) = +| &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)]; +| +| yy_current_state = yy_get_previous_state( ); +| +| yy_cp = (yy_c_buf_p); +| yy_bp = (yytext_ptr) + YY_MORE_ADJ; +| goto yy_find_action; +| } +| break; +| } +| +| default: +| YY_FATAL_ERROR( +| "fatal flex scanner internal error--no action found" ); +| } /* end of action switch */ +| } /* end of scanning one token */ +| } /* end of yylex */ +| +| /* yy_get_next_buffer - try to read in a new buffer +| * +| * Returns a code representing an action: +| * EOB_ACT_LAST_MATCH - +| * EOB_ACT_CONTINUE_SCAN - continue scanning from current position +| * EOB_ACT_END_OF_FILE - end of file +| */ +| static int yy_get_next_buffer (void) +| { +| register char *dest = YY_CURRENT_BUFFER_LVALUE->yy_ch_buf; +| register char *source = (yytext_ptr); +| register int number_to_move, i; +| int ret_val; +| +| if ( (yy_c_buf_p) > &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars) + 1] ) +| YY_FATAL_ERROR( +| "fatal flex scanner internal error--end of buffer missed" ); +| +| if ( YY_CURRENT_BUFFER_LVALUE->yy_fill_buffer == 0 ) +| { /* Don't try to fill the buffer, so this is an EOF. */ +| if ( (yy_c_buf_p) - (yytext_ptr) - YY_MORE_ADJ == 1 ) +| { +| /* We matched a single character, the EOB, so +| * treat this as a final EOF. +| */ +| return EOB_ACT_END_OF_FILE; +| } +| +| else +| { +| /* We matched some text prior to the EOB, first +| * process it. +| */ +| return EOB_ACT_LAST_MATCH; +| } +| } +| +| /* Try to read more data. */ +| +| /* First move last chars to start of buffer. */ +| number_to_move = (int) ((yy_c_buf_p) - (yytext_ptr)) - 1; +| +| for ( i = 0; i < number_to_move; ++i ) +| *(dest++) = *(source++); +| +| if ( YY_CURRENT_BUFFER_LVALUE->yy_buffer_status == YY_BUFFER_EOF_PENDING ) +| /* don't do the read, it's not guaranteed to return an EOF, +| * just force an EOF +| */ +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars) = 0; +| +| else +| { +| yy_size_t num_to_read = +| YY_CURRENT_BUFFER_LVALUE->yy_buf_size - number_to_move - 1; +| +| while ( num_to_read <= 0 ) +| { /* Not enough room in the buffer - grow it. */ +| +| YY_FATAL_ERROR( +| "input buffer overflow, can't enlarge buffer because scanner uses REJECT" ); +| +| } +| +| if ( num_to_read > YY_READ_BUF_SIZE ) +| num_to_read = YY_READ_BUF_SIZE; +| +| /* Read in more data. */ +| YY_INPUT( (&YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[number_to_move]), +| (yy_n_chars), num_to_read ); +| +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars); +| } +| +| if ( (yy_n_chars) == 0 ) +| { +| if ( number_to_move == YY_MORE_ADJ ) +| { +| ret_val = EOB_ACT_END_OF_FILE; +| yyrestart(yyin ); +| } +| +| else +| { +| ret_val = EOB_ACT_LAST_MATCH; +| YY_CURRENT_BUFFER_LVALUE->yy_buffer_status = +| YY_BUFFER_EOF_PENDING; +| } +| } +| +| else +| ret_val = EOB_ACT_CONTINUE_SCAN; +| +| if ((yy_size_t) ((yy_n_chars) + number_to_move) > YY_CURRENT_BUFFER_LVALUE->yy_buf_size) { +| /* Extend the array by 50%, plus the number we really need. */ +| yy_size_t new_size = (yy_n_chars) + number_to_move + ((yy_n_chars) >> 1); +| YY_CURRENT_BUFFER_LVALUE->yy_ch_buf = (char *) yyrealloc((void *) YY_CURRENT_BUFFER_LVALUE->yy_ch_buf,new_size ); +| if ( ! YY_CURRENT_BUFFER_LVALUE->yy_ch_buf ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_get_next_buffer()" ); +| } +| +| (yy_n_chars) += number_to_move; +| YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)] = YY_END_OF_BUFFER_CHAR; +| YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars) + 1] = YY_END_OF_BUFFER_CHAR; +| +| (yytext_ptr) = &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[0]; +| +| return ret_val; +| } +| +| /* yy_get_previous_state - get the state just before the EOB char was reached */ +| +| static yy_state_type yy_get_previous_state (void) +| { +| register yy_state_type yy_current_state; +| register char *yy_cp; +| +| yy_current_state = (yy_start); +| +| (yy_state_ptr) = (yy_state_buf); +| *(yy_state_ptr)++ = yy_current_state; +| +| for ( yy_cp = (yytext_ptr) + YY_MORE_ADJ; yy_cp < (yy_c_buf_p); ++yy_cp ) +| { +| register YY_CHAR yy_c = (*yy_cp ? yy_ec[YY_SC_TO_UI(*yy_cp)] : 1); +| while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) +| { +| yy_current_state = (int) yy_def[yy_current_state]; +| if ( yy_current_state >= 13 ) +| yy_c = yy_meta[(unsigned int) yy_c]; +| } +| yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; +| *(yy_state_ptr)++ = yy_current_state; +| } +| +| return yy_current_state; +| } +| +| /* yy_try_NUL_trans - try to make a transition on the NUL character +| * +| * synopsis +| * next_state = yy_try_NUL_trans( current_state ); +| */ +| static yy_state_type yy_try_NUL_trans (yy_state_type yy_current_state ) +| { +| register int yy_is_jam; +| +| register YY_CHAR yy_c = 1; +| while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) +| { +| yy_current_state = (int) yy_def[yy_current_state]; +| if ( yy_current_state >= 13 ) +| yy_c = yy_meta[(unsigned int) yy_c]; +| } +| yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; +| yy_is_jam = (yy_current_state == 12); +| if ( ! yy_is_jam ) +| *(yy_state_ptr)++ = yy_current_state; +| +| return yy_is_jam ? 0 : yy_current_state; +| } +| +| static void yyunput (int c, register char * yy_bp ) +| { +| register char *yy_cp; +| +| yy_cp = (yy_c_buf_p); +| +| /* undo effects of setting up yytext */ +| *yy_cp = (yy_hold_char); +| +| if ( yy_cp < YY_CURRENT_BUFFER_LVALUE->yy_ch_buf + 2 ) +| { /* need to shift things up to make room */ +| /* +2 for EOB chars. */ +| register yy_size_t number_to_move = (yy_n_chars) + 2; +| register char *dest = &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[ +| YY_CURRENT_BUFFER_LVALUE->yy_buf_size + 2]; +| register char *source = +| &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[number_to_move]; +| +| while ( source > YY_CURRENT_BUFFER_LVALUE->yy_ch_buf ) +| *--dest = *--source; +| +| yy_cp += (int) (dest - source); +| yy_bp += (int) (dest - source); +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = +| (yy_n_chars) = YY_CURRENT_BUFFER_LVALUE->yy_buf_size; +| +| if ( yy_cp < YY_CURRENT_BUFFER_LVALUE->yy_ch_buf + 2 ) +| YY_FATAL_ERROR( "flex scanner push-back overflow" ); +| } +| +| *--yy_cp = (char) c; +| +| (yytext_ptr) = yy_bp; +| (yy_hold_char) = *yy_cp; +| (yy_c_buf_p) = yy_cp; +| } +| +| #ifndef YY_NO_INPUT +| #ifdef __cplusplus +| static int yyinput (void) +| #else +| static int input (void) +| #endif +| +| { +| int c; +| +| *(yy_c_buf_p) = (yy_hold_char); +| +| if ( *(yy_c_buf_p) == YY_END_OF_BUFFER_CHAR ) +| { +| /* yy_c_buf_p now points to the character we want to return. +| * If this occurs *before* the EOB characters, then it's a +| * valid NUL; if not, then we've hit the end of the buffer. +| */ +| if ( (yy_c_buf_p) < &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)] ) +| /* This was really a NUL. */ +| *(yy_c_buf_p) = '\0'; +| +| else +| { /* need more input */ +| yy_size_t offset = (yy_c_buf_p) - (yytext_ptr); +| ++(yy_c_buf_p); +| +| switch ( yy_get_next_buffer( ) ) +| { +| case EOB_ACT_LAST_MATCH: +| /* This happens because yy_g_n_b() +| * sees that we've accumulated a +| * token and flags that we need to +| * try matching the token before +| * proceeding. But for input(), +| * there's no matching to consider. +| * So convert the EOB_ACT_LAST_MATCH +| * to EOB_ACT_END_OF_FILE. +| */ +| +| /* Reset buffer status. */ +| yyrestart(yyin ); +| +| /*FALLTHROUGH*/ +| +| case EOB_ACT_END_OF_FILE: +| { +| if ( yywrap( ) ) +| return EOF; +| +| if ( ! (yy_did_buffer_switch_on_eof) ) +| YY_NEW_FILE; +| #ifdef __cplusplus +| return yyinput(); +| #else +| return input(); +| #endif +| } +| +| case EOB_ACT_CONTINUE_SCAN: +| (yy_c_buf_p) = (yytext_ptr) + offset; +| break; +| } +| } +| } +| +| c = *(unsigned char *) (yy_c_buf_p); /* cast for 8-bit char's */ +| *(yy_c_buf_p) = '\0'; /* preserve yytext */ +| (yy_hold_char) = *++(yy_c_buf_p); +| +| return c; +| } +| #endif /* ifndef YY_NO_INPUT */ +| +| /** Immediately switch to a different input stream. +| * @param input_file A readable stream. +| * +| * @note This function does not reset the start condition to @c INITIAL . +| */ +| void yyrestart (FILE * input_file ) +| { +| +| if ( ! YY_CURRENT_BUFFER ){ +| yyensure_buffer_stack (); +| YY_CURRENT_BUFFER_LVALUE = +| yy_create_buffer(yyin,YY_BUF_SIZE ); +| } +| +| yy_init_buffer(YY_CURRENT_BUFFER,input_file ); +| yy_load_buffer_state( ); +| } +| +| /** Switch to a different input buffer. +| * @param new_buffer The new input buffer. +| * +| */ +| void yy_switch_to_buffer (YY_BUFFER_STATE new_buffer ) +| { +| +| /* TODO. We should be able to replace this entire function body +| * with +| * yypop_buffer_state(); +| * yypush_buffer_state(new_buffer); +| */ +| yyensure_buffer_stack (); +| if ( YY_CURRENT_BUFFER == new_buffer ) +| return; +| +| if ( YY_CURRENT_BUFFER ) +| { +| /* Flush out information for old buffer. */ +| *(yy_c_buf_p) = (yy_hold_char); +| YY_CURRENT_BUFFER_LVALUE->yy_buf_pos = (yy_c_buf_p); +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars); +| } +| +| YY_CURRENT_BUFFER_LVALUE = new_buffer; +| yy_load_buffer_state( ); +| +| /* We don't actually know whether we did this switch during +| * EOF (yywrap()) processing, but the only time this flag +| * is looked at is after yywrap() is called, so it's safe +| * to go ahead and always set it. +| */ +| (yy_did_buffer_switch_on_eof) = 1; +| } +| +| static void yy_load_buffer_state (void) +| { +| (yy_n_chars) = YY_CURRENT_BUFFER_LVALUE->yy_n_chars; +| (yytext_ptr) = (yy_c_buf_p) = YY_CURRENT_BUFFER_LVALUE->yy_buf_pos; +| yyin = YY_CURRENT_BUFFER_LVALUE->yy_input_file; +| (yy_hold_char) = *(yy_c_buf_p); +| } +| +| /** Allocate and initialize an input buffer state. +| * @param file A readable stream. +| * @param size The character buffer size in bytes. When in doubt, use @c YY_BUF_SIZE. +| * +| * @return the allocated buffer state. +| */ +| YY_BUFFER_STATE yy_create_buffer (FILE * file, int size ) +| { +| YY_BUFFER_STATE b; +| +| b = (YY_BUFFER_STATE) yyalloc(sizeof( struct yy_buffer_state ) ); +| if ( ! b ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_create_buffer()" ); +| +| b->yy_buf_size = size; +| +| /* yy_ch_buf has to be 2 characters longer than the size given because +| * we need to put in 2 end-of-buffer characters. +| */ +| b->yy_ch_buf = (char *) yyalloc(b->yy_buf_size + 2 ); +| if ( ! b->yy_ch_buf ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_create_buffer()" ); +| +| b->yy_is_our_buffer = 1; +| +| yy_init_buffer(b,file ); +| +| return b; +| } +| +| /** Destroy the buffer. +| * @param b a buffer created with yy_create_buffer() +| * +| */ +| void yy_delete_buffer (YY_BUFFER_STATE b ) +| { +| +| if ( ! b ) +| return; +| +| if ( b == YY_CURRENT_BUFFER ) /* Not sure if we should pop here. */ +| YY_CURRENT_BUFFER_LVALUE = (YY_BUFFER_STATE) 0; +| +| if ( b->yy_is_our_buffer ) +| yyfree((void *) b->yy_ch_buf ); +| +| yyfree((void *) b ); +| } +| +| /* Initializes or reinitializes a buffer. +| * This function is sometimes called more than once on the same buffer, +| * such as during a yyrestart() or at EOF. +| */ +| static void yy_init_buffer (YY_BUFFER_STATE b, FILE * file ) +| +| { +| int oerrno = errno; +| +| yy_flush_buffer(b ); +| +| b->yy_input_file = file; +| b->yy_fill_buffer = 1; +| +| /* If b is the current buffer, then yy_init_buffer was _probably_ +| * called from yyrestart() or through yy_get_next_buffer. +| * In that case, we don't want to reset the lineno or column. +| */ +| if (b != YY_CURRENT_BUFFER){ +| b->yy_bs_lineno = 1; +| b->yy_bs_column = 0; +| } +| +| b->yy_is_interactive = file ? (isatty( fileno(file) ) > 0) : 0; +| +| errno = oerrno; +| } +| +| /** Discard all buffered characters. On the next scan, YY_INPUT will be called. +| * @param b the buffer state to be flushed, usually @c YY_CURRENT_BUFFER. +| * +| */ +| void yy_flush_buffer (YY_BUFFER_STATE b ) +| { +| if ( ! b ) +| return; +| +| b->yy_n_chars = 0; +| +| /* We always need two end-of-buffer characters. The first causes +| * a transition to the end-of-buffer state. The second causes +| * a jam in that state. +| */ +| b->yy_ch_buf[0] = YY_END_OF_BUFFER_CHAR; +| b->yy_ch_buf[1] = YY_END_OF_BUFFER_CHAR; +| +| b->yy_buf_pos = &b->yy_ch_buf[0]; +| +| b->yy_at_bol = 1; +| b->yy_buffer_status = YY_BUFFER_NEW; +| +| if ( b == YY_CURRENT_BUFFER ) +| yy_load_buffer_state( ); +| } +| +| /** Pushes the new state onto the stack. The new state becomes +| * the current state. This function will allocate the stack +| * if necessary. +| * @param new_buffer The new state. +| * +| */ +| void yypush_buffer_state (YY_BUFFER_STATE new_buffer ) +| { +| if (new_buffer == NULL) +| return; +| +| yyensure_buffer_stack(); +| +| /* This block is copied from yy_switch_to_buffer. */ +| if ( YY_CURRENT_BUFFER ) +| { +| /* Flush out information for old buffer. */ +| *(yy_c_buf_p) = (yy_hold_char); +| YY_CURRENT_BUFFER_LVALUE->yy_buf_pos = (yy_c_buf_p); +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars); +| } +| +| /* Only push if top exists. Otherwise, replace top. */ +| if (YY_CURRENT_BUFFER) +| (yy_buffer_stack_top)++; +| YY_CURRENT_BUFFER_LVALUE = new_buffer; +| +| /* copied from yy_switch_to_buffer. */ +| yy_load_buffer_state( ); +| (yy_did_buffer_switch_on_eof) = 1; +| } +| +| /** Removes and deletes the top of the stack, if present. +| * The next element becomes the new top. +| * +| */ +| void yypop_buffer_state (void) +| { +| if (!YY_CURRENT_BUFFER) +| return; +| +| yy_delete_buffer(YY_CURRENT_BUFFER ); +| YY_CURRENT_BUFFER_LVALUE = NULL; +| if ((yy_buffer_stack_top) > 0) +| --(yy_buffer_stack_top); +| +| if (YY_CURRENT_BUFFER) { +| yy_load_buffer_state( ); +| (yy_did_buffer_switch_on_eof) = 1; +| } +| } +| +| /* Allocates the stack if it does not exist. +| * Guarantees space for at least one push. +| */ +| static void yyensure_buffer_stack (void) +| { +| yy_size_t num_to_alloc; +| +| if (!(yy_buffer_stack)) { +| +| /* First allocation is just for 2 elements, since we don't know if this +| * scanner will even need a stack. We use 2 instead of 1 to avoid an +| * immediate realloc on the next call. +| */ +| num_to_alloc = 1; +| (yy_buffer_stack) = (struct yy_buffer_state**)yyalloc +| (num_to_alloc * sizeof(struct yy_buffer_state*) +| ); +| if ( ! (yy_buffer_stack) ) +| YY_FATAL_ERROR( "out of dynamic memory in yyensure_buffer_stack()" ); +| +| memset((yy_buffer_stack), 0, num_to_alloc * sizeof(struct yy_buffer_state*)); +| +| (yy_buffer_stack_max) = num_to_alloc; +| (yy_buffer_stack_top) = 0; +| return; +| } +| +| if ((yy_buffer_stack_top) >= ((yy_buffer_stack_max)) - 1){ +| +| /* Increase the buffer to prepare for a possible push. */ +| int grow_size = 8 /* arbitrary grow size */; +| +| num_to_alloc = (yy_buffer_stack_max) + grow_size; +| (yy_buffer_stack) = (struct yy_buffer_state**)yyrealloc +| ((yy_buffer_stack), +| num_to_alloc * sizeof(struct yy_buffer_state*) +| ); +| if ( ! (yy_buffer_stack) ) +| YY_FATAL_ERROR( "out of dynamic memory in yyensure_buffer_stack()" ); +| +| /* zero only the new slots.*/ +| memset((yy_buffer_stack) + (yy_buffer_stack_max), 0, grow_size * sizeof(struct yy_buffer_state*)); +| (yy_buffer_stack_max) = num_to_alloc; +| } +| } +| +| /** Setup the input buffer state to scan directly from a user-specified character buffer. +| * @param base the character buffer +| * @param size the size in bytes of the character buffer +| * +| * @return the newly allocated buffer state object. +| */ +| YY_BUFFER_STATE yy_scan_buffer (char * base, yy_size_t size ) +| { +| YY_BUFFER_STATE b; +| +| if ( size < 2 || +| base[size-2] != YY_END_OF_BUFFER_CHAR || +| base[size-1] != YY_END_OF_BUFFER_CHAR ) +| /* They forgot to leave room for the EOB's. */ +| return 0; +| +| b = (YY_BUFFER_STATE) yyalloc(sizeof( struct yy_buffer_state ) ); +| if ( ! b ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_scan_buffer()" ); +| +| b->yy_buf_size = size - 2; /* "- 2" to take care of EOB's */ +| b->yy_buf_pos = b->yy_ch_buf = base; +| b->yy_is_our_buffer = 0; +| b->yy_input_file = 0; +| b->yy_n_chars = b->yy_buf_size; +| b->yy_is_interactive = 0; +| b->yy_at_bol = 1; +| b->yy_fill_buffer = 0; +| b->yy_buffer_status = YY_BUFFER_NEW; +| +| yy_switch_to_buffer(b ); +| +| return b; +| } +| +| /** Setup the input buffer state to scan a string. The next call to yylex() will +| * scan from a @e copy of @a str. +| * @param yystr a NUL-terminated string to scan +| * +| * @return the newly allocated buffer state object. +| * @note If you want to scan bytes that may contain NUL values, then use +| * yy_scan_bytes() instead. +| */ +| YY_BUFFER_STATE yy_scan_string (yyconst char * yystr ) +| { +| +| return yy_scan_bytes(yystr,strlen(yystr) ); +| } +| +| /** Setup the input buffer state to scan the given bytes. The next call to yylex() will +| * scan from a @e copy of @a bytes. +| * @param yybytes the byte buffer to scan +| * @param _yybytes_len the number of bytes in the buffer pointed to by @a bytes. +| * +| * @return the newly allocated buffer state object. +| */ +| YY_BUFFER_STATE yy_scan_bytes (yyconst char * yybytes, yy_size_t _yybytes_len ) +| { +| YY_BUFFER_STATE b; +| char *buf; +| yy_size_t n; +| yy_size_t i; +| +| /* Get memory for full buffer, including space for trailing EOB's. */ +| n = _yybytes_len + 2; +| buf = (char *) yyalloc(n ); +| if ( ! buf ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_scan_bytes()" ); +| +| for ( i = 0; i < _yybytes_len; ++i ) +| buf[i] = yybytes[i]; +| +| buf[_yybytes_len] = buf[_yybytes_len+1] = YY_END_OF_BUFFER_CHAR; +| +| b = yy_scan_buffer(buf,n ); +| if ( ! b ) +| YY_FATAL_ERROR( "bad buffer in yy_scan_bytes()" ); +| +| /* It's okay to grow etc. this buffer, and we should throw it +| * away when we're done. +| */ +| b->yy_is_our_buffer = 1; +| +| return b; +| } +| +| #ifndef YY_EXIT_FAILURE +| #define YY_EXIT_FAILURE 2 +| #endif +| +| static void yy_fatal_error (yyconst char* msg ) +| { +| (void) fprintf( stderr, "%s\n", msg ); +| exit( YY_EXIT_FAILURE ); +| } +| +| /* Redefine yyless() so it works in section 3 code. */ +| +| #undef yyless +| #define yyless(n) \ +| do \ +| { \ +| /* Undo effects of setting up yytext. */ \ +| int yyless_macro_arg = (n); \ +| YY_LESS_LINENO(yyless_macro_arg);\ +| yytext[yyleng] = (yy_hold_char); \ +| (yy_c_buf_p) = yytext + yyless_macro_arg; \ +| (yy_hold_char) = *(yy_c_buf_p); \ +| *(yy_c_buf_p) = '\0'; \ +| yyleng = yyless_macro_arg; \ +| } \ +| while ( 0 ) +| +| /* Accessor methods (get/set functions) to struct members. */ +| +| /** Get the current line number. +| * +| */ +| int yyget_lineno (void) +| { +| +| return yylineno; +| } +| +| /** Get the input stream. +| * +| */ +| FILE *yyget_in (void) +| { +| return yyin; +| } +| +| /** Get the output stream. +| * +| */ +| FILE *yyget_out (void) +| { +| return yyout; +| } +| +| /** Get the length of the current token. +| * +| */ +| yy_size_t yyget_leng (void) +| { +| return yyleng; +| } +| +| /** Get the current token. +| * +| */ +| +| char *yyget_text (void) +| { +| return yytext; +| } +| +| /** Set the current line number. +| * @param line_number +| * +| */ +| void yyset_lineno (int line_number ) +| { +| +| yylineno = line_number; +| } +| +| /** Set the input stream. This does not discard the current +| * input buffer. +| * @param in_str A readable stream. +| * +| * @see yy_switch_to_buffer +| */ +| void yyset_in (FILE * in_str ) +| { +| yyin = in_str ; +| } +| +| void yyset_out (FILE * out_str ) +| { +| yyout = out_str ; +| } +| +| int yyget_debug (void) +| { +| return yy_flex_debug; +| } +| +| void yyset_debug (int bdebug ) +| { +| yy_flex_debug = bdebug ; +| } +| +| static int yy_init_globals (void) +| { +| /* Initialization is the same as for the non-reentrant scanner. +| * This function is called from yylex_destroy(), so don't allocate here. +| */ +| +| (yy_buffer_stack) = 0; +| (yy_buffer_stack_top) = 0; +| (yy_buffer_stack_max) = 0; +| (yy_c_buf_p) = (char *) 0; +| (yy_init) = 0; +| (yy_start) = 0; +| +| (yy_state_buf) = 0; +| (yy_state_ptr) = 0; +| (yy_full_match) = 0; +| (yy_lp) = 0; +| +| /* Defined in main.c */ +| #ifdef YY_STDINIT +| yyin = stdin; +| yyout = stdout; +| #else +| yyin = (FILE *) 0; +| yyout = (FILE *) 0; +| #endif +| +| /* For future reference: Set errno on error, since we are called by +| * yylex_init() +| */ +| return 0; +| } +| +| /* yylex_destroy is for both reentrant and non-reentrant scanners. */ +| int yylex_destroy (void) +| { +| +| /* Pop the buffer stack, destroying each element. */ +| while(YY_CURRENT_BUFFER){ +| yy_delete_buffer(YY_CURRENT_BUFFER ); +| YY_CURRENT_BUFFER_LVALUE = NULL; +| yypop_buffer_state(); +| } +| +| /* Destroy the stack itself. */ +| yyfree((yy_buffer_stack) ); +| (yy_buffer_stack) = NULL; +| +| yyfree ( (yy_state_buf) ); +| (yy_state_buf) = NULL; +| +| /* Reset the globals. This is important in a non-reentrant scanner so the next time +| * yylex() is called, initialization will occur. */ +| yy_init_globals( ); +| +| return 0; +| } +| +| /* +| * Internal utility routines. +| */ +| +| #ifndef yytext_ptr +| static void yy_flex_strncpy (char* s1, yyconst char * s2, int n ) +| { +| register int i; +| for ( i = 0; i < n; ++i ) +| s1[i] = s2[i]; +| } +| #endif +| +| #ifdef YY_NEED_STRLEN +| static int yy_flex_strlen (yyconst char * s ) +| { +| register int n; +| for ( n = 0; s[n]; ++n ) +| ; +| +| return n; +| } +| #endif +| +| void *yyalloc (yy_size_t size ) +| { +| return (void *) malloc( size ); +| } +| +| void *yyrealloc (void * ptr, yy_size_t size ) +| { +| /* The cast to (char *) in the following accommodates both +| * implementations that use char* generic pointers, and those +| * that use void* generic pointers. It works with the latter +| * because both ANSI C and C++ allow castless assignment from +| * any pointer type to void*, and deal with argument conversions +| * as though doing an assignment. +| */ +| return (void *) realloc( (char *) ptr, size ); +| } +| +| void yyfree (void * ptr ) +| { +| free( (char *) ptr ); /* see yyrealloc() for (char *) cast */ +| } +| +| #define YYTABLES_NAME "yytables" +| +| #line 9 "conftest.l" +| +| +| #ifdef YYTEXT_POINTER +| extern char *yytext; +| #endif +| int +| main (void) +| { +| return ! yylex () + ! yywrap (); +| } +configure:16305: gcc -o conftest -g -O2 conftest.c -lfl >&5 +/usr/bin/ld: cannot find -lfl +collect2: error: ld returned 1 exit status +configure:16305: $? = 1 +configure: failed program was: +| /* confdefs.h */ +| #define PACKAGE_NAME "libconfig" +| #define PACKAGE_TARNAME "libconfig" +| #define PACKAGE_VERSION "1.4.9" +| #define PACKAGE_STRING "libconfig 1.4.9" +| #define PACKAGE_BUGREPORT "hyperrealm@gmail.com" +| #define PACKAGE_URL "http://www.hyperrealm.com/main.php?s=libconfig" +| #define PACKAGE "libconfig" +| #define VERSION "1.4.9" +| #define TARGET "x86_64-unknown-linux-gnu" +| #define STDC_HEADERS 1 +| #define HAVE_SYS_TYPES_H 1 +| #define HAVE_SYS_STAT_H 1 +| #define HAVE_STDLIB_H 1 +| #define HAVE_STRING_H 1 +| #define HAVE_MEMORY_H 1 +| #define HAVE_STRINGS_H 1 +| #define HAVE_INTTYPES_H 1 +| #define HAVE_STDINT_H 1 +| #define HAVE_UNISTD_H 1 +| #define __EXTENSIONS__ 1 +| #define _ALL_SOURCE 1 +| #define _GNU_SOURCE 1 +| #define _POSIX_PTHREAD_SEMANTICS 1 +| #define _TANDEM_SOURCE 1 +| #define HAVE_DLFCN_H 1 +| #define LT_OBJDIR ".libs/" +| /* end confdefs.h. */ +| +| #line 3 "lex.yy.c" +| +| #define YY_INT_ALIGNED short int +| +| /* A lexical scanner generated by flex */ +| +| #define FLEX_SCANNER +| #define YY_FLEX_MAJOR_VERSION 2 +| #define YY_FLEX_MINOR_VERSION 5 +| #define YY_FLEX_SUBMINOR_VERSION 37 +| #if YY_FLEX_SUBMINOR_VERSION > 0 +| #define FLEX_BETA +| #endif +| +| /* First, we deal with platform-specific or compiler-specific issues. */ +| +| /* begin standard C headers. */ +| #include +| #include +| #include +| #include +| +| /* end standard C headers. */ +| +| /* flex integer type definitions */ +| +| #ifndef FLEXINT_H +| #define FLEXINT_H +| +| /* C99 systems have . Non-C99 systems may or may not. */ +| +| #if defined (__STDC_VERSION__) && __STDC_VERSION__ >= 199901L +| +| /* C99 says to define __STDC_LIMIT_MACROS before including stdint.h, +| * if you want the limit (max/min) macros for int types. +| */ +| #ifndef __STDC_LIMIT_MACROS +| #define __STDC_LIMIT_MACROS 1 +| #endif +| +| #include +| typedef int8_t flex_int8_t; +| typedef uint8_t flex_uint8_t; +| typedef int16_t flex_int16_t; +| typedef uint16_t flex_uint16_t; +| typedef int32_t flex_int32_t; +| typedef uint32_t flex_uint32_t; +| #else +| typedef signed char flex_int8_t; +| typedef short int flex_int16_t; +| typedef int flex_int32_t; +| typedef unsigned char flex_uint8_t; +| typedef unsigned short int flex_uint16_t; +| typedef unsigned int flex_uint32_t; +| +| /* Limits of integral types. */ +| #ifndef INT8_MIN +| #define INT8_MIN (-128) +| #endif +| #ifndef INT16_MIN +| #define INT16_MIN (-32767-1) +| #endif +| #ifndef INT32_MIN +| #define INT32_MIN (-2147483647-1) +| #endif +| #ifndef INT8_MAX +| #define INT8_MAX (127) +| #endif +| #ifndef INT16_MAX +| #define INT16_MAX (32767) +| #endif +| #ifndef INT32_MAX +| #define INT32_MAX (2147483647) +| #endif +| #ifndef UINT8_MAX +| #define UINT8_MAX (255U) +| #endif +| #ifndef UINT16_MAX +| #define UINT16_MAX (65535U) +| #endif +| #ifndef UINT32_MAX +| #define UINT32_MAX (4294967295U) +| #endif +| +| #endif /* ! C99 */ +| +| #endif /* ! FLEXINT_H */ +| +| #ifdef __cplusplus +| +| /* The "const" storage-class-modifier is valid. */ +| #define YY_USE_CONST +| +| #else /* ! __cplusplus */ +| +| /* C99 requires __STDC__ to be defined as 1. */ +| #if defined (__STDC__) +| +| #define YY_USE_CONST +| +| #endif /* defined (__STDC__) */ +| #endif /* ! __cplusplus */ +| +| #ifdef YY_USE_CONST +| #define yyconst const +| #else +| #define yyconst +| #endif +| +| /* Returned upon end-of-file. */ +| #define YY_NULL 0 +| +| /* Promotes a possibly negative, possibly signed char to an unsigned +| * integer for use as an array index. If the signed char is negative, +| * we want to instead treat it as an 8-bit unsigned char, hence the +| * double cast. +| */ +| #define YY_SC_TO_UI(c) ((unsigned int) (unsigned char) c) +| +| /* Enter a start condition. This macro really ought to take a parameter, +| * but we do it the disgusting crufty way forced on us by the ()-less +| * definition of BEGIN. +| */ +| #define BEGIN (yy_start) = 1 + 2 * +| +| /* Translate the current start state into a value that can be later handed +| * to BEGIN to return to the state. The YYSTATE alias is for lex +| * compatibility. +| */ +| #define YY_START (((yy_start) - 1) / 2) +| #define YYSTATE YY_START +| +| /* Action number for EOF rule of a given start state. */ +| #define YY_STATE_EOF(state) (YY_END_OF_BUFFER + state + 1) +| +| /* Special action meaning "start processing a new file". */ +| #define YY_NEW_FILE yyrestart(yyin ) +| +| #define YY_END_OF_BUFFER_CHAR 0 +| +| /* Size of default input buffer. */ +| #ifndef YY_BUF_SIZE +| #define YY_BUF_SIZE 16384 +| #endif +| +| /* The state buf must be large enough to hold one state per character in the main buffer. +| */ +| #define YY_STATE_BUF_SIZE ((YY_BUF_SIZE + 2) * sizeof(yy_state_type)) +| +| #ifndef YY_TYPEDEF_YY_BUFFER_STATE +| #define YY_TYPEDEF_YY_BUFFER_STATE +| typedef struct yy_buffer_state *YY_BUFFER_STATE; +| #endif +| +| #ifndef YY_TYPEDEF_YY_SIZE_T +| #define YY_TYPEDEF_YY_SIZE_T +| typedef size_t yy_size_t; +| #endif +| +| extern yy_size_t yyleng; +| +| extern FILE *yyin, *yyout; +| +| #define EOB_ACT_CONTINUE_SCAN 0 +| #define EOB_ACT_END_OF_FILE 1 +| #define EOB_ACT_LAST_MATCH 2 +| +| #define YY_LESS_LINENO(n) +| +| /* Return all but the first "n" matched characters back to the input stream. */ +| #define yyless(n) \ +| do \ +| { \ +| /* Undo effects of setting up yytext. */ \ +| int yyless_macro_arg = (n); \ +| YY_LESS_LINENO(yyless_macro_arg);\ +| *yy_cp = (yy_hold_char); \ +| YY_RESTORE_YY_MORE_OFFSET \ +| (yy_c_buf_p) = yy_cp = yy_bp + yyless_macro_arg - YY_MORE_ADJ; \ +| YY_DO_BEFORE_ACTION; /* set up yytext again */ \ +| } \ +| while ( 0 ) +| +| #define unput(c) yyunput( c, (yytext_ptr) ) +| +| #ifndef YY_STRUCT_YY_BUFFER_STATE +| #define YY_STRUCT_YY_BUFFER_STATE +| struct yy_buffer_state +| { +| FILE *yy_input_file; +| +| char *yy_ch_buf; /* input buffer */ +| char *yy_buf_pos; /* current position in input buffer */ +| +| /* Size of input buffer in bytes, not including room for EOB +| * characters. +| */ +| yy_size_t yy_buf_size; +| +| /* Number of characters read into yy_ch_buf, not including EOB +| * characters. +| */ +| yy_size_t yy_n_chars; +| +| /* Whether we "own" the buffer - i.e., we know we created it, +| * and can realloc() it to grow it, and should free() it to +| * delete it. +| */ +| int yy_is_our_buffer; +| +| /* Whether this is an "interactive" input source; if so, and +| * if we're using stdio for input, then we want to use getc() +| * instead of fread(), to make sure we stop fetching input after +| * each newline. +| */ +| int yy_is_interactive; +| +| /* Whether we're considered to be at the beginning of a line. +| * If so, '^' rules will be active on the next match, otherwise +| * not. +| */ +| int yy_at_bol; +| +| int yy_bs_lineno; /**< The line count. */ +| int yy_bs_column; /**< The column count. */ +| +| /* Whether to try to fill the input buffer when we reach the +| * end of it. +| */ +| int yy_fill_buffer; +| +| int yy_buffer_status; +| +| #define YY_BUFFER_NEW 0 +| #define YY_BUFFER_NORMAL 1 +| /* When an EOF's been seen but there's still some text to process +| * then we mark the buffer as YY_EOF_PENDING, to indicate that we +| * shouldn't try reading from the input source any more. We might +| * still have a bunch of tokens to match, though, because of +| * possible backing-up. +| * +| * When we actually see the EOF, we change the status to "new" +| * (via yyrestart()), so that the user can continue scanning by +| * just pointing yyin at a new input file. +| */ +| #define YY_BUFFER_EOF_PENDING 2 +| +| }; +| #endif /* !YY_STRUCT_YY_BUFFER_STATE */ +| +| /* Stack of input buffers. */ +| static size_t yy_buffer_stack_top = 0; /**< index of top of stack. */ +| static size_t yy_buffer_stack_max = 0; /**< capacity of stack. */ +| static YY_BUFFER_STATE * yy_buffer_stack = 0; /**< Stack as an array. */ +| +| /* We provide macros for accessing buffer states in case in the +| * future we want to put the buffer states in a more general +| * "scanner state". +| * +| * Returns the top of the stack, or NULL. +| */ +| #define YY_CURRENT_BUFFER ( (yy_buffer_stack) \ +| ? (yy_buffer_stack)[(yy_buffer_stack_top)] \ +| : NULL) +| +| /* Same as previous macro, but useful when we know that the buffer stack is not +| * NULL or when we need an lvalue. For internal use only. +| */ +| #define YY_CURRENT_BUFFER_LVALUE (yy_buffer_stack)[(yy_buffer_stack_top)] +| +| /* yy_hold_char holds the character lost when yytext is formed. */ +| static char yy_hold_char; +| static yy_size_t yy_n_chars; /* number of characters read into yy_ch_buf */ +| yy_size_t yyleng; +| +| /* Points to current character in buffer. */ +| static char *yy_c_buf_p = (char *) 0; +| static int yy_init = 0; /* whether we need to initialize */ +| static int yy_start = 0; /* start state number */ +| +| /* Flag which is used to allow yywrap()'s to do buffer switches +| * instead of setting up a fresh yyin. A bit of a hack ... +| */ +| static int yy_did_buffer_switch_on_eof; +| +| void yyrestart (FILE *input_file ); +| void yy_switch_to_buffer (YY_BUFFER_STATE new_buffer ); +| YY_BUFFER_STATE yy_create_buffer (FILE *file,int size ); +| void yy_delete_buffer (YY_BUFFER_STATE b ); +| void yy_flush_buffer (YY_BUFFER_STATE b ); +| void yypush_buffer_state (YY_BUFFER_STATE new_buffer ); +| void yypop_buffer_state (void ); +| +| static void yyensure_buffer_stack (void ); +| static void yy_load_buffer_state (void ); +| static void yy_init_buffer (YY_BUFFER_STATE b,FILE *file ); +| +| #define YY_FLUSH_BUFFER yy_flush_buffer(YY_CURRENT_BUFFER ) +| +| YY_BUFFER_STATE yy_scan_buffer (char *base,yy_size_t size ); +| YY_BUFFER_STATE yy_scan_string (yyconst char *yy_str ); +| YY_BUFFER_STATE yy_scan_bytes (yyconst char *bytes,yy_size_t len ); +| +| void *yyalloc (yy_size_t ); +| void *yyrealloc (void *,yy_size_t ); +| void yyfree (void * ); +| +| #define yy_new_buffer yy_create_buffer +| +| #define yy_set_interactive(is_interactive) \ +| { \ +| if ( ! YY_CURRENT_BUFFER ){ \ +| yyensure_buffer_stack (); \ +| YY_CURRENT_BUFFER_LVALUE = \ +| yy_create_buffer(yyin,YY_BUF_SIZE ); \ +| } \ +| YY_CURRENT_BUFFER_LVALUE->yy_is_interactive = is_interactive; \ +| } +| +| #define yy_set_bol(at_bol) \ +| { \ +| if ( ! YY_CURRENT_BUFFER ){\ +| yyensure_buffer_stack (); \ +| YY_CURRENT_BUFFER_LVALUE = \ +| yy_create_buffer(yyin,YY_BUF_SIZE ); \ +| } \ +| YY_CURRENT_BUFFER_LVALUE->yy_at_bol = at_bol; \ +| } +| +| #define YY_AT_BOL() (YY_CURRENT_BUFFER_LVALUE->yy_at_bol) +| +| /* Begin user sect3 */ +| +| typedef unsigned char YY_CHAR; +| +| FILE *yyin = (FILE *) 0, *yyout = (FILE *) 0; +| +| typedef int yy_state_type; +| +| extern int yylineno; +| +| int yylineno = 1; +| +| extern char *yytext; +| #define yytext_ptr yytext +| +| static yy_state_type yy_get_previous_state (void ); +| static yy_state_type yy_try_NUL_trans (yy_state_type current_state ); +| static int yy_get_next_buffer (void ); +| static void yy_fatal_error (yyconst char msg[] ); +| +| /* Done after the current pattern has been matched and before the +| * corresponding action - sets up yytext. +| */ +| #define YY_DO_BEFORE_ACTION \ +| (yytext_ptr) = yy_bp; \ +| (yytext_ptr) -= (yy_more_len); \ +| yyleng = (size_t) (yy_cp - (yytext_ptr)); \ +| (yy_hold_char) = *yy_cp; \ +| *yy_cp = '\0'; \ +| (yy_c_buf_p) = yy_cp; +| +| #define YY_NUM_RULES 8 +| #define YY_END_OF_BUFFER 9 +| /* This struct is not used in this scanner, +| but its presence is necessary. */ +| struct yy_trans_info +| { +| flex_int32_t yy_verify; +| flex_int32_t yy_nxt; +| }; +| static yyconst flex_int16_t yy_acclist[23] = +| { 0, +| 9, 7, 8, 8, 1, 7, 8, 2, 7, 8, +| 3, 7, 8, 4, 7, 8, 5, 7, 8, 6, +| 7, 8 +| } ; +| +| static yyconst flex_int16_t yy_accept[14] = +| { 0, +| 1, 1, 1, 2, 4, 5, 8, 11, 14, 17, +| 20, 23, 23 +| } ; +| +| static yyconst flex_int32_t yy_ec[256] = +| { 0, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 2, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 3, 4, 5, 6, +| +| 7, 8, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1 +| } ; +| +| static yyconst flex_int32_t yy_meta[9] = +| { 0, +| 1, 1, 1, 1, 1, 1, 1, 1 +| } ; +| +| static yyconst flex_int16_t yy_base[13] = +| { 0, +| 0, 0, 9, 10, 10, 10, 10, 10, 10, 10, +| 10, 10 +| } ; +| +| static yyconst flex_int16_t yy_def[13] = +| { 0, +| 12, 1, 12, 12, 12, 12, 12, 12, 12, 12, +| 12, 0 +| } ; +| +| static yyconst flex_int16_t yy_nxt[19] = +| { 0, +| 4, 5, 6, 7, 8, 9, 10, 11, 12, 3, +| 12, 12, 12, 12, 12, 12, 12, 12 +| } ; +| +| static yyconst flex_int16_t yy_chk[19] = +| { 0, +| 1, 1, 1, 1, 1, 1, 1, 1, 3, 12, +| 12, 12, 12, 12, 12, 12, 12, 12 +| } ; +| +| extern int yy_flex_debug; +| int yy_flex_debug = 0; +| +| static yy_state_type *yy_state_buf=0, *yy_state_ptr=0; +| static char *yy_full_match; +| static int yy_lp; +| #define REJECT \ +| { \ +| *yy_cp = (yy_hold_char); /* undo effects of setting up yytext */ \ +| yy_cp = (yy_full_match); /* restore poss. backed-over text */ \ +| ++(yy_lp); \ +| goto find_rule; \ +| } +| +| static int yy_more_flag = 0; +| static int yy_more_len = 0; +| #define yymore() ((yy_more_flag) = 1) +| #define YY_MORE_ADJ (yy_more_len) +| #define YY_RESTORE_YY_MORE_OFFSET +| char *yytext; +| #line 1 "conftest.l" +| #line 469 "lex.yy.c" +| +| #define INITIAL 0 +| +| #ifndef YY_NO_UNISTD_H +| /* Special case for "unistd.h", since it is non-ANSI. We include it way +| * down here because we want the user's section 1 to have been scanned first. +| * The user has a chance to override it with an option. +| */ +| #include +| #endif +| +| #ifndef YY_EXTRA_TYPE +| #define YY_EXTRA_TYPE void * +| #endif +| +| static int yy_init_globals (void ); +| +| /* Accessor methods to globals. +| These are made visible to non-reentrant scanners for convenience. */ +| +| int yylex_destroy (void ); +| +| int yyget_debug (void ); +| +| void yyset_debug (int debug_flag ); +| +| YY_EXTRA_TYPE yyget_extra (void ); +| +| void yyset_extra (YY_EXTRA_TYPE user_defined ); +| +| FILE *yyget_in (void ); +| +| void yyset_in (FILE * in_str ); +| +| FILE *yyget_out (void ); +| +| void yyset_out (FILE * out_str ); +| +| yy_size_t yyget_leng (void ); +| +| char *yyget_text (void ); +| +| int yyget_lineno (void ); +| +| void yyset_lineno (int line_number ); +| +| /* Macros after this point can all be overridden by user definitions in +| * section 1. +| */ +| +| #ifndef YY_SKIP_YYWRAP +| #ifdef __cplusplus +| extern "C" int yywrap (void ); +| #else +| extern int yywrap (void ); +| #endif +| #endif +| +| static void yyunput (int c,char *buf_ptr ); +| +| #ifndef yytext_ptr +| static void yy_flex_strncpy (char *,yyconst char *,int ); +| #endif +| +| #ifdef YY_NEED_STRLEN +| static int yy_flex_strlen (yyconst char * ); +| #endif +| +| #ifndef YY_NO_INPUT +| +| #ifdef __cplusplus +| static int yyinput (void ); +| #else +| static int input (void ); +| #endif +| +| #endif +| +| /* Amount of stuff to slurp up with each read. */ +| #ifndef YY_READ_BUF_SIZE +| #define YY_READ_BUF_SIZE 8192 +| #endif +| +| /* Copy whatever the last rule matched to the standard output. */ +| #ifndef ECHO +| /* This used to be an fputs(), but since the string might contain NUL's, +| * we now use fwrite(). +| */ +| #define ECHO do { if (fwrite( yytext, yyleng, 1, yyout )) {} } while (0) +| #endif +| +| /* Gets input and stuffs it into "buf". number of characters read, or YY_NULL, +| * is returned in "result". +| */ +| #ifndef YY_INPUT +| #define YY_INPUT(buf,result,max_size) \ +| if ( YY_CURRENT_BUFFER_LVALUE->yy_is_interactive ) \ +| { \ +| int c = '*'; \ +| size_t n; \ +| for ( n = 0; n < max_size && \ +| (c = getc( yyin )) != EOF && c != '\n'; ++n ) \ +| buf[n] = (char) c; \ +| if ( c == '\n' ) \ +| buf[n++] = (char) c; \ +| if ( c == EOF && ferror( yyin ) ) \ +| YY_FATAL_ERROR( "input in flex scanner failed" ); \ +| result = n; \ +| } \ +| else \ +| { \ +| errno=0; \ +| while ( (result = fread(buf, 1, max_size, yyin))==0 && ferror(yyin)) \ +| { \ +| if( errno != EINTR) \ +| { \ +| YY_FATAL_ERROR( "input in flex scanner failed" ); \ +| break; \ +| } \ +| errno=0; \ +| clearerr(yyin); \ +| } \ +| }\ +| \ +| +| #endif +| +| /* No semi-colon after return; correct usage is to write "yyterminate();" - +| * we don't want an extra ';' after the "return" because that will cause +| * some compilers to complain about unreachable statements. +| */ +| #ifndef yyterminate +| #define yyterminate() return YY_NULL +| #endif +| +| /* Number of entries by which start-condition stack grows. */ +| #ifndef YY_START_STACK_INCR +| #define YY_START_STACK_INCR 25 +| #endif +| +| /* Report a fatal error. */ +| #ifndef YY_FATAL_ERROR +| #define YY_FATAL_ERROR(msg) yy_fatal_error( msg ) +| #endif +| +| /* end tables serialization structures and prototypes */ +| +| /* Default declaration of generated scanner - a define so the user can +| * easily add parameters. +| */ +| #ifndef YY_DECL +| #define YY_DECL_IS_OURS 1 +| +| extern int yylex (void); +| +| #define YY_DECL int yylex (void) +| #endif /* !YY_DECL */ +| +| /* Code executed at the beginning of each rule, after yytext and yyleng +| * have been set up. +| */ +| #ifndef YY_USER_ACTION +| #define YY_USER_ACTION +| #endif +| +| /* Code executed at the end of each rule. */ +| #ifndef YY_BREAK +| #define YY_BREAK break; +| #endif +| +| #define YY_RULE_SETUP \ +| YY_USER_ACTION +| +| /** The main scanner function which does all the work. +| */ +| YY_DECL +| { +| register yy_state_type yy_current_state; +| register char *yy_cp, *yy_bp; +| register int yy_act; +| +| #line 1 "conftest.l" +| +| #line 653 "lex.yy.c" +| +| if ( !(yy_init) ) +| { +| (yy_init) = 1; +| +| #ifdef YY_USER_INIT +| YY_USER_INIT; +| #endif +| +| /* Create the reject buffer large enough to save one state per allowed character. */ +| if ( ! (yy_state_buf) ) +| (yy_state_buf) = (yy_state_type *)yyalloc(YY_STATE_BUF_SIZE ); +| if ( ! (yy_state_buf) ) +| YY_FATAL_ERROR( "out of dynamic memory in yylex()" ); +| +| if ( ! (yy_start) ) +| (yy_start) = 1; /* first start state */ +| +| if ( ! yyin ) +| yyin = stdin; +| +| if ( ! yyout ) +| yyout = stdout; +| +| if ( ! YY_CURRENT_BUFFER ) { +| yyensure_buffer_stack (); +| YY_CURRENT_BUFFER_LVALUE = +| yy_create_buffer(yyin,YY_BUF_SIZE ); +| } +| +| yy_load_buffer_state( ); +| } +| +| while ( 1 ) /* loops until end-of-file is reached */ +| { +| (yy_more_len) = 0; +| if ( (yy_more_flag) ) +| { +| (yy_more_len) = (yy_c_buf_p) - (yytext_ptr); +| (yy_more_flag) = 0; +| } +| yy_cp = (yy_c_buf_p); +| +| /* Support of yytext. */ +| *yy_cp = (yy_hold_char); +| +| /* yy_bp points to the position in yy_ch_buf of the start of +| * the current run. +| */ +| yy_bp = yy_cp; +| +| yy_current_state = (yy_start); +| +| (yy_state_ptr) = (yy_state_buf); +| *(yy_state_ptr)++ = yy_current_state; +| +| yy_match: +| do +| { +| register YY_CHAR yy_c = yy_ec[YY_SC_TO_UI(*yy_cp)]; +| while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) +| { +| yy_current_state = (int) yy_def[yy_current_state]; +| if ( yy_current_state >= 13 ) +| yy_c = yy_meta[(unsigned int) yy_c]; +| } +| yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; +| *(yy_state_ptr)++ = yy_current_state; +| ++yy_cp; +| } +| while ( yy_base[yy_current_state] != 10 ); +| +| yy_find_action: +| yy_current_state = *--(yy_state_ptr); +| (yy_lp) = yy_accept[yy_current_state]; +| find_rule: /* we branch to this label when backing up */ +| for ( ; ; ) /* until we find what rule we matched */ +| { +| if ( (yy_lp) && (yy_lp) < yy_accept[yy_current_state + 1] ) +| { +| yy_act = yy_acclist[(yy_lp)]; +| { +| (yy_full_match) = yy_cp; +| break; +| } +| } +| --yy_cp; +| yy_current_state = *--(yy_state_ptr); +| (yy_lp) = yy_accept[yy_current_state]; +| } +| +| YY_DO_BEFORE_ACTION; +| +| do_action: /* This label is used only to access EOF actions. */ +| +| switch ( yy_act ) +| { /* beginning of action switch */ +| case 1: +| YY_RULE_SETUP +| #line 2 "conftest.l" +| { ECHO; } +| YY_BREAK +| case 2: +| YY_RULE_SETUP +| #line 3 "conftest.l" +| { REJECT; } +| YY_BREAK +| case 3: +| YY_RULE_SETUP +| #line 4 "conftest.l" +| { yymore (); } +| YY_BREAK +| case 4: +| YY_RULE_SETUP +| #line 5 "conftest.l" +| { yyless (1); } +| YY_BREAK +| case 5: +| YY_RULE_SETUP +| #line 6 "conftest.l" +| { yyless (input () != 0); } +| YY_BREAK +| case 6: +| YY_RULE_SETUP +| #line 7 "conftest.l" +| { unput (yytext[0]); } +| YY_BREAK +| case 7: +| YY_RULE_SETUP +| #line 8 "conftest.l" +| { BEGIN INITIAL; } +| YY_BREAK +| case 8: +| YY_RULE_SETUP +| #line 9 "conftest.l" +| ECHO; +| YY_BREAK +| #line 791 "lex.yy.c" +| case YY_STATE_EOF(INITIAL): +| yyterminate(); +| +| case YY_END_OF_BUFFER: +| { +| /* Amount of text matched not including the EOB char. */ +| int yy_amount_of_matched_text = (int) (yy_cp - (yytext_ptr)) - 1; +| +| /* Undo the effects of YY_DO_BEFORE_ACTION. */ +| *yy_cp = (yy_hold_char); +| YY_RESTORE_YY_MORE_OFFSET +| +| if ( YY_CURRENT_BUFFER_LVALUE->yy_buffer_status == YY_BUFFER_NEW ) +| { +| /* We're scanning a new file or input source. It's +| * possible that this happened because the user +| * just pointed yyin at a new source and called +| * yylex(). If so, then we have to assure +| * consistency between YY_CURRENT_BUFFER and our +| * globals. Here is the right place to do so, because +| * this is the first action (other than possibly a +| * back-up) that will match for the new input source. +| */ +| (yy_n_chars) = YY_CURRENT_BUFFER_LVALUE->yy_n_chars; +| YY_CURRENT_BUFFER_LVALUE->yy_input_file = yyin; +| YY_CURRENT_BUFFER_LVALUE->yy_buffer_status = YY_BUFFER_NORMAL; +| } +| +| /* Note that here we test for yy_c_buf_p "<=" to the position +| * of the first EOB in the buffer, since yy_c_buf_p will +| * already have been incremented past the NUL character +| * (since all states make transitions on EOB to the +| * end-of-buffer state). Contrast this with the test +| * in input(). +| */ +| if ( (yy_c_buf_p) <= &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)] ) +| { /* This was really a NUL. */ +| yy_state_type yy_next_state; +| +| (yy_c_buf_p) = (yytext_ptr) + yy_amount_of_matched_text; +| +| yy_current_state = yy_get_previous_state( ); +| +| /* Okay, we're now positioned to make the NUL +| * transition. We couldn't have +| * yy_get_previous_state() go ahead and do it +| * for us because it doesn't know how to deal +| * with the possibility of jamming (and we don't +| * want to build jamming into it because then it +| * will run more slowly). +| */ +| +| yy_next_state = yy_try_NUL_trans( yy_current_state ); +| +| yy_bp = (yytext_ptr) + YY_MORE_ADJ; +| +| if ( yy_next_state ) +| { +| /* Consume the NUL. */ +| yy_cp = ++(yy_c_buf_p); +| yy_current_state = yy_next_state; +| goto yy_match; +| } +| +| else +| { +| yy_cp = (yy_c_buf_p); +| goto yy_find_action; +| } +| } +| +| else switch ( yy_get_next_buffer( ) ) +| { +| case EOB_ACT_END_OF_FILE: +| { +| (yy_did_buffer_switch_on_eof) = 0; +| +| if ( yywrap( ) ) +| { +| /* Note: because we've taken care in +| * yy_get_next_buffer() to have set up +| * yytext, we can now set up +| * yy_c_buf_p so that if some total +| * hoser (like flex itself) wants to +| * call the scanner after we return the +| * YY_NULL, it'll still work - another +| * YY_NULL will get returned. +| */ +| (yy_c_buf_p) = (yytext_ptr) + YY_MORE_ADJ; +| +| yy_act = YY_STATE_EOF(YY_START); +| goto do_action; +| } +| +| else +| { +| if ( ! (yy_did_buffer_switch_on_eof) ) +| YY_NEW_FILE; +| } +| break; +| } +| +| case EOB_ACT_CONTINUE_SCAN: +| (yy_c_buf_p) = +| (yytext_ptr) + yy_amount_of_matched_text; +| +| yy_current_state = yy_get_previous_state( ); +| +| yy_cp = (yy_c_buf_p); +| yy_bp = (yytext_ptr) + YY_MORE_ADJ; +| goto yy_match; +| +| case EOB_ACT_LAST_MATCH: +| (yy_c_buf_p) = +| &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)]; +| +| yy_current_state = yy_get_previous_state( ); +| +| yy_cp = (yy_c_buf_p); +| yy_bp = (yytext_ptr) + YY_MORE_ADJ; +| goto yy_find_action; +| } +| break; +| } +| +| default: +| YY_FATAL_ERROR( +| "fatal flex scanner internal error--no action found" ); +| } /* end of action switch */ +| } /* end of scanning one token */ +| } /* end of yylex */ +| +| /* yy_get_next_buffer - try to read in a new buffer +| * +| * Returns a code representing an action: +| * EOB_ACT_LAST_MATCH - +| * EOB_ACT_CONTINUE_SCAN - continue scanning from current position +| * EOB_ACT_END_OF_FILE - end of file +| */ +| static int yy_get_next_buffer (void) +| { +| register char *dest = YY_CURRENT_BUFFER_LVALUE->yy_ch_buf; +| register char *source = (yytext_ptr); +| register int number_to_move, i; +| int ret_val; +| +| if ( (yy_c_buf_p) > &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars) + 1] ) +| YY_FATAL_ERROR( +| "fatal flex scanner internal error--end of buffer missed" ); +| +| if ( YY_CURRENT_BUFFER_LVALUE->yy_fill_buffer == 0 ) +| { /* Don't try to fill the buffer, so this is an EOF. */ +| if ( (yy_c_buf_p) - (yytext_ptr) - YY_MORE_ADJ == 1 ) +| { +| /* We matched a single character, the EOB, so +| * treat this as a final EOF. +| */ +| return EOB_ACT_END_OF_FILE; +| } +| +| else +| { +| /* We matched some text prior to the EOB, first +| * process it. +| */ +| return EOB_ACT_LAST_MATCH; +| } +| } +| +| /* Try to read more data. */ +| +| /* First move last chars to start of buffer. */ +| number_to_move = (int) ((yy_c_buf_p) - (yytext_ptr)) - 1; +| +| for ( i = 0; i < number_to_move; ++i ) +| *(dest++) = *(source++); +| +| if ( YY_CURRENT_BUFFER_LVALUE->yy_buffer_status == YY_BUFFER_EOF_PENDING ) +| /* don't do the read, it's not guaranteed to return an EOF, +| * just force an EOF +| */ +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars) = 0; +| +| else +| { +| yy_size_t num_to_read = +| YY_CURRENT_BUFFER_LVALUE->yy_buf_size - number_to_move - 1; +| +| while ( num_to_read <= 0 ) +| { /* Not enough room in the buffer - grow it. */ +| +| YY_FATAL_ERROR( +| "input buffer overflow, can't enlarge buffer because scanner uses REJECT" ); +| +| } +| +| if ( num_to_read > YY_READ_BUF_SIZE ) +| num_to_read = YY_READ_BUF_SIZE; +| +| /* Read in more data. */ +| YY_INPUT( (&YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[number_to_move]), +| (yy_n_chars), num_to_read ); +| +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars); +| } +| +| if ( (yy_n_chars) == 0 ) +| { +| if ( number_to_move == YY_MORE_ADJ ) +| { +| ret_val = EOB_ACT_END_OF_FILE; +| yyrestart(yyin ); +| } +| +| else +| { +| ret_val = EOB_ACT_LAST_MATCH; +| YY_CURRENT_BUFFER_LVALUE->yy_buffer_status = +| YY_BUFFER_EOF_PENDING; +| } +| } +| +| else +| ret_val = EOB_ACT_CONTINUE_SCAN; +| +| if ((yy_size_t) ((yy_n_chars) + number_to_move) > YY_CURRENT_BUFFER_LVALUE->yy_buf_size) { +| /* Extend the array by 50%, plus the number we really need. */ +| yy_size_t new_size = (yy_n_chars) + number_to_move + ((yy_n_chars) >> 1); +| YY_CURRENT_BUFFER_LVALUE->yy_ch_buf = (char *) yyrealloc((void *) YY_CURRENT_BUFFER_LVALUE->yy_ch_buf,new_size ); +| if ( ! YY_CURRENT_BUFFER_LVALUE->yy_ch_buf ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_get_next_buffer()" ); +| } +| +| (yy_n_chars) += number_to_move; +| YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)] = YY_END_OF_BUFFER_CHAR; +| YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars) + 1] = YY_END_OF_BUFFER_CHAR; +| +| (yytext_ptr) = &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[0]; +| +| return ret_val; +| } +| +| /* yy_get_previous_state - get the state just before the EOB char was reached */ +| +| static yy_state_type yy_get_previous_state (void) +| { +| register yy_state_type yy_current_state; +| register char *yy_cp; +| +| yy_current_state = (yy_start); +| +| (yy_state_ptr) = (yy_state_buf); +| *(yy_state_ptr)++ = yy_current_state; +| +| for ( yy_cp = (yytext_ptr) + YY_MORE_ADJ; yy_cp < (yy_c_buf_p); ++yy_cp ) +| { +| register YY_CHAR yy_c = (*yy_cp ? yy_ec[YY_SC_TO_UI(*yy_cp)] : 1); +| while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) +| { +| yy_current_state = (int) yy_def[yy_current_state]; +| if ( yy_current_state >= 13 ) +| yy_c = yy_meta[(unsigned int) yy_c]; +| } +| yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; +| *(yy_state_ptr)++ = yy_current_state; +| } +| +| return yy_current_state; +| } +| +| /* yy_try_NUL_trans - try to make a transition on the NUL character +| * +| * synopsis +| * next_state = yy_try_NUL_trans( current_state ); +| */ +| static yy_state_type yy_try_NUL_trans (yy_state_type yy_current_state ) +| { +| register int yy_is_jam; +| +| register YY_CHAR yy_c = 1; +| while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) +| { +| yy_current_state = (int) yy_def[yy_current_state]; +| if ( yy_current_state >= 13 ) +| yy_c = yy_meta[(unsigned int) yy_c]; +| } +| yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; +| yy_is_jam = (yy_current_state == 12); +| if ( ! yy_is_jam ) +| *(yy_state_ptr)++ = yy_current_state; +| +| return yy_is_jam ? 0 : yy_current_state; +| } +| +| static void yyunput (int c, register char * yy_bp ) +| { +| register char *yy_cp; +| +| yy_cp = (yy_c_buf_p); +| +| /* undo effects of setting up yytext */ +| *yy_cp = (yy_hold_char); +| +| if ( yy_cp < YY_CURRENT_BUFFER_LVALUE->yy_ch_buf + 2 ) +| { /* need to shift things up to make room */ +| /* +2 for EOB chars. */ +| register yy_size_t number_to_move = (yy_n_chars) + 2; +| register char *dest = &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[ +| YY_CURRENT_BUFFER_LVALUE->yy_buf_size + 2]; +| register char *source = +| &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[number_to_move]; +| +| while ( source > YY_CURRENT_BUFFER_LVALUE->yy_ch_buf ) +| *--dest = *--source; +| +| yy_cp += (int) (dest - source); +| yy_bp += (int) (dest - source); +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = +| (yy_n_chars) = YY_CURRENT_BUFFER_LVALUE->yy_buf_size; +| +| if ( yy_cp < YY_CURRENT_BUFFER_LVALUE->yy_ch_buf + 2 ) +| YY_FATAL_ERROR( "flex scanner push-back overflow" ); +| } +| +| *--yy_cp = (char) c; +| +| (yytext_ptr) = yy_bp; +| (yy_hold_char) = *yy_cp; +| (yy_c_buf_p) = yy_cp; +| } +| +| #ifndef YY_NO_INPUT +| #ifdef __cplusplus +| static int yyinput (void) +| #else +| static int input (void) +| #endif +| +| { +| int c; +| +| *(yy_c_buf_p) = (yy_hold_char); +| +| if ( *(yy_c_buf_p) == YY_END_OF_BUFFER_CHAR ) +| { +| /* yy_c_buf_p now points to the character we want to return. +| * If this occurs *before* the EOB characters, then it's a +| * valid NUL; if not, then we've hit the end of the buffer. +| */ +| if ( (yy_c_buf_p) < &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)] ) +| /* This was really a NUL. */ +| *(yy_c_buf_p) = '\0'; +| +| else +| { /* need more input */ +| yy_size_t offset = (yy_c_buf_p) - (yytext_ptr); +| ++(yy_c_buf_p); +| +| switch ( yy_get_next_buffer( ) ) +| { +| case EOB_ACT_LAST_MATCH: +| /* This happens because yy_g_n_b() +| * sees that we've accumulated a +| * token and flags that we need to +| * try matching the token before +| * proceeding. But for input(), +| * there's no matching to consider. +| * So convert the EOB_ACT_LAST_MATCH +| * to EOB_ACT_END_OF_FILE. +| */ +| +| /* Reset buffer status. */ +| yyrestart(yyin ); +| +| /*FALLTHROUGH*/ +| +| case EOB_ACT_END_OF_FILE: +| { +| if ( yywrap( ) ) +| return EOF; +| +| if ( ! (yy_did_buffer_switch_on_eof) ) +| YY_NEW_FILE; +| #ifdef __cplusplus +| return yyinput(); +| #else +| return input(); +| #endif +| } +| +| case EOB_ACT_CONTINUE_SCAN: +| (yy_c_buf_p) = (yytext_ptr) + offset; +| break; +| } +| } +| } +| +| c = *(unsigned char *) (yy_c_buf_p); /* cast for 8-bit char's */ +| *(yy_c_buf_p) = '\0'; /* preserve yytext */ +| (yy_hold_char) = *++(yy_c_buf_p); +| +| return c; +| } +| #endif /* ifndef YY_NO_INPUT */ +| +| /** Immediately switch to a different input stream. +| * @param input_file A readable stream. +| * +| * @note This function does not reset the start condition to @c INITIAL . +| */ +| void yyrestart (FILE * input_file ) +| { +| +| if ( ! YY_CURRENT_BUFFER ){ +| yyensure_buffer_stack (); +| YY_CURRENT_BUFFER_LVALUE = +| yy_create_buffer(yyin,YY_BUF_SIZE ); +| } +| +| yy_init_buffer(YY_CURRENT_BUFFER,input_file ); +| yy_load_buffer_state( ); +| } +| +| /** Switch to a different input buffer. +| * @param new_buffer The new input buffer. +| * +| */ +| void yy_switch_to_buffer (YY_BUFFER_STATE new_buffer ) +| { +| +| /* TODO. We should be able to replace this entire function body +| * with +| * yypop_buffer_state(); +| * yypush_buffer_state(new_buffer); +| */ +| yyensure_buffer_stack (); +| if ( YY_CURRENT_BUFFER == new_buffer ) +| return; +| +| if ( YY_CURRENT_BUFFER ) +| { +| /* Flush out information for old buffer. */ +| *(yy_c_buf_p) = (yy_hold_char); +| YY_CURRENT_BUFFER_LVALUE->yy_buf_pos = (yy_c_buf_p); +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars); +| } +| +| YY_CURRENT_BUFFER_LVALUE = new_buffer; +| yy_load_buffer_state( ); +| +| /* We don't actually know whether we did this switch during +| * EOF (yywrap()) processing, but the only time this flag +| * is looked at is after yywrap() is called, so it's safe +| * to go ahead and always set it. +| */ +| (yy_did_buffer_switch_on_eof) = 1; +| } +| +| static void yy_load_buffer_state (void) +| { +| (yy_n_chars) = YY_CURRENT_BUFFER_LVALUE->yy_n_chars; +| (yytext_ptr) = (yy_c_buf_p) = YY_CURRENT_BUFFER_LVALUE->yy_buf_pos; +| yyin = YY_CURRENT_BUFFER_LVALUE->yy_input_file; +| (yy_hold_char) = *(yy_c_buf_p); +| } +| +| /** Allocate and initialize an input buffer state. +| * @param file A readable stream. +| * @param size The character buffer size in bytes. When in doubt, use @c YY_BUF_SIZE. +| * +| * @return the allocated buffer state. +| */ +| YY_BUFFER_STATE yy_create_buffer (FILE * file, int size ) +| { +| YY_BUFFER_STATE b; +| +| b = (YY_BUFFER_STATE) yyalloc(sizeof( struct yy_buffer_state ) ); +| if ( ! b ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_create_buffer()" ); +| +| b->yy_buf_size = size; +| +| /* yy_ch_buf has to be 2 characters longer than the size given because +| * we need to put in 2 end-of-buffer characters. +| */ +| b->yy_ch_buf = (char *) yyalloc(b->yy_buf_size + 2 ); +| if ( ! b->yy_ch_buf ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_create_buffer()" ); +| +| b->yy_is_our_buffer = 1; +| +| yy_init_buffer(b,file ); +| +| return b; +| } +| +| /** Destroy the buffer. +| * @param b a buffer created with yy_create_buffer() +| * +| */ +| void yy_delete_buffer (YY_BUFFER_STATE b ) +| { +| +| if ( ! b ) +| return; +| +| if ( b == YY_CURRENT_BUFFER ) /* Not sure if we should pop here. */ +| YY_CURRENT_BUFFER_LVALUE = (YY_BUFFER_STATE) 0; +| +| if ( b->yy_is_our_buffer ) +| yyfree((void *) b->yy_ch_buf ); +| +| yyfree((void *) b ); +| } +| +| /* Initializes or reinitializes a buffer. +| * This function is sometimes called more than once on the same buffer, +| * such as during a yyrestart() or at EOF. +| */ +| static void yy_init_buffer (YY_BUFFER_STATE b, FILE * file ) +| +| { +| int oerrno = errno; +| +| yy_flush_buffer(b ); +| +| b->yy_input_file = file; +| b->yy_fill_buffer = 1; +| +| /* If b is the current buffer, then yy_init_buffer was _probably_ +| * called from yyrestart() or through yy_get_next_buffer. +| * In that case, we don't want to reset the lineno or column. +| */ +| if (b != YY_CURRENT_BUFFER){ +| b->yy_bs_lineno = 1; +| b->yy_bs_column = 0; +| } +| +| b->yy_is_interactive = file ? (isatty( fileno(file) ) > 0) : 0; +| +| errno = oerrno; +| } +| +| /** Discard all buffered characters. On the next scan, YY_INPUT will be called. +| * @param b the buffer state to be flushed, usually @c YY_CURRENT_BUFFER. +| * +| */ +| void yy_flush_buffer (YY_BUFFER_STATE b ) +| { +| if ( ! b ) +| return; +| +| b->yy_n_chars = 0; +| +| /* We always need two end-of-buffer characters. The first causes +| * a transition to the end-of-buffer state. The second causes +| * a jam in that state. +| */ +| b->yy_ch_buf[0] = YY_END_OF_BUFFER_CHAR; +| b->yy_ch_buf[1] = YY_END_OF_BUFFER_CHAR; +| +| b->yy_buf_pos = &b->yy_ch_buf[0]; +| +| b->yy_at_bol = 1; +| b->yy_buffer_status = YY_BUFFER_NEW; +| +| if ( b == YY_CURRENT_BUFFER ) +| yy_load_buffer_state( ); +| } +| +| /** Pushes the new state onto the stack. The new state becomes +| * the current state. This function will allocate the stack +| * if necessary. +| * @param new_buffer The new state. +| * +| */ +| void yypush_buffer_state (YY_BUFFER_STATE new_buffer ) +| { +| if (new_buffer == NULL) +| return; +| +| yyensure_buffer_stack(); +| +| /* This block is copied from yy_switch_to_buffer. */ +| if ( YY_CURRENT_BUFFER ) +| { +| /* Flush out information for old buffer. */ +| *(yy_c_buf_p) = (yy_hold_char); +| YY_CURRENT_BUFFER_LVALUE->yy_buf_pos = (yy_c_buf_p); +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars); +| } +| +| /* Only push if top exists. Otherwise, replace top. */ +| if (YY_CURRENT_BUFFER) +| (yy_buffer_stack_top)++; +| YY_CURRENT_BUFFER_LVALUE = new_buffer; +| +| /* copied from yy_switch_to_buffer. */ +| yy_load_buffer_state( ); +| (yy_did_buffer_switch_on_eof) = 1; +| } +| +| /** Removes and deletes the top of the stack, if present. +| * The next element becomes the new top. +| * +| */ +| void yypop_buffer_state (void) +| { +| if (!YY_CURRENT_BUFFER) +| return; +| +| yy_delete_buffer(YY_CURRENT_BUFFER ); +| YY_CURRENT_BUFFER_LVALUE = NULL; +| if ((yy_buffer_stack_top) > 0) +| --(yy_buffer_stack_top); +| +| if (YY_CURRENT_BUFFER) { +| yy_load_buffer_state( ); +| (yy_did_buffer_switch_on_eof) = 1; +| } +| } +| +| /* Allocates the stack if it does not exist. +| * Guarantees space for at least one push. +| */ +| static void yyensure_buffer_stack (void) +| { +| yy_size_t num_to_alloc; +| +| if (!(yy_buffer_stack)) { +| +| /* First allocation is just for 2 elements, since we don't know if this +| * scanner will even need a stack. We use 2 instead of 1 to avoid an +| * immediate realloc on the next call. +| */ +| num_to_alloc = 1; +| (yy_buffer_stack) = (struct yy_buffer_state**)yyalloc +| (num_to_alloc * sizeof(struct yy_buffer_state*) +| ); +| if ( ! (yy_buffer_stack) ) +| YY_FATAL_ERROR( "out of dynamic memory in yyensure_buffer_stack()" ); +| +| memset((yy_buffer_stack), 0, num_to_alloc * sizeof(struct yy_buffer_state*)); +| +| (yy_buffer_stack_max) = num_to_alloc; +| (yy_buffer_stack_top) = 0; +| return; +| } +| +| if ((yy_buffer_stack_top) >= ((yy_buffer_stack_max)) - 1){ +| +| /* Increase the buffer to prepare for a possible push. */ +| int grow_size = 8 /* arbitrary grow size */; +| +| num_to_alloc = (yy_buffer_stack_max) + grow_size; +| (yy_buffer_stack) = (struct yy_buffer_state**)yyrealloc +| ((yy_buffer_stack), +| num_to_alloc * sizeof(struct yy_buffer_state*) +| ); +| if ( ! (yy_buffer_stack) ) +| YY_FATAL_ERROR( "out of dynamic memory in yyensure_buffer_stack()" ); +| +| /* zero only the new slots.*/ +| memset((yy_buffer_stack) + (yy_buffer_stack_max), 0, grow_size * sizeof(struct yy_buffer_state*)); +| (yy_buffer_stack_max) = num_to_alloc; +| } +| } +| +| /** Setup the input buffer state to scan directly from a user-specified character buffer. +| * @param base the character buffer +| * @param size the size in bytes of the character buffer +| * +| * @return the newly allocated buffer state object. +| */ +| YY_BUFFER_STATE yy_scan_buffer (char * base, yy_size_t size ) +| { +| YY_BUFFER_STATE b; +| +| if ( size < 2 || +| base[size-2] != YY_END_OF_BUFFER_CHAR || +| base[size-1] != YY_END_OF_BUFFER_CHAR ) +| /* They forgot to leave room for the EOB's. */ +| return 0; +| +| b = (YY_BUFFER_STATE) yyalloc(sizeof( struct yy_buffer_state ) ); +| if ( ! b ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_scan_buffer()" ); +| +| b->yy_buf_size = size - 2; /* "- 2" to take care of EOB's */ +| b->yy_buf_pos = b->yy_ch_buf = base; +| b->yy_is_our_buffer = 0; +| b->yy_input_file = 0; +| b->yy_n_chars = b->yy_buf_size; +| b->yy_is_interactive = 0; +| b->yy_at_bol = 1; +| b->yy_fill_buffer = 0; +| b->yy_buffer_status = YY_BUFFER_NEW; +| +| yy_switch_to_buffer(b ); +| +| return b; +| } +| +| /** Setup the input buffer state to scan a string. The next call to yylex() will +| * scan from a @e copy of @a str. +| * @param yystr a NUL-terminated string to scan +| * +| * @return the newly allocated buffer state object. +| * @note If you want to scan bytes that may contain NUL values, then use +| * yy_scan_bytes() instead. +| */ +| YY_BUFFER_STATE yy_scan_string (yyconst char * yystr ) +| { +| +| return yy_scan_bytes(yystr,strlen(yystr) ); +| } +| +| /** Setup the input buffer state to scan the given bytes. The next call to yylex() will +| * scan from a @e copy of @a bytes. +| * @param yybytes the byte buffer to scan +| * @param _yybytes_len the number of bytes in the buffer pointed to by @a bytes. +| * +| * @return the newly allocated buffer state object. +| */ +| YY_BUFFER_STATE yy_scan_bytes (yyconst char * yybytes, yy_size_t _yybytes_len ) +| { +| YY_BUFFER_STATE b; +| char *buf; +| yy_size_t n; +| yy_size_t i; +| +| /* Get memory for full buffer, including space for trailing EOB's. */ +| n = _yybytes_len + 2; +| buf = (char *) yyalloc(n ); +| if ( ! buf ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_scan_bytes()" ); +| +| for ( i = 0; i < _yybytes_len; ++i ) +| buf[i] = yybytes[i]; +| +| buf[_yybytes_len] = buf[_yybytes_len+1] = YY_END_OF_BUFFER_CHAR; +| +| b = yy_scan_buffer(buf,n ); +| if ( ! b ) +| YY_FATAL_ERROR( "bad buffer in yy_scan_bytes()" ); +| +| /* It's okay to grow etc. this buffer, and we should throw it +| * away when we're done. +| */ +| b->yy_is_our_buffer = 1; +| +| return b; +| } +| +| #ifndef YY_EXIT_FAILURE +| #define YY_EXIT_FAILURE 2 +| #endif +| +| static void yy_fatal_error (yyconst char* msg ) +| { +| (void) fprintf( stderr, "%s\n", msg ); +| exit( YY_EXIT_FAILURE ); +| } +| +| /* Redefine yyless() so it works in section 3 code. */ +| +| #undef yyless +| #define yyless(n) \ +| do \ +| { \ +| /* Undo effects of setting up yytext. */ \ +| int yyless_macro_arg = (n); \ +| YY_LESS_LINENO(yyless_macro_arg);\ +| yytext[yyleng] = (yy_hold_char); \ +| (yy_c_buf_p) = yytext + yyless_macro_arg; \ +| (yy_hold_char) = *(yy_c_buf_p); \ +| *(yy_c_buf_p) = '\0'; \ +| yyleng = yyless_macro_arg; \ +| } \ +| while ( 0 ) +| +| /* Accessor methods (get/set functions) to struct members. */ +| +| /** Get the current line number. +| * +| */ +| int yyget_lineno (void) +| { +| +| return yylineno; +| } +| +| /** Get the input stream. +| * +| */ +| FILE *yyget_in (void) +| { +| return yyin; +| } +| +| /** Get the output stream. +| * +| */ +| FILE *yyget_out (void) +| { +| return yyout; +| } +| +| /** Get the length of the current token. +| * +| */ +| yy_size_t yyget_leng (void) +| { +| return yyleng; +| } +| +| /** Get the current token. +| * +| */ +| +| char *yyget_text (void) +| { +| return yytext; +| } +| +| /** Set the current line number. +| * @param line_number +| * +| */ +| void yyset_lineno (int line_number ) +| { +| +| yylineno = line_number; +| } +| +| /** Set the input stream. This does not discard the current +| * input buffer. +| * @param in_str A readable stream. +| * +| * @see yy_switch_to_buffer +| */ +| void yyset_in (FILE * in_str ) +| { +| yyin = in_str ; +| } +| +| void yyset_out (FILE * out_str ) +| { +| yyout = out_str ; +| } +| +| int yyget_debug (void) +| { +| return yy_flex_debug; +| } +| +| void yyset_debug (int bdebug ) +| { +| yy_flex_debug = bdebug ; +| } +| +| static int yy_init_globals (void) +| { +| /* Initialization is the same as for the non-reentrant scanner. +| * This function is called from yylex_destroy(), so don't allocate here. +| */ +| +| (yy_buffer_stack) = 0; +| (yy_buffer_stack_top) = 0; +| (yy_buffer_stack_max) = 0; +| (yy_c_buf_p) = (char *) 0; +| (yy_init) = 0; +| (yy_start) = 0; +| +| (yy_state_buf) = 0; +| (yy_state_ptr) = 0; +| (yy_full_match) = 0; +| (yy_lp) = 0; +| +| /* Defined in main.c */ +| #ifdef YY_STDINIT +| yyin = stdin; +| yyout = stdout; +| #else +| yyin = (FILE *) 0; +| yyout = (FILE *) 0; +| #endif +| +| /* For future reference: Set errno on error, since we are called by +| * yylex_init() +| */ +| return 0; +| } +| +| /* yylex_destroy is for both reentrant and non-reentrant scanners. */ +| int yylex_destroy (void) +| { +| +| /* Pop the buffer stack, destroying each element. */ +| while(YY_CURRENT_BUFFER){ +| yy_delete_buffer(YY_CURRENT_BUFFER ); +| YY_CURRENT_BUFFER_LVALUE = NULL; +| yypop_buffer_state(); +| } +| +| /* Destroy the stack itself. */ +| yyfree((yy_buffer_stack) ); +| (yy_buffer_stack) = NULL; +| +| yyfree ( (yy_state_buf) ); +| (yy_state_buf) = NULL; +| +| /* Reset the globals. This is important in a non-reentrant scanner so the next time +| * yylex() is called, initialization will occur. */ +| yy_init_globals( ); +| +| return 0; +| } +| +| /* +| * Internal utility routines. +| */ +| +| #ifndef yytext_ptr +| static void yy_flex_strncpy (char* s1, yyconst char * s2, int n ) +| { +| register int i; +| for ( i = 0; i < n; ++i ) +| s1[i] = s2[i]; +| } +| #endif +| +| #ifdef YY_NEED_STRLEN +| static int yy_flex_strlen (yyconst char * s ) +| { +| register int n; +| for ( n = 0; s[n]; ++n ) +| ; +| +| return n; +| } +| #endif +| +| void *yyalloc (yy_size_t size ) +| { +| return (void *) malloc( size ); +| } +| +| void *yyrealloc (void * ptr, yy_size_t size ) +| { +| /* The cast to (char *) in the following accommodates both +| * implementations that use char* generic pointers, and those +| * that use void* generic pointers. It works with the latter +| * because both ANSI C and C++ allow castless assignment from +| * any pointer type to void*, and deal with argument conversions +| * as though doing an assignment. +| */ +| return (void *) realloc( (char *) ptr, size ); +| } +| +| void yyfree (void * ptr ) +| { +| free( (char *) ptr ); /* see yyrealloc() for (char *) cast */ +| } +| +| #define YYTABLES_NAME "yytables" +| +| #line 9 "conftest.l" +| +| +| #ifdef YYTEXT_POINTER +| extern char *yytext; +| #endif +| int +| main (void) +| { +| return ! yylex () + ! yywrap (); +| } +configure:16305: gcc -o conftest -g -O2 conftest.c -ll >&5 +/usr/bin/ld: cannot find -ll +collect2: error: ld returned 1 exit status +configure:16305: $? = 1 +configure: failed program was: +| /* confdefs.h */ +| #define PACKAGE_NAME "libconfig" +| #define PACKAGE_TARNAME "libconfig" +| #define PACKAGE_VERSION "1.4.9" +| #define PACKAGE_STRING "libconfig 1.4.9" +| #define PACKAGE_BUGREPORT "hyperrealm@gmail.com" +| #define PACKAGE_URL "http://www.hyperrealm.com/main.php?s=libconfig" +| #define PACKAGE "libconfig" +| #define VERSION "1.4.9" +| #define TARGET "x86_64-unknown-linux-gnu" +| #define STDC_HEADERS 1 +| #define HAVE_SYS_TYPES_H 1 +| #define HAVE_SYS_STAT_H 1 +| #define HAVE_STDLIB_H 1 +| #define HAVE_STRING_H 1 +| #define HAVE_MEMORY_H 1 +| #define HAVE_STRINGS_H 1 +| #define HAVE_INTTYPES_H 1 +| #define HAVE_STDINT_H 1 +| #define HAVE_UNISTD_H 1 +| #define __EXTENSIONS__ 1 +| #define _ALL_SOURCE 1 +| #define _GNU_SOURCE 1 +| #define _POSIX_PTHREAD_SEMANTICS 1 +| #define _TANDEM_SOURCE 1 +| #define HAVE_DLFCN_H 1 +| #define LT_OBJDIR ".libs/" +| /* end confdefs.h. */ +| +| #line 3 "lex.yy.c" +| +| #define YY_INT_ALIGNED short int +| +| /* A lexical scanner generated by flex */ +| +| #define FLEX_SCANNER +| #define YY_FLEX_MAJOR_VERSION 2 +| #define YY_FLEX_MINOR_VERSION 5 +| #define YY_FLEX_SUBMINOR_VERSION 37 +| #if YY_FLEX_SUBMINOR_VERSION > 0 +| #define FLEX_BETA +| #endif +| +| /* First, we deal with platform-specific or compiler-specific issues. */ +| +| /* begin standard C headers. */ +| #include +| #include +| #include +| #include +| +| /* end standard C headers. */ +| +| /* flex integer type definitions */ +| +| #ifndef FLEXINT_H +| #define FLEXINT_H +| +| /* C99 systems have . Non-C99 systems may or may not. */ +| +| #if defined (__STDC_VERSION__) && __STDC_VERSION__ >= 199901L +| +| /* C99 says to define __STDC_LIMIT_MACROS before including stdint.h, +| * if you want the limit (max/min) macros for int types. +| */ +| #ifndef __STDC_LIMIT_MACROS +| #define __STDC_LIMIT_MACROS 1 +| #endif +| +| #include +| typedef int8_t flex_int8_t; +| typedef uint8_t flex_uint8_t; +| typedef int16_t flex_int16_t; +| typedef uint16_t flex_uint16_t; +| typedef int32_t flex_int32_t; +| typedef uint32_t flex_uint32_t; +| #else +| typedef signed char flex_int8_t; +| typedef short int flex_int16_t; +| typedef int flex_int32_t; +| typedef unsigned char flex_uint8_t; +| typedef unsigned short int flex_uint16_t; +| typedef unsigned int flex_uint32_t; +| +| /* Limits of integral types. */ +| #ifndef INT8_MIN +| #define INT8_MIN (-128) +| #endif +| #ifndef INT16_MIN +| #define INT16_MIN (-32767-1) +| #endif +| #ifndef INT32_MIN +| #define INT32_MIN (-2147483647-1) +| #endif +| #ifndef INT8_MAX +| #define INT8_MAX (127) +| #endif +| #ifndef INT16_MAX +| #define INT16_MAX (32767) +| #endif +| #ifndef INT32_MAX +| #define INT32_MAX (2147483647) +| #endif +| #ifndef UINT8_MAX +| #define UINT8_MAX (255U) +| #endif +| #ifndef UINT16_MAX +| #define UINT16_MAX (65535U) +| #endif +| #ifndef UINT32_MAX +| #define UINT32_MAX (4294967295U) +| #endif +| +| #endif /* ! C99 */ +| +| #endif /* ! FLEXINT_H */ +| +| #ifdef __cplusplus +| +| /* The "const" storage-class-modifier is valid. */ +| #define YY_USE_CONST +| +| #else /* ! __cplusplus */ +| +| /* C99 requires __STDC__ to be defined as 1. */ +| #if defined (__STDC__) +| +| #define YY_USE_CONST +| +| #endif /* defined (__STDC__) */ +| #endif /* ! __cplusplus */ +| +| #ifdef YY_USE_CONST +| #define yyconst const +| #else +| #define yyconst +| #endif +| +| /* Returned upon end-of-file. */ +| #define YY_NULL 0 +| +| /* Promotes a possibly negative, possibly signed char to an unsigned +| * integer for use as an array index. If the signed char is negative, +| * we want to instead treat it as an 8-bit unsigned char, hence the +| * double cast. +| */ +| #define YY_SC_TO_UI(c) ((unsigned int) (unsigned char) c) +| +| /* Enter a start condition. This macro really ought to take a parameter, +| * but we do it the disgusting crufty way forced on us by the ()-less +| * definition of BEGIN. +| */ +| #define BEGIN (yy_start) = 1 + 2 * +| +| /* Translate the current start state into a value that can be later handed +| * to BEGIN to return to the state. The YYSTATE alias is for lex +| * compatibility. +| */ +| #define YY_START (((yy_start) - 1) / 2) +| #define YYSTATE YY_START +| +| /* Action number for EOF rule of a given start state. */ +| #define YY_STATE_EOF(state) (YY_END_OF_BUFFER + state + 1) +| +| /* Special action meaning "start processing a new file". */ +| #define YY_NEW_FILE yyrestart(yyin ) +| +| #define YY_END_OF_BUFFER_CHAR 0 +| +| /* Size of default input buffer. */ +| #ifndef YY_BUF_SIZE +| #define YY_BUF_SIZE 16384 +| #endif +| +| /* The state buf must be large enough to hold one state per character in the main buffer. +| */ +| #define YY_STATE_BUF_SIZE ((YY_BUF_SIZE + 2) * sizeof(yy_state_type)) +| +| #ifndef YY_TYPEDEF_YY_BUFFER_STATE +| #define YY_TYPEDEF_YY_BUFFER_STATE +| typedef struct yy_buffer_state *YY_BUFFER_STATE; +| #endif +| +| #ifndef YY_TYPEDEF_YY_SIZE_T +| #define YY_TYPEDEF_YY_SIZE_T +| typedef size_t yy_size_t; +| #endif +| +| extern yy_size_t yyleng; +| +| extern FILE *yyin, *yyout; +| +| #define EOB_ACT_CONTINUE_SCAN 0 +| #define EOB_ACT_END_OF_FILE 1 +| #define EOB_ACT_LAST_MATCH 2 +| +| #define YY_LESS_LINENO(n) +| +| /* Return all but the first "n" matched characters back to the input stream. */ +| #define yyless(n) \ +| do \ +| { \ +| /* Undo effects of setting up yytext. */ \ +| int yyless_macro_arg = (n); \ +| YY_LESS_LINENO(yyless_macro_arg);\ +| *yy_cp = (yy_hold_char); \ +| YY_RESTORE_YY_MORE_OFFSET \ +| (yy_c_buf_p) = yy_cp = yy_bp + yyless_macro_arg - YY_MORE_ADJ; \ +| YY_DO_BEFORE_ACTION; /* set up yytext again */ \ +| } \ +| while ( 0 ) +| +| #define unput(c) yyunput( c, (yytext_ptr) ) +| +| #ifndef YY_STRUCT_YY_BUFFER_STATE +| #define YY_STRUCT_YY_BUFFER_STATE +| struct yy_buffer_state +| { +| FILE *yy_input_file; +| +| char *yy_ch_buf; /* input buffer */ +| char *yy_buf_pos; /* current position in input buffer */ +| +| /* Size of input buffer in bytes, not including room for EOB +| * characters. +| */ +| yy_size_t yy_buf_size; +| +| /* Number of characters read into yy_ch_buf, not including EOB +| * characters. +| */ +| yy_size_t yy_n_chars; +| +| /* Whether we "own" the buffer - i.e., we know we created it, +| * and can realloc() it to grow it, and should free() it to +| * delete it. +| */ +| int yy_is_our_buffer; +| +| /* Whether this is an "interactive" input source; if so, and +| * if we're using stdio for input, then we want to use getc() +| * instead of fread(), to make sure we stop fetching input after +| * each newline. +| */ +| int yy_is_interactive; +| +| /* Whether we're considered to be at the beginning of a line. +| * If so, '^' rules will be active on the next match, otherwise +| * not. +| */ +| int yy_at_bol; +| +| int yy_bs_lineno; /**< The line count. */ +| int yy_bs_column; /**< The column count. */ +| +| /* Whether to try to fill the input buffer when we reach the +| * end of it. +| */ +| int yy_fill_buffer; +| +| int yy_buffer_status; +| +| #define YY_BUFFER_NEW 0 +| #define YY_BUFFER_NORMAL 1 +| /* When an EOF's been seen but there's still some text to process +| * then we mark the buffer as YY_EOF_PENDING, to indicate that we +| * shouldn't try reading from the input source any more. We might +| * still have a bunch of tokens to match, though, because of +| * possible backing-up. +| * +| * When we actually see the EOF, we change the status to "new" +| * (via yyrestart()), so that the user can continue scanning by +| * just pointing yyin at a new input file. +| */ +| #define YY_BUFFER_EOF_PENDING 2 +| +| }; +| #endif /* !YY_STRUCT_YY_BUFFER_STATE */ +| +| /* Stack of input buffers. */ +| static size_t yy_buffer_stack_top = 0; /**< index of top of stack. */ +| static size_t yy_buffer_stack_max = 0; /**< capacity of stack. */ +| static YY_BUFFER_STATE * yy_buffer_stack = 0; /**< Stack as an array. */ +| +| /* We provide macros for accessing buffer states in case in the +| * future we want to put the buffer states in a more general +| * "scanner state". +| * +| * Returns the top of the stack, or NULL. +| */ +| #define YY_CURRENT_BUFFER ( (yy_buffer_stack) \ +| ? (yy_buffer_stack)[(yy_buffer_stack_top)] \ +| : NULL) +| +| /* Same as previous macro, but useful when we know that the buffer stack is not +| * NULL or when we need an lvalue. For internal use only. +| */ +| #define YY_CURRENT_BUFFER_LVALUE (yy_buffer_stack)[(yy_buffer_stack_top)] +| +| /* yy_hold_char holds the character lost when yytext is formed. */ +| static char yy_hold_char; +| static yy_size_t yy_n_chars; /* number of characters read into yy_ch_buf */ +| yy_size_t yyleng; +| +| /* Points to current character in buffer. */ +| static char *yy_c_buf_p = (char *) 0; +| static int yy_init = 0; /* whether we need to initialize */ +| static int yy_start = 0; /* start state number */ +| +| /* Flag which is used to allow yywrap()'s to do buffer switches +| * instead of setting up a fresh yyin. A bit of a hack ... +| */ +| static int yy_did_buffer_switch_on_eof; +| +| void yyrestart (FILE *input_file ); +| void yy_switch_to_buffer (YY_BUFFER_STATE new_buffer ); +| YY_BUFFER_STATE yy_create_buffer (FILE *file,int size ); +| void yy_delete_buffer (YY_BUFFER_STATE b ); +| void yy_flush_buffer (YY_BUFFER_STATE b ); +| void yypush_buffer_state (YY_BUFFER_STATE new_buffer ); +| void yypop_buffer_state (void ); +| +| static void yyensure_buffer_stack (void ); +| static void yy_load_buffer_state (void ); +| static void yy_init_buffer (YY_BUFFER_STATE b,FILE *file ); +| +| #define YY_FLUSH_BUFFER yy_flush_buffer(YY_CURRENT_BUFFER ) +| +| YY_BUFFER_STATE yy_scan_buffer (char *base,yy_size_t size ); +| YY_BUFFER_STATE yy_scan_string (yyconst char *yy_str ); +| YY_BUFFER_STATE yy_scan_bytes (yyconst char *bytes,yy_size_t len ); +| +| void *yyalloc (yy_size_t ); +| void *yyrealloc (void *,yy_size_t ); +| void yyfree (void * ); +| +| #define yy_new_buffer yy_create_buffer +| +| #define yy_set_interactive(is_interactive) \ +| { \ +| if ( ! YY_CURRENT_BUFFER ){ \ +| yyensure_buffer_stack (); \ +| YY_CURRENT_BUFFER_LVALUE = \ +| yy_create_buffer(yyin,YY_BUF_SIZE ); \ +| } \ +| YY_CURRENT_BUFFER_LVALUE->yy_is_interactive = is_interactive; \ +| } +| +| #define yy_set_bol(at_bol) \ +| { \ +| if ( ! YY_CURRENT_BUFFER ){\ +| yyensure_buffer_stack (); \ +| YY_CURRENT_BUFFER_LVALUE = \ +| yy_create_buffer(yyin,YY_BUF_SIZE ); \ +| } \ +| YY_CURRENT_BUFFER_LVALUE->yy_at_bol = at_bol; \ +| } +| +| #define YY_AT_BOL() (YY_CURRENT_BUFFER_LVALUE->yy_at_bol) +| +| /* Begin user sect3 */ +| +| typedef unsigned char YY_CHAR; +| +| FILE *yyin = (FILE *) 0, *yyout = (FILE *) 0; +| +| typedef int yy_state_type; +| +| extern int yylineno; +| +| int yylineno = 1; +| +| extern char *yytext; +| #define yytext_ptr yytext +| +| static yy_state_type yy_get_previous_state (void ); +| static yy_state_type yy_try_NUL_trans (yy_state_type current_state ); +| static int yy_get_next_buffer (void ); +| static void yy_fatal_error (yyconst char msg[] ); +| +| /* Done after the current pattern has been matched and before the +| * corresponding action - sets up yytext. +| */ +| #define YY_DO_BEFORE_ACTION \ +| (yytext_ptr) = yy_bp; \ +| (yytext_ptr) -= (yy_more_len); \ +| yyleng = (size_t) (yy_cp - (yytext_ptr)); \ +| (yy_hold_char) = *yy_cp; \ +| *yy_cp = '\0'; \ +| (yy_c_buf_p) = yy_cp; +| +| #define YY_NUM_RULES 8 +| #define YY_END_OF_BUFFER 9 +| /* This struct is not used in this scanner, +| but its presence is necessary. */ +| struct yy_trans_info +| { +| flex_int32_t yy_verify; +| flex_int32_t yy_nxt; +| }; +| static yyconst flex_int16_t yy_acclist[23] = +| { 0, +| 9, 7, 8, 8, 1, 7, 8, 2, 7, 8, +| 3, 7, 8, 4, 7, 8, 5, 7, 8, 6, +| 7, 8 +| } ; +| +| static yyconst flex_int16_t yy_accept[14] = +| { 0, +| 1, 1, 1, 2, 4, 5, 8, 11, 14, 17, +| 20, 23, 23 +| } ; +| +| static yyconst flex_int32_t yy_ec[256] = +| { 0, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 2, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 3, 4, 5, 6, +| +| 7, 8, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1 +| } ; +| +| static yyconst flex_int32_t yy_meta[9] = +| { 0, +| 1, 1, 1, 1, 1, 1, 1, 1 +| } ; +| +| static yyconst flex_int16_t yy_base[13] = +| { 0, +| 0, 0, 9, 10, 10, 10, 10, 10, 10, 10, +| 10, 10 +| } ; +| +| static yyconst flex_int16_t yy_def[13] = +| { 0, +| 12, 1, 12, 12, 12, 12, 12, 12, 12, 12, +| 12, 0 +| } ; +| +| static yyconst flex_int16_t yy_nxt[19] = +| { 0, +| 4, 5, 6, 7, 8, 9, 10, 11, 12, 3, +| 12, 12, 12, 12, 12, 12, 12, 12 +| } ; +| +| static yyconst flex_int16_t yy_chk[19] = +| { 0, +| 1, 1, 1, 1, 1, 1, 1, 1, 3, 12, +| 12, 12, 12, 12, 12, 12, 12, 12 +| } ; +| +| extern int yy_flex_debug; +| int yy_flex_debug = 0; +| +| static yy_state_type *yy_state_buf=0, *yy_state_ptr=0; +| static char *yy_full_match; +| static int yy_lp; +| #define REJECT \ +| { \ +| *yy_cp = (yy_hold_char); /* undo effects of setting up yytext */ \ +| yy_cp = (yy_full_match); /* restore poss. backed-over text */ \ +| ++(yy_lp); \ +| goto find_rule; \ +| } +| +| static int yy_more_flag = 0; +| static int yy_more_len = 0; +| #define yymore() ((yy_more_flag) = 1) +| #define YY_MORE_ADJ (yy_more_len) +| #define YY_RESTORE_YY_MORE_OFFSET +| char *yytext; +| #line 1 "conftest.l" +| #line 469 "lex.yy.c" +| +| #define INITIAL 0 +| +| #ifndef YY_NO_UNISTD_H +| /* Special case for "unistd.h", since it is non-ANSI. We include it way +| * down here because we want the user's section 1 to have been scanned first. +| * The user has a chance to override it with an option. +| */ +| #include +| #endif +| +| #ifndef YY_EXTRA_TYPE +| #define YY_EXTRA_TYPE void * +| #endif +| +| static int yy_init_globals (void ); +| +| /* Accessor methods to globals. +| These are made visible to non-reentrant scanners for convenience. */ +| +| int yylex_destroy (void ); +| +| int yyget_debug (void ); +| +| void yyset_debug (int debug_flag ); +| +| YY_EXTRA_TYPE yyget_extra (void ); +| +| void yyset_extra (YY_EXTRA_TYPE user_defined ); +| +| FILE *yyget_in (void ); +| +| void yyset_in (FILE * in_str ); +| +| FILE *yyget_out (void ); +| +| void yyset_out (FILE * out_str ); +| +| yy_size_t yyget_leng (void ); +| +| char *yyget_text (void ); +| +| int yyget_lineno (void ); +| +| void yyset_lineno (int line_number ); +| +| /* Macros after this point can all be overridden by user definitions in +| * section 1. +| */ +| +| #ifndef YY_SKIP_YYWRAP +| #ifdef __cplusplus +| extern "C" int yywrap (void ); +| #else +| extern int yywrap (void ); +| #endif +| #endif +| +| static void yyunput (int c,char *buf_ptr ); +| +| #ifndef yytext_ptr +| static void yy_flex_strncpy (char *,yyconst char *,int ); +| #endif +| +| #ifdef YY_NEED_STRLEN +| static int yy_flex_strlen (yyconst char * ); +| #endif +| +| #ifndef YY_NO_INPUT +| +| #ifdef __cplusplus +| static int yyinput (void ); +| #else +| static int input (void ); +| #endif +| +| #endif +| +| /* Amount of stuff to slurp up with each read. */ +| #ifndef YY_READ_BUF_SIZE +| #define YY_READ_BUF_SIZE 8192 +| #endif +| +| /* Copy whatever the last rule matched to the standard output. */ +| #ifndef ECHO +| /* This used to be an fputs(), but since the string might contain NUL's, +| * we now use fwrite(). +| */ +| #define ECHO do { if (fwrite( yytext, yyleng, 1, yyout )) {} } while (0) +| #endif +| +| /* Gets input and stuffs it into "buf". number of characters read, or YY_NULL, +| * is returned in "result". +| */ +| #ifndef YY_INPUT +| #define YY_INPUT(buf,result,max_size) \ +| if ( YY_CURRENT_BUFFER_LVALUE->yy_is_interactive ) \ +| { \ +| int c = '*'; \ +| size_t n; \ +| for ( n = 0; n < max_size && \ +| (c = getc( yyin )) != EOF && c != '\n'; ++n ) \ +| buf[n] = (char) c; \ +| if ( c == '\n' ) \ +| buf[n++] = (char) c; \ +| if ( c == EOF && ferror( yyin ) ) \ +| YY_FATAL_ERROR( "input in flex scanner failed" ); \ +| result = n; \ +| } \ +| else \ +| { \ +| errno=0; \ +| while ( (result = fread(buf, 1, max_size, yyin))==0 && ferror(yyin)) \ +| { \ +| if( errno != EINTR) \ +| { \ +| YY_FATAL_ERROR( "input in flex scanner failed" ); \ +| break; \ +| } \ +| errno=0; \ +| clearerr(yyin); \ +| } \ +| }\ +| \ +| +| #endif +| +| /* No semi-colon after return; correct usage is to write "yyterminate();" - +| * we don't want an extra ';' after the "return" because that will cause +| * some compilers to complain about unreachable statements. +| */ +| #ifndef yyterminate +| #define yyterminate() return YY_NULL +| #endif +| +| /* Number of entries by which start-condition stack grows. */ +| #ifndef YY_START_STACK_INCR +| #define YY_START_STACK_INCR 25 +| #endif +| +| /* Report a fatal error. */ +| #ifndef YY_FATAL_ERROR +| #define YY_FATAL_ERROR(msg) yy_fatal_error( msg ) +| #endif +| +| /* end tables serialization structures and prototypes */ +| +| /* Default declaration of generated scanner - a define so the user can +| * easily add parameters. +| */ +| #ifndef YY_DECL +| #define YY_DECL_IS_OURS 1 +| +| extern int yylex (void); +| +| #define YY_DECL int yylex (void) +| #endif /* !YY_DECL */ +| +| /* Code executed at the beginning of each rule, after yytext and yyleng +| * have been set up. +| */ +| #ifndef YY_USER_ACTION +| #define YY_USER_ACTION +| #endif +| +| /* Code executed at the end of each rule. */ +| #ifndef YY_BREAK +| #define YY_BREAK break; +| #endif +| +| #define YY_RULE_SETUP \ +| YY_USER_ACTION +| +| /** The main scanner function which does all the work. +| */ +| YY_DECL +| { +| register yy_state_type yy_current_state; +| register char *yy_cp, *yy_bp; +| register int yy_act; +| +| #line 1 "conftest.l" +| +| #line 653 "lex.yy.c" +| +| if ( !(yy_init) ) +| { +| (yy_init) = 1; +| +| #ifdef YY_USER_INIT +| YY_USER_INIT; +| #endif +| +| /* Create the reject buffer large enough to save one state per allowed character. */ +| if ( ! (yy_state_buf) ) +| (yy_state_buf) = (yy_state_type *)yyalloc(YY_STATE_BUF_SIZE ); +| if ( ! (yy_state_buf) ) +| YY_FATAL_ERROR( "out of dynamic memory in yylex()" ); +| +| if ( ! (yy_start) ) +| (yy_start) = 1; /* first start state */ +| +| if ( ! yyin ) +| yyin = stdin; +| +| if ( ! yyout ) +| yyout = stdout; +| +| if ( ! YY_CURRENT_BUFFER ) { +| yyensure_buffer_stack (); +| YY_CURRENT_BUFFER_LVALUE = +| yy_create_buffer(yyin,YY_BUF_SIZE ); +| } +| +| yy_load_buffer_state( ); +| } +| +| while ( 1 ) /* loops until end-of-file is reached */ +| { +| (yy_more_len) = 0; +| if ( (yy_more_flag) ) +| { +| (yy_more_len) = (yy_c_buf_p) - (yytext_ptr); +| (yy_more_flag) = 0; +| } +| yy_cp = (yy_c_buf_p); +| +| /* Support of yytext. */ +| *yy_cp = (yy_hold_char); +| +| /* yy_bp points to the position in yy_ch_buf of the start of +| * the current run. +| */ +| yy_bp = yy_cp; +| +| yy_current_state = (yy_start); +| +| (yy_state_ptr) = (yy_state_buf); +| *(yy_state_ptr)++ = yy_current_state; +| +| yy_match: +| do +| { +| register YY_CHAR yy_c = yy_ec[YY_SC_TO_UI(*yy_cp)]; +| while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) +| { +| yy_current_state = (int) yy_def[yy_current_state]; +| if ( yy_current_state >= 13 ) +| yy_c = yy_meta[(unsigned int) yy_c]; +| } +| yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; +| *(yy_state_ptr)++ = yy_current_state; +| ++yy_cp; +| } +| while ( yy_base[yy_current_state] != 10 ); +| +| yy_find_action: +| yy_current_state = *--(yy_state_ptr); +| (yy_lp) = yy_accept[yy_current_state]; +| find_rule: /* we branch to this label when backing up */ +| for ( ; ; ) /* until we find what rule we matched */ +| { +| if ( (yy_lp) && (yy_lp) < yy_accept[yy_current_state + 1] ) +| { +| yy_act = yy_acclist[(yy_lp)]; +| { +| (yy_full_match) = yy_cp; +| break; +| } +| } +| --yy_cp; +| yy_current_state = *--(yy_state_ptr); +| (yy_lp) = yy_accept[yy_current_state]; +| } +| +| YY_DO_BEFORE_ACTION; +| +| do_action: /* This label is used only to access EOF actions. */ +| +| switch ( yy_act ) +| { /* beginning of action switch */ +| case 1: +| YY_RULE_SETUP +| #line 2 "conftest.l" +| { ECHO; } +| YY_BREAK +| case 2: +| YY_RULE_SETUP +| #line 3 "conftest.l" +| { REJECT; } +| YY_BREAK +| case 3: +| YY_RULE_SETUP +| #line 4 "conftest.l" +| { yymore (); } +| YY_BREAK +| case 4: +| YY_RULE_SETUP +| #line 5 "conftest.l" +| { yyless (1); } +| YY_BREAK +| case 5: +| YY_RULE_SETUP +| #line 6 "conftest.l" +| { yyless (input () != 0); } +| YY_BREAK +| case 6: +| YY_RULE_SETUP +| #line 7 "conftest.l" +| { unput (yytext[0]); } +| YY_BREAK +| case 7: +| YY_RULE_SETUP +| #line 8 "conftest.l" +| { BEGIN INITIAL; } +| YY_BREAK +| case 8: +| YY_RULE_SETUP +| #line 9 "conftest.l" +| ECHO; +| YY_BREAK +| #line 791 "lex.yy.c" +| case YY_STATE_EOF(INITIAL): +| yyterminate(); +| +| case YY_END_OF_BUFFER: +| { +| /* Amount of text matched not including the EOB char. */ +| int yy_amount_of_matched_text = (int) (yy_cp - (yytext_ptr)) - 1; +| +| /* Undo the effects of YY_DO_BEFORE_ACTION. */ +| *yy_cp = (yy_hold_char); +| YY_RESTORE_YY_MORE_OFFSET +| +| if ( YY_CURRENT_BUFFER_LVALUE->yy_buffer_status == YY_BUFFER_NEW ) +| { +| /* We're scanning a new file or input source. It's +| * possible that this happened because the user +| * just pointed yyin at a new source and called +| * yylex(). If so, then we have to assure +| * consistency between YY_CURRENT_BUFFER and our +| * globals. Here is the right place to do so, because +| * this is the first action (other than possibly a +| * back-up) that will match for the new input source. +| */ +| (yy_n_chars) = YY_CURRENT_BUFFER_LVALUE->yy_n_chars; +| YY_CURRENT_BUFFER_LVALUE->yy_input_file = yyin; +| YY_CURRENT_BUFFER_LVALUE->yy_buffer_status = YY_BUFFER_NORMAL; +| } +| +| /* Note that here we test for yy_c_buf_p "<=" to the position +| * of the first EOB in the buffer, since yy_c_buf_p will +| * already have been incremented past the NUL character +| * (since all states make transitions on EOB to the +| * end-of-buffer state). Contrast this with the test +| * in input(). +| */ +| if ( (yy_c_buf_p) <= &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)] ) +| { /* This was really a NUL. */ +| yy_state_type yy_next_state; +| +| (yy_c_buf_p) = (yytext_ptr) + yy_amount_of_matched_text; +| +| yy_current_state = yy_get_previous_state( ); +| +| /* Okay, we're now positioned to make the NUL +| * transition. We couldn't have +| * yy_get_previous_state() go ahead and do it +| * for us because it doesn't know how to deal +| * with the possibility of jamming (and we don't +| * want to build jamming into it because then it +| * will run more slowly). +| */ +| +| yy_next_state = yy_try_NUL_trans( yy_current_state ); +| +| yy_bp = (yytext_ptr) + YY_MORE_ADJ; +| +| if ( yy_next_state ) +| { +| /* Consume the NUL. */ +| yy_cp = ++(yy_c_buf_p); +| yy_current_state = yy_next_state; +| goto yy_match; +| } +| +| else +| { +| yy_cp = (yy_c_buf_p); +| goto yy_find_action; +| } +| } +| +| else switch ( yy_get_next_buffer( ) ) +| { +| case EOB_ACT_END_OF_FILE: +| { +| (yy_did_buffer_switch_on_eof) = 0; +| +| if ( yywrap( ) ) +| { +| /* Note: because we've taken care in +| * yy_get_next_buffer() to have set up +| * yytext, we can now set up +| * yy_c_buf_p so that if some total +| * hoser (like flex itself) wants to +| * call the scanner after we return the +| * YY_NULL, it'll still work - another +| * YY_NULL will get returned. +| */ +| (yy_c_buf_p) = (yytext_ptr) + YY_MORE_ADJ; +| +| yy_act = YY_STATE_EOF(YY_START); +| goto do_action; +| } +| +| else +| { +| if ( ! (yy_did_buffer_switch_on_eof) ) +| YY_NEW_FILE; +| } +| break; +| } +| +| case EOB_ACT_CONTINUE_SCAN: +| (yy_c_buf_p) = +| (yytext_ptr) + yy_amount_of_matched_text; +| +| yy_current_state = yy_get_previous_state( ); +| +| yy_cp = (yy_c_buf_p); +| yy_bp = (yytext_ptr) + YY_MORE_ADJ; +| goto yy_match; +| +| case EOB_ACT_LAST_MATCH: +| (yy_c_buf_p) = +| &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)]; +| +| yy_current_state = yy_get_previous_state( ); +| +| yy_cp = (yy_c_buf_p); +| yy_bp = (yytext_ptr) + YY_MORE_ADJ; +| goto yy_find_action; +| } +| break; +| } +| +| default: +| YY_FATAL_ERROR( +| "fatal flex scanner internal error--no action found" ); +| } /* end of action switch */ +| } /* end of scanning one token */ +| } /* end of yylex */ +| +| /* yy_get_next_buffer - try to read in a new buffer +| * +| * Returns a code representing an action: +| * EOB_ACT_LAST_MATCH - +| * EOB_ACT_CONTINUE_SCAN - continue scanning from current position +| * EOB_ACT_END_OF_FILE - end of file +| */ +| static int yy_get_next_buffer (void) +| { +| register char *dest = YY_CURRENT_BUFFER_LVALUE->yy_ch_buf; +| register char *source = (yytext_ptr); +| register int number_to_move, i; +| int ret_val; +| +| if ( (yy_c_buf_p) > &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars) + 1] ) +| YY_FATAL_ERROR( +| "fatal flex scanner internal error--end of buffer missed" ); +| +| if ( YY_CURRENT_BUFFER_LVALUE->yy_fill_buffer == 0 ) +| { /* Don't try to fill the buffer, so this is an EOF. */ +| if ( (yy_c_buf_p) - (yytext_ptr) - YY_MORE_ADJ == 1 ) +| { +| /* We matched a single character, the EOB, so +| * treat this as a final EOF. +| */ +| return EOB_ACT_END_OF_FILE; +| } +| +| else +| { +| /* We matched some text prior to the EOB, first +| * process it. +| */ +| return EOB_ACT_LAST_MATCH; +| } +| } +| +| /* Try to read more data. */ +| +| /* First move last chars to start of buffer. */ +| number_to_move = (int) ((yy_c_buf_p) - (yytext_ptr)) - 1; +| +| for ( i = 0; i < number_to_move; ++i ) +| *(dest++) = *(source++); +| +| if ( YY_CURRENT_BUFFER_LVALUE->yy_buffer_status == YY_BUFFER_EOF_PENDING ) +| /* don't do the read, it's not guaranteed to return an EOF, +| * just force an EOF +| */ +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars) = 0; +| +| else +| { +| yy_size_t num_to_read = +| YY_CURRENT_BUFFER_LVALUE->yy_buf_size - number_to_move - 1; +| +| while ( num_to_read <= 0 ) +| { /* Not enough room in the buffer - grow it. */ +| +| YY_FATAL_ERROR( +| "input buffer overflow, can't enlarge buffer because scanner uses REJECT" ); +| +| } +| +| if ( num_to_read > YY_READ_BUF_SIZE ) +| num_to_read = YY_READ_BUF_SIZE; +| +| /* Read in more data. */ +| YY_INPUT( (&YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[number_to_move]), +| (yy_n_chars), num_to_read ); +| +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars); +| } +| +| if ( (yy_n_chars) == 0 ) +| { +| if ( number_to_move == YY_MORE_ADJ ) +| { +| ret_val = EOB_ACT_END_OF_FILE; +| yyrestart(yyin ); +| } +| +| else +| { +| ret_val = EOB_ACT_LAST_MATCH; +| YY_CURRENT_BUFFER_LVALUE->yy_buffer_status = +| YY_BUFFER_EOF_PENDING; +| } +| } +| +| else +| ret_val = EOB_ACT_CONTINUE_SCAN; +| +| if ((yy_size_t) ((yy_n_chars) + number_to_move) > YY_CURRENT_BUFFER_LVALUE->yy_buf_size) { +| /* Extend the array by 50%, plus the number we really need. */ +| yy_size_t new_size = (yy_n_chars) + number_to_move + ((yy_n_chars) >> 1); +| YY_CURRENT_BUFFER_LVALUE->yy_ch_buf = (char *) yyrealloc((void *) YY_CURRENT_BUFFER_LVALUE->yy_ch_buf,new_size ); +| if ( ! YY_CURRENT_BUFFER_LVALUE->yy_ch_buf ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_get_next_buffer()" ); +| } +| +| (yy_n_chars) += number_to_move; +| YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)] = YY_END_OF_BUFFER_CHAR; +| YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars) + 1] = YY_END_OF_BUFFER_CHAR; +| +| (yytext_ptr) = &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[0]; +| +| return ret_val; +| } +| +| /* yy_get_previous_state - get the state just before the EOB char was reached */ +| +| static yy_state_type yy_get_previous_state (void) +| { +| register yy_state_type yy_current_state; +| register char *yy_cp; +| +| yy_current_state = (yy_start); +| +| (yy_state_ptr) = (yy_state_buf); +| *(yy_state_ptr)++ = yy_current_state; +| +| for ( yy_cp = (yytext_ptr) + YY_MORE_ADJ; yy_cp < (yy_c_buf_p); ++yy_cp ) +| { +| register YY_CHAR yy_c = (*yy_cp ? yy_ec[YY_SC_TO_UI(*yy_cp)] : 1); +| while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) +| { +| yy_current_state = (int) yy_def[yy_current_state]; +| if ( yy_current_state >= 13 ) +| yy_c = yy_meta[(unsigned int) yy_c]; +| } +| yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; +| *(yy_state_ptr)++ = yy_current_state; +| } +| +| return yy_current_state; +| } +| +| /* yy_try_NUL_trans - try to make a transition on the NUL character +| * +| * synopsis +| * next_state = yy_try_NUL_trans( current_state ); +| */ +| static yy_state_type yy_try_NUL_trans (yy_state_type yy_current_state ) +| { +| register int yy_is_jam; +| +| register YY_CHAR yy_c = 1; +| while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) +| { +| yy_current_state = (int) yy_def[yy_current_state]; +| if ( yy_current_state >= 13 ) +| yy_c = yy_meta[(unsigned int) yy_c]; +| } +| yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; +| yy_is_jam = (yy_current_state == 12); +| if ( ! yy_is_jam ) +| *(yy_state_ptr)++ = yy_current_state; +| +| return yy_is_jam ? 0 : yy_current_state; +| } +| +| static void yyunput (int c, register char * yy_bp ) +| { +| register char *yy_cp; +| +| yy_cp = (yy_c_buf_p); +| +| /* undo effects of setting up yytext */ +| *yy_cp = (yy_hold_char); +| +| if ( yy_cp < YY_CURRENT_BUFFER_LVALUE->yy_ch_buf + 2 ) +| { /* need to shift things up to make room */ +| /* +2 for EOB chars. */ +| register yy_size_t number_to_move = (yy_n_chars) + 2; +| register char *dest = &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[ +| YY_CURRENT_BUFFER_LVALUE->yy_buf_size + 2]; +| register char *source = +| &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[number_to_move]; +| +| while ( source > YY_CURRENT_BUFFER_LVALUE->yy_ch_buf ) +| *--dest = *--source; +| +| yy_cp += (int) (dest - source); +| yy_bp += (int) (dest - source); +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = +| (yy_n_chars) = YY_CURRENT_BUFFER_LVALUE->yy_buf_size; +| +| if ( yy_cp < YY_CURRENT_BUFFER_LVALUE->yy_ch_buf + 2 ) +| YY_FATAL_ERROR( "flex scanner push-back overflow" ); +| } +| +| *--yy_cp = (char) c; +| +| (yytext_ptr) = yy_bp; +| (yy_hold_char) = *yy_cp; +| (yy_c_buf_p) = yy_cp; +| } +| +| #ifndef YY_NO_INPUT +| #ifdef __cplusplus +| static int yyinput (void) +| #else +| static int input (void) +| #endif +| +| { +| int c; +| +| *(yy_c_buf_p) = (yy_hold_char); +| +| if ( *(yy_c_buf_p) == YY_END_OF_BUFFER_CHAR ) +| { +| /* yy_c_buf_p now points to the character we want to return. +| * If this occurs *before* the EOB characters, then it's a +| * valid NUL; if not, then we've hit the end of the buffer. +| */ +| if ( (yy_c_buf_p) < &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)] ) +| /* This was really a NUL. */ +| *(yy_c_buf_p) = '\0'; +| +| else +| { /* need more input */ +| yy_size_t offset = (yy_c_buf_p) - (yytext_ptr); +| ++(yy_c_buf_p); +| +| switch ( yy_get_next_buffer( ) ) +| { +| case EOB_ACT_LAST_MATCH: +| /* This happens because yy_g_n_b() +| * sees that we've accumulated a +| * token and flags that we need to +| * try matching the token before +| * proceeding. But for input(), +| * there's no matching to consider. +| * So convert the EOB_ACT_LAST_MATCH +| * to EOB_ACT_END_OF_FILE. +| */ +| +| /* Reset buffer status. */ +| yyrestart(yyin ); +| +| /*FALLTHROUGH*/ +| +| case EOB_ACT_END_OF_FILE: +| { +| if ( yywrap( ) ) +| return EOF; +| +| if ( ! (yy_did_buffer_switch_on_eof) ) +| YY_NEW_FILE; +| #ifdef __cplusplus +| return yyinput(); +| #else +| return input(); +| #endif +| } +| +| case EOB_ACT_CONTINUE_SCAN: +| (yy_c_buf_p) = (yytext_ptr) + offset; +| break; +| } +| } +| } +| +| c = *(unsigned char *) (yy_c_buf_p); /* cast for 8-bit char's */ +| *(yy_c_buf_p) = '\0'; /* preserve yytext */ +| (yy_hold_char) = *++(yy_c_buf_p); +| +| return c; +| } +| #endif /* ifndef YY_NO_INPUT */ +| +| /** Immediately switch to a different input stream. +| * @param input_file A readable stream. +| * +| * @note This function does not reset the start condition to @c INITIAL . +| */ +| void yyrestart (FILE * input_file ) +| { +| +| if ( ! YY_CURRENT_BUFFER ){ +| yyensure_buffer_stack (); +| YY_CURRENT_BUFFER_LVALUE = +| yy_create_buffer(yyin,YY_BUF_SIZE ); +| } +| +| yy_init_buffer(YY_CURRENT_BUFFER,input_file ); +| yy_load_buffer_state( ); +| } +| +| /** Switch to a different input buffer. +| * @param new_buffer The new input buffer. +| * +| */ +| void yy_switch_to_buffer (YY_BUFFER_STATE new_buffer ) +| { +| +| /* TODO. We should be able to replace this entire function body +| * with +| * yypop_buffer_state(); +| * yypush_buffer_state(new_buffer); +| */ +| yyensure_buffer_stack (); +| if ( YY_CURRENT_BUFFER == new_buffer ) +| return; +| +| if ( YY_CURRENT_BUFFER ) +| { +| /* Flush out information for old buffer. */ +| *(yy_c_buf_p) = (yy_hold_char); +| YY_CURRENT_BUFFER_LVALUE->yy_buf_pos = (yy_c_buf_p); +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars); +| } +| +| YY_CURRENT_BUFFER_LVALUE = new_buffer; +| yy_load_buffer_state( ); +| +| /* We don't actually know whether we did this switch during +| * EOF (yywrap()) processing, but the only time this flag +| * is looked at is after yywrap() is called, so it's safe +| * to go ahead and always set it. +| */ +| (yy_did_buffer_switch_on_eof) = 1; +| } +| +| static void yy_load_buffer_state (void) +| { +| (yy_n_chars) = YY_CURRENT_BUFFER_LVALUE->yy_n_chars; +| (yytext_ptr) = (yy_c_buf_p) = YY_CURRENT_BUFFER_LVALUE->yy_buf_pos; +| yyin = YY_CURRENT_BUFFER_LVALUE->yy_input_file; +| (yy_hold_char) = *(yy_c_buf_p); +| } +| +| /** Allocate and initialize an input buffer state. +| * @param file A readable stream. +| * @param size The character buffer size in bytes. When in doubt, use @c YY_BUF_SIZE. +| * +| * @return the allocated buffer state. +| */ +| YY_BUFFER_STATE yy_create_buffer (FILE * file, int size ) +| { +| YY_BUFFER_STATE b; +| +| b = (YY_BUFFER_STATE) yyalloc(sizeof( struct yy_buffer_state ) ); +| if ( ! b ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_create_buffer()" ); +| +| b->yy_buf_size = size; +| +| /* yy_ch_buf has to be 2 characters longer than the size given because +| * we need to put in 2 end-of-buffer characters. +| */ +| b->yy_ch_buf = (char *) yyalloc(b->yy_buf_size + 2 ); +| if ( ! b->yy_ch_buf ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_create_buffer()" ); +| +| b->yy_is_our_buffer = 1; +| +| yy_init_buffer(b,file ); +| +| return b; +| } +| +| /** Destroy the buffer. +| * @param b a buffer created with yy_create_buffer() +| * +| */ +| void yy_delete_buffer (YY_BUFFER_STATE b ) +| { +| +| if ( ! b ) +| return; +| +| if ( b == YY_CURRENT_BUFFER ) /* Not sure if we should pop here. */ +| YY_CURRENT_BUFFER_LVALUE = (YY_BUFFER_STATE) 0; +| +| if ( b->yy_is_our_buffer ) +| yyfree((void *) b->yy_ch_buf ); +| +| yyfree((void *) b ); +| } +| +| /* Initializes or reinitializes a buffer. +| * This function is sometimes called more than once on the same buffer, +| * such as during a yyrestart() or at EOF. +| */ +| static void yy_init_buffer (YY_BUFFER_STATE b, FILE * file ) +| +| { +| int oerrno = errno; +| +| yy_flush_buffer(b ); +| +| b->yy_input_file = file; +| b->yy_fill_buffer = 1; +| +| /* If b is the current buffer, then yy_init_buffer was _probably_ +| * called from yyrestart() or through yy_get_next_buffer. +| * In that case, we don't want to reset the lineno or column. +| */ +| if (b != YY_CURRENT_BUFFER){ +| b->yy_bs_lineno = 1; +| b->yy_bs_column = 0; +| } +| +| b->yy_is_interactive = file ? (isatty( fileno(file) ) > 0) : 0; +| +| errno = oerrno; +| } +| +| /** Discard all buffered characters. On the next scan, YY_INPUT will be called. +| * @param b the buffer state to be flushed, usually @c YY_CURRENT_BUFFER. +| * +| */ +| void yy_flush_buffer (YY_BUFFER_STATE b ) +| { +| if ( ! b ) +| return; +| +| b->yy_n_chars = 0; +| +| /* We always need two end-of-buffer characters. The first causes +| * a transition to the end-of-buffer state. The second causes +| * a jam in that state. +| */ +| b->yy_ch_buf[0] = YY_END_OF_BUFFER_CHAR; +| b->yy_ch_buf[1] = YY_END_OF_BUFFER_CHAR; +| +| b->yy_buf_pos = &b->yy_ch_buf[0]; +| +| b->yy_at_bol = 1; +| b->yy_buffer_status = YY_BUFFER_NEW; +| +| if ( b == YY_CURRENT_BUFFER ) +| yy_load_buffer_state( ); +| } +| +| /** Pushes the new state onto the stack. The new state becomes +| * the current state. This function will allocate the stack +| * if necessary. +| * @param new_buffer The new state. +| * +| */ +| void yypush_buffer_state (YY_BUFFER_STATE new_buffer ) +| { +| if (new_buffer == NULL) +| return; +| +| yyensure_buffer_stack(); +| +| /* This block is copied from yy_switch_to_buffer. */ +| if ( YY_CURRENT_BUFFER ) +| { +| /* Flush out information for old buffer. */ +| *(yy_c_buf_p) = (yy_hold_char); +| YY_CURRENT_BUFFER_LVALUE->yy_buf_pos = (yy_c_buf_p); +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars); +| } +| +| /* Only push if top exists. Otherwise, replace top. */ +| if (YY_CURRENT_BUFFER) +| (yy_buffer_stack_top)++; +| YY_CURRENT_BUFFER_LVALUE = new_buffer; +| +| /* copied from yy_switch_to_buffer. */ +| yy_load_buffer_state( ); +| (yy_did_buffer_switch_on_eof) = 1; +| } +| +| /** Removes and deletes the top of the stack, if present. +| * The next element becomes the new top. +| * +| */ +| void yypop_buffer_state (void) +| { +| if (!YY_CURRENT_BUFFER) +| return; +| +| yy_delete_buffer(YY_CURRENT_BUFFER ); +| YY_CURRENT_BUFFER_LVALUE = NULL; +| if ((yy_buffer_stack_top) > 0) +| --(yy_buffer_stack_top); +| +| if (YY_CURRENT_BUFFER) { +| yy_load_buffer_state( ); +| (yy_did_buffer_switch_on_eof) = 1; +| } +| } +| +| /* Allocates the stack if it does not exist. +| * Guarantees space for at least one push. +| */ +| static void yyensure_buffer_stack (void) +| { +| yy_size_t num_to_alloc; +| +| if (!(yy_buffer_stack)) { +| +| /* First allocation is just for 2 elements, since we don't know if this +| * scanner will even need a stack. We use 2 instead of 1 to avoid an +| * immediate realloc on the next call. +| */ +| num_to_alloc = 1; +| (yy_buffer_stack) = (struct yy_buffer_state**)yyalloc +| (num_to_alloc * sizeof(struct yy_buffer_state*) +| ); +| if ( ! (yy_buffer_stack) ) +| YY_FATAL_ERROR( "out of dynamic memory in yyensure_buffer_stack()" ); +| +| memset((yy_buffer_stack), 0, num_to_alloc * sizeof(struct yy_buffer_state*)); +| +| (yy_buffer_stack_max) = num_to_alloc; +| (yy_buffer_stack_top) = 0; +| return; +| } +| +| if ((yy_buffer_stack_top) >= ((yy_buffer_stack_max)) - 1){ +| +| /* Increase the buffer to prepare for a possible push. */ +| int grow_size = 8 /* arbitrary grow size */; +| +| num_to_alloc = (yy_buffer_stack_max) + grow_size; +| (yy_buffer_stack) = (struct yy_buffer_state**)yyrealloc +| ((yy_buffer_stack), +| num_to_alloc * sizeof(struct yy_buffer_state*) +| ); +| if ( ! (yy_buffer_stack) ) +| YY_FATAL_ERROR( "out of dynamic memory in yyensure_buffer_stack()" ); +| +| /* zero only the new slots.*/ +| memset((yy_buffer_stack) + (yy_buffer_stack_max), 0, grow_size * sizeof(struct yy_buffer_state*)); +| (yy_buffer_stack_max) = num_to_alloc; +| } +| } +| +| /** Setup the input buffer state to scan directly from a user-specified character buffer. +| * @param base the character buffer +| * @param size the size in bytes of the character buffer +| * +| * @return the newly allocated buffer state object. +| */ +| YY_BUFFER_STATE yy_scan_buffer (char * base, yy_size_t size ) +| { +| YY_BUFFER_STATE b; +| +| if ( size < 2 || +| base[size-2] != YY_END_OF_BUFFER_CHAR || +| base[size-1] != YY_END_OF_BUFFER_CHAR ) +| /* They forgot to leave room for the EOB's. */ +| return 0; +| +| b = (YY_BUFFER_STATE) yyalloc(sizeof( struct yy_buffer_state ) ); +| if ( ! b ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_scan_buffer()" ); +| +| b->yy_buf_size = size - 2; /* "- 2" to take care of EOB's */ +| b->yy_buf_pos = b->yy_ch_buf = base; +| b->yy_is_our_buffer = 0; +| b->yy_input_file = 0; +| b->yy_n_chars = b->yy_buf_size; +| b->yy_is_interactive = 0; +| b->yy_at_bol = 1; +| b->yy_fill_buffer = 0; +| b->yy_buffer_status = YY_BUFFER_NEW; +| +| yy_switch_to_buffer(b ); +| +| return b; +| } +| +| /** Setup the input buffer state to scan a string. The next call to yylex() will +| * scan from a @e copy of @a str. +| * @param yystr a NUL-terminated string to scan +| * +| * @return the newly allocated buffer state object. +| * @note If you want to scan bytes that may contain NUL values, then use +| * yy_scan_bytes() instead. +| */ +| YY_BUFFER_STATE yy_scan_string (yyconst char * yystr ) +| { +| +| return yy_scan_bytes(yystr,strlen(yystr) ); +| } +| +| /** Setup the input buffer state to scan the given bytes. The next call to yylex() will +| * scan from a @e copy of @a bytes. +| * @param yybytes the byte buffer to scan +| * @param _yybytes_len the number of bytes in the buffer pointed to by @a bytes. +| * +| * @return the newly allocated buffer state object. +| */ +| YY_BUFFER_STATE yy_scan_bytes (yyconst char * yybytes, yy_size_t _yybytes_len ) +| { +| YY_BUFFER_STATE b; +| char *buf; +| yy_size_t n; +| yy_size_t i; +| +| /* Get memory for full buffer, including space for trailing EOB's. */ +| n = _yybytes_len + 2; +| buf = (char *) yyalloc(n ); +| if ( ! buf ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_scan_bytes()" ); +| +| for ( i = 0; i < _yybytes_len; ++i ) +| buf[i] = yybytes[i]; +| +| buf[_yybytes_len] = buf[_yybytes_len+1] = YY_END_OF_BUFFER_CHAR; +| +| b = yy_scan_buffer(buf,n ); +| if ( ! b ) +| YY_FATAL_ERROR( "bad buffer in yy_scan_bytes()" ); +| +| /* It's okay to grow etc. this buffer, and we should throw it +| * away when we're done. +| */ +| b->yy_is_our_buffer = 1; +| +| return b; +| } +| +| #ifndef YY_EXIT_FAILURE +| #define YY_EXIT_FAILURE 2 +| #endif +| +| static void yy_fatal_error (yyconst char* msg ) +| { +| (void) fprintf( stderr, "%s\n", msg ); +| exit( YY_EXIT_FAILURE ); +| } +| +| /* Redefine yyless() so it works in section 3 code. */ +| +| #undef yyless +| #define yyless(n) \ +| do \ +| { \ +| /* Undo effects of setting up yytext. */ \ +| int yyless_macro_arg = (n); \ +| YY_LESS_LINENO(yyless_macro_arg);\ +| yytext[yyleng] = (yy_hold_char); \ +| (yy_c_buf_p) = yytext + yyless_macro_arg; \ +| (yy_hold_char) = *(yy_c_buf_p); \ +| *(yy_c_buf_p) = '\0'; \ +| yyleng = yyless_macro_arg; \ +| } \ +| while ( 0 ) +| +| /* Accessor methods (get/set functions) to struct members. */ +| +| /** Get the current line number. +| * +| */ +| int yyget_lineno (void) +| { +| +| return yylineno; +| } +| +| /** Get the input stream. +| * +| */ +| FILE *yyget_in (void) +| { +| return yyin; +| } +| +| /** Get the output stream. +| * +| */ +| FILE *yyget_out (void) +| { +| return yyout; +| } +| +| /** Get the length of the current token. +| * +| */ +| yy_size_t yyget_leng (void) +| { +| return yyleng; +| } +| +| /** Get the current token. +| * +| */ +| +| char *yyget_text (void) +| { +| return yytext; +| } +| +| /** Set the current line number. +| * @param line_number +| * +| */ +| void yyset_lineno (int line_number ) +| { +| +| yylineno = line_number; +| } +| +| /** Set the input stream. This does not discard the current +| * input buffer. +| * @param in_str A readable stream. +| * +| * @see yy_switch_to_buffer +| */ +| void yyset_in (FILE * in_str ) +| { +| yyin = in_str ; +| } +| +| void yyset_out (FILE * out_str ) +| { +| yyout = out_str ; +| } +| +| int yyget_debug (void) +| { +| return yy_flex_debug; +| } +| +| void yyset_debug (int bdebug ) +| { +| yy_flex_debug = bdebug ; +| } +| +| static int yy_init_globals (void) +| { +| /* Initialization is the same as for the non-reentrant scanner. +| * This function is called from yylex_destroy(), so don't allocate here. +| */ +| +| (yy_buffer_stack) = 0; +| (yy_buffer_stack_top) = 0; +| (yy_buffer_stack_max) = 0; +| (yy_c_buf_p) = (char *) 0; +| (yy_init) = 0; +| (yy_start) = 0; +| +| (yy_state_buf) = 0; +| (yy_state_ptr) = 0; +| (yy_full_match) = 0; +| (yy_lp) = 0; +| +| /* Defined in main.c */ +| #ifdef YY_STDINIT +| yyin = stdin; +| yyout = stdout; +| #else +| yyin = (FILE *) 0; +| yyout = (FILE *) 0; +| #endif +| +| /* For future reference: Set errno on error, since we are called by +| * yylex_init() +| */ +| return 0; +| } +| +| /* yylex_destroy is for both reentrant and non-reentrant scanners. */ +| int yylex_destroy (void) +| { +| +| /* Pop the buffer stack, destroying each element. */ +| while(YY_CURRENT_BUFFER){ +| yy_delete_buffer(YY_CURRENT_BUFFER ); +| YY_CURRENT_BUFFER_LVALUE = NULL; +| yypop_buffer_state(); +| } +| +| /* Destroy the stack itself. */ +| yyfree((yy_buffer_stack) ); +| (yy_buffer_stack) = NULL; +| +| yyfree ( (yy_state_buf) ); +| (yy_state_buf) = NULL; +| +| /* Reset the globals. This is important in a non-reentrant scanner so the next time +| * yylex() is called, initialization will occur. */ +| yy_init_globals( ); +| +| return 0; +| } +| +| /* +| * Internal utility routines. +| */ +| +| #ifndef yytext_ptr +| static void yy_flex_strncpy (char* s1, yyconst char * s2, int n ) +| { +| register int i; +| for ( i = 0; i < n; ++i ) +| s1[i] = s2[i]; +| } +| #endif +| +| #ifdef YY_NEED_STRLEN +| static int yy_flex_strlen (yyconst char * s ) +| { +| register int n; +| for ( n = 0; s[n]; ++n ) +| ; +| +| return n; +| } +| #endif +| +| void *yyalloc (yy_size_t size ) +| { +| return (void *) malloc( size ); +| } +| +| void *yyrealloc (void * ptr, yy_size_t size ) +| { +| /* The cast to (char *) in the following accommodates both +| * implementations that use char* generic pointers, and those +| * that use void* generic pointers. It works with the latter +| * because both ANSI C and C++ allow castless assignment from +| * any pointer type to void*, and deal with argument conversions +| * as though doing an assignment. +| */ +| return (void *) realloc( (char *) ptr, size ); +| } +| +| void yyfree (void * ptr ) +| { +| free( (char *) ptr ); /* see yyrealloc() for (char *) cast */ +| } +| +| #define YYTABLES_NAME "yytables" +| +| #line 9 "conftest.l" +| +| +| #ifdef YYTEXT_POINTER +| extern char *yytext; +| #endif +| int +| main (void) +| { +| return ! yylex () + ! yywrap (); +| } +configure:16315: result: none needed +configure:16321: checking whether yytext is a pointer +configure:16338: gcc -o conftest -g -O2 conftest.c >&5 +/var/tmp/ccxckJly.o: In function `input': +/ufs/greta/zomer/pharcos/libconfig-1.4.9/lex.yy.c:1169: undefined reference to `yywrap' +/var/tmp/ccxckJly.o: In function `yylex': +/ufs/greta/zomer/pharcos/libconfig-1.4.9/lex.yy.c:868: undefined reference to `yywrap' +/var/tmp/ccxckJly.o: In function `main': +/ufs/greta/zomer/pharcos/libconfig-1.4.9/conftest.l:17: undefined reference to `yywrap' +collect2: error: ld returned 1 exit status +configure:16338: $? = 1 +configure: failed program was: +| /* confdefs.h */ +| #define PACKAGE_NAME "libconfig" +| #define PACKAGE_TARNAME "libconfig" +| #define PACKAGE_VERSION "1.4.9" +| #define PACKAGE_STRING "libconfig 1.4.9" +| #define PACKAGE_BUGREPORT "hyperrealm@gmail.com" +| #define PACKAGE_URL "http://www.hyperrealm.com/main.php?s=libconfig" +| #define PACKAGE "libconfig" +| #define VERSION "1.4.9" +| #define TARGET "x86_64-unknown-linux-gnu" +| #define STDC_HEADERS 1 +| #define HAVE_SYS_TYPES_H 1 +| #define HAVE_SYS_STAT_H 1 +| #define HAVE_STDLIB_H 1 +| #define HAVE_STRING_H 1 +| #define HAVE_MEMORY_H 1 +| #define HAVE_STRINGS_H 1 +| #define HAVE_INTTYPES_H 1 +| #define HAVE_STDINT_H 1 +| #define HAVE_UNISTD_H 1 +| #define __EXTENSIONS__ 1 +| #define _ALL_SOURCE 1 +| #define _GNU_SOURCE 1 +| #define _POSIX_PTHREAD_SEMANTICS 1 +| #define _TANDEM_SOURCE 1 +| #define HAVE_DLFCN_H 1 +| #define LT_OBJDIR ".libs/" +| /* end confdefs.h. */ +| +| #define YYTEXT_POINTER 1 +| +| #line 3 "lex.yy.c" +| +| #define YY_INT_ALIGNED short int +| +| /* A lexical scanner generated by flex */ +| +| #define FLEX_SCANNER +| #define YY_FLEX_MAJOR_VERSION 2 +| #define YY_FLEX_MINOR_VERSION 5 +| #define YY_FLEX_SUBMINOR_VERSION 37 +| #if YY_FLEX_SUBMINOR_VERSION > 0 +| #define FLEX_BETA +| #endif +| +| /* First, we deal with platform-specific or compiler-specific issues. */ +| +| /* begin standard C headers. */ +| #include +| #include +| #include +| #include +| +| /* end standard C headers. */ +| +| /* flex integer type definitions */ +| +| #ifndef FLEXINT_H +| #define FLEXINT_H +| +| /* C99 systems have . Non-C99 systems may or may not. */ +| +| #if defined (__STDC_VERSION__) && __STDC_VERSION__ >= 199901L +| +| /* C99 says to define __STDC_LIMIT_MACROS before including stdint.h, +| * if you want the limit (max/min) macros for int types. +| */ +| #ifndef __STDC_LIMIT_MACROS +| #define __STDC_LIMIT_MACROS 1 +| #endif +| +| #include +| typedef int8_t flex_int8_t; +| typedef uint8_t flex_uint8_t; +| typedef int16_t flex_int16_t; +| typedef uint16_t flex_uint16_t; +| typedef int32_t flex_int32_t; +| typedef uint32_t flex_uint32_t; +| #else +| typedef signed char flex_int8_t; +| typedef short int flex_int16_t; +| typedef int flex_int32_t; +| typedef unsigned char flex_uint8_t; +| typedef unsigned short int flex_uint16_t; +| typedef unsigned int flex_uint32_t; +| +| /* Limits of integral types. */ +| #ifndef INT8_MIN +| #define INT8_MIN (-128) +| #endif +| #ifndef INT16_MIN +| #define INT16_MIN (-32767-1) +| #endif +| #ifndef INT32_MIN +| #define INT32_MIN (-2147483647-1) +| #endif +| #ifndef INT8_MAX +| #define INT8_MAX (127) +| #endif +| #ifndef INT16_MAX +| #define INT16_MAX (32767) +| #endif +| #ifndef INT32_MAX +| #define INT32_MAX (2147483647) +| #endif +| #ifndef UINT8_MAX +| #define UINT8_MAX (255U) +| #endif +| #ifndef UINT16_MAX +| #define UINT16_MAX (65535U) +| #endif +| #ifndef UINT32_MAX +| #define UINT32_MAX (4294967295U) +| #endif +| +| #endif /* ! C99 */ +| +| #endif /* ! FLEXINT_H */ +| +| #ifdef __cplusplus +| +| /* The "const" storage-class-modifier is valid. */ +| #define YY_USE_CONST +| +| #else /* ! __cplusplus */ +| +| /* C99 requires __STDC__ to be defined as 1. */ +| #if defined (__STDC__) +| +| #define YY_USE_CONST +| +| #endif /* defined (__STDC__) */ +| #endif /* ! __cplusplus */ +| +| #ifdef YY_USE_CONST +| #define yyconst const +| #else +| #define yyconst +| #endif +| +| /* Returned upon end-of-file. */ +| #define YY_NULL 0 +| +| /* Promotes a possibly negative, possibly signed char to an unsigned +| * integer for use as an array index. If the signed char is negative, +| * we want to instead treat it as an 8-bit unsigned char, hence the +| * double cast. +| */ +| #define YY_SC_TO_UI(c) ((unsigned int) (unsigned char) c) +| +| /* Enter a start condition. This macro really ought to take a parameter, +| * but we do it the disgusting crufty way forced on us by the ()-less +| * definition of BEGIN. +| */ +| #define BEGIN (yy_start) = 1 + 2 * +| +| /* Translate the current start state into a value that can be later handed +| * to BEGIN to return to the state. The YYSTATE alias is for lex +| * compatibility. +| */ +| #define YY_START (((yy_start) - 1) / 2) +| #define YYSTATE YY_START +| +| /* Action number for EOF rule of a given start state. */ +| #define YY_STATE_EOF(state) (YY_END_OF_BUFFER + state + 1) +| +| /* Special action meaning "start processing a new file". */ +| #define YY_NEW_FILE yyrestart(yyin ) +| +| #define YY_END_OF_BUFFER_CHAR 0 +| +| /* Size of default input buffer. */ +| #ifndef YY_BUF_SIZE +| #define YY_BUF_SIZE 16384 +| #endif +| +| /* The state buf must be large enough to hold one state per character in the main buffer. +| */ +| #define YY_STATE_BUF_SIZE ((YY_BUF_SIZE + 2) * sizeof(yy_state_type)) +| +| #ifndef YY_TYPEDEF_YY_BUFFER_STATE +| #define YY_TYPEDEF_YY_BUFFER_STATE +| typedef struct yy_buffer_state *YY_BUFFER_STATE; +| #endif +| +| #ifndef YY_TYPEDEF_YY_SIZE_T +| #define YY_TYPEDEF_YY_SIZE_T +| typedef size_t yy_size_t; +| #endif +| +| extern yy_size_t yyleng; +| +| extern FILE *yyin, *yyout; +| +| #define EOB_ACT_CONTINUE_SCAN 0 +| #define EOB_ACT_END_OF_FILE 1 +| #define EOB_ACT_LAST_MATCH 2 +| +| #define YY_LESS_LINENO(n) +| +| /* Return all but the first "n" matched characters back to the input stream. */ +| #define yyless(n) \ +| do \ +| { \ +| /* Undo effects of setting up yytext. */ \ +| int yyless_macro_arg = (n); \ +| YY_LESS_LINENO(yyless_macro_arg);\ +| *yy_cp = (yy_hold_char); \ +| YY_RESTORE_YY_MORE_OFFSET \ +| (yy_c_buf_p) = yy_cp = yy_bp + yyless_macro_arg - YY_MORE_ADJ; \ +| YY_DO_BEFORE_ACTION; /* set up yytext again */ \ +| } \ +| while ( 0 ) +| +| #define unput(c) yyunput( c, (yytext_ptr) ) +| +| #ifndef YY_STRUCT_YY_BUFFER_STATE +| #define YY_STRUCT_YY_BUFFER_STATE +| struct yy_buffer_state +| { +| FILE *yy_input_file; +| +| char *yy_ch_buf; /* input buffer */ +| char *yy_buf_pos; /* current position in input buffer */ +| +| /* Size of input buffer in bytes, not including room for EOB +| * characters. +| */ +| yy_size_t yy_buf_size; +| +| /* Number of characters read into yy_ch_buf, not including EOB +| * characters. +| */ +| yy_size_t yy_n_chars; +| +| /* Whether we "own" the buffer - i.e., we know we created it, +| * and can realloc() it to grow it, and should free() it to +| * delete it. +| */ +| int yy_is_our_buffer; +| +| /* Whether this is an "interactive" input source; if so, and +| * if we're using stdio for input, then we want to use getc() +| * instead of fread(), to make sure we stop fetching input after +| * each newline. +| */ +| int yy_is_interactive; +| +| /* Whether we're considered to be at the beginning of a line. +| * If so, '^' rules will be active on the next match, otherwise +| * not. +| */ +| int yy_at_bol; +| +| int yy_bs_lineno; /**< The line count. */ +| int yy_bs_column; /**< The column count. */ +| +| /* Whether to try to fill the input buffer when we reach the +| * end of it. +| */ +| int yy_fill_buffer; +| +| int yy_buffer_status; +| +| #define YY_BUFFER_NEW 0 +| #define YY_BUFFER_NORMAL 1 +| /* When an EOF's been seen but there's still some text to process +| * then we mark the buffer as YY_EOF_PENDING, to indicate that we +| * shouldn't try reading from the input source any more. We might +| * still have a bunch of tokens to match, though, because of +| * possible backing-up. +| * +| * When we actually see the EOF, we change the status to "new" +| * (via yyrestart()), so that the user can continue scanning by +| * just pointing yyin at a new input file. +| */ +| #define YY_BUFFER_EOF_PENDING 2 +| +| }; +| #endif /* !YY_STRUCT_YY_BUFFER_STATE */ +| +| /* Stack of input buffers. */ +| static size_t yy_buffer_stack_top = 0; /**< index of top of stack. */ +| static size_t yy_buffer_stack_max = 0; /**< capacity of stack. */ +| static YY_BUFFER_STATE * yy_buffer_stack = 0; /**< Stack as an array. */ +| +| /* We provide macros for accessing buffer states in case in the +| * future we want to put the buffer states in a more general +| * "scanner state". +| * +| * Returns the top of the stack, or NULL. +| */ +| #define YY_CURRENT_BUFFER ( (yy_buffer_stack) \ +| ? (yy_buffer_stack)[(yy_buffer_stack_top)] \ +| : NULL) +| +| /* Same as previous macro, but useful when we know that the buffer stack is not +| * NULL or when we need an lvalue. For internal use only. +| */ +| #define YY_CURRENT_BUFFER_LVALUE (yy_buffer_stack)[(yy_buffer_stack_top)] +| +| /* yy_hold_char holds the character lost when yytext is formed. */ +| static char yy_hold_char; +| static yy_size_t yy_n_chars; /* number of characters read into yy_ch_buf */ +| yy_size_t yyleng; +| +| /* Points to current character in buffer. */ +| static char *yy_c_buf_p = (char *) 0; +| static int yy_init = 0; /* whether we need to initialize */ +| static int yy_start = 0; /* start state number */ +| +| /* Flag which is used to allow yywrap()'s to do buffer switches +| * instead of setting up a fresh yyin. A bit of a hack ... +| */ +| static int yy_did_buffer_switch_on_eof; +| +| void yyrestart (FILE *input_file ); +| void yy_switch_to_buffer (YY_BUFFER_STATE new_buffer ); +| YY_BUFFER_STATE yy_create_buffer (FILE *file,int size ); +| void yy_delete_buffer (YY_BUFFER_STATE b ); +| void yy_flush_buffer (YY_BUFFER_STATE b ); +| void yypush_buffer_state (YY_BUFFER_STATE new_buffer ); +| void yypop_buffer_state (void ); +| +| static void yyensure_buffer_stack (void ); +| static void yy_load_buffer_state (void ); +| static void yy_init_buffer (YY_BUFFER_STATE b,FILE *file ); +| +| #define YY_FLUSH_BUFFER yy_flush_buffer(YY_CURRENT_BUFFER ) +| +| YY_BUFFER_STATE yy_scan_buffer (char *base,yy_size_t size ); +| YY_BUFFER_STATE yy_scan_string (yyconst char *yy_str ); +| YY_BUFFER_STATE yy_scan_bytes (yyconst char *bytes,yy_size_t len ); +| +| void *yyalloc (yy_size_t ); +| void *yyrealloc (void *,yy_size_t ); +| void yyfree (void * ); +| +| #define yy_new_buffer yy_create_buffer +| +| #define yy_set_interactive(is_interactive) \ +| { \ +| if ( ! YY_CURRENT_BUFFER ){ \ +| yyensure_buffer_stack (); \ +| YY_CURRENT_BUFFER_LVALUE = \ +| yy_create_buffer(yyin,YY_BUF_SIZE ); \ +| } \ +| YY_CURRENT_BUFFER_LVALUE->yy_is_interactive = is_interactive; \ +| } +| +| #define yy_set_bol(at_bol) \ +| { \ +| if ( ! YY_CURRENT_BUFFER ){\ +| yyensure_buffer_stack (); \ +| YY_CURRENT_BUFFER_LVALUE = \ +| yy_create_buffer(yyin,YY_BUF_SIZE ); \ +| } \ +| YY_CURRENT_BUFFER_LVALUE->yy_at_bol = at_bol; \ +| } +| +| #define YY_AT_BOL() (YY_CURRENT_BUFFER_LVALUE->yy_at_bol) +| +| /* Begin user sect3 */ +| +| typedef unsigned char YY_CHAR; +| +| FILE *yyin = (FILE *) 0, *yyout = (FILE *) 0; +| +| typedef int yy_state_type; +| +| extern int yylineno; +| +| int yylineno = 1; +| +| extern char *yytext; +| #define yytext_ptr yytext +| +| static yy_state_type yy_get_previous_state (void ); +| static yy_state_type yy_try_NUL_trans (yy_state_type current_state ); +| static int yy_get_next_buffer (void ); +| static void yy_fatal_error (yyconst char msg[] ); +| +| /* Done after the current pattern has been matched and before the +| * corresponding action - sets up yytext. +| */ +| #define YY_DO_BEFORE_ACTION \ +| (yytext_ptr) = yy_bp; \ +| (yytext_ptr) -= (yy_more_len); \ +| yyleng = (size_t) (yy_cp - (yytext_ptr)); \ +| (yy_hold_char) = *yy_cp; \ +| *yy_cp = '\0'; \ +| (yy_c_buf_p) = yy_cp; +| +| #define YY_NUM_RULES 8 +| #define YY_END_OF_BUFFER 9 +| /* This struct is not used in this scanner, +| but its presence is necessary. */ +| struct yy_trans_info +| { +| flex_int32_t yy_verify; +| flex_int32_t yy_nxt; +| }; +| static yyconst flex_int16_t yy_acclist[23] = +| { 0, +| 9, 7, 8, 8, 1, 7, 8, 2, 7, 8, +| 3, 7, 8, 4, 7, 8, 5, 7, 8, 6, +| 7, 8 +| } ; +| +| static yyconst flex_int16_t yy_accept[14] = +| { 0, +| 1, 1, 1, 2, 4, 5, 8, 11, 14, 17, +| 20, 23, 23 +| } ; +| +| static yyconst flex_int32_t yy_ec[256] = +| { 0, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 2, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 3, 4, 5, 6, +| +| 7, 8, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, +| 1, 1, 1, 1, 1 +| } ; +| +| static yyconst flex_int32_t yy_meta[9] = +| { 0, +| 1, 1, 1, 1, 1, 1, 1, 1 +| } ; +| +| static yyconst flex_int16_t yy_base[13] = +| { 0, +| 0, 0, 9, 10, 10, 10, 10, 10, 10, 10, +| 10, 10 +| } ; +| +| static yyconst flex_int16_t yy_def[13] = +| { 0, +| 12, 1, 12, 12, 12, 12, 12, 12, 12, 12, +| 12, 0 +| } ; +| +| static yyconst flex_int16_t yy_nxt[19] = +| { 0, +| 4, 5, 6, 7, 8, 9, 10, 11, 12, 3, +| 12, 12, 12, 12, 12, 12, 12, 12 +| } ; +| +| static yyconst flex_int16_t yy_chk[19] = +| { 0, +| 1, 1, 1, 1, 1, 1, 1, 1, 3, 12, +| 12, 12, 12, 12, 12, 12, 12, 12 +| } ; +| +| extern int yy_flex_debug; +| int yy_flex_debug = 0; +| +| static yy_state_type *yy_state_buf=0, *yy_state_ptr=0; +| static char *yy_full_match; +| static int yy_lp; +| #define REJECT \ +| { \ +| *yy_cp = (yy_hold_char); /* undo effects of setting up yytext */ \ +| yy_cp = (yy_full_match); /* restore poss. backed-over text */ \ +| ++(yy_lp); \ +| goto find_rule; \ +| } +| +| static int yy_more_flag = 0; +| static int yy_more_len = 0; +| #define yymore() ((yy_more_flag) = 1) +| #define YY_MORE_ADJ (yy_more_len) +| #define YY_RESTORE_YY_MORE_OFFSET +| char *yytext; +| #line 1 "conftest.l" +| #line 469 "lex.yy.c" +| +| #define INITIAL 0 +| +| #ifndef YY_NO_UNISTD_H +| /* Special case for "unistd.h", since it is non-ANSI. We include it way +| * down here because we want the user's section 1 to have been scanned first. +| * The user has a chance to override it with an option. +| */ +| #include +| #endif +| +| #ifndef YY_EXTRA_TYPE +| #define YY_EXTRA_TYPE void * +| #endif +| +| static int yy_init_globals (void ); +| +| /* Accessor methods to globals. +| These are made visible to non-reentrant scanners for convenience. */ +| +| int yylex_destroy (void ); +| +| int yyget_debug (void ); +| +| void yyset_debug (int debug_flag ); +| +| YY_EXTRA_TYPE yyget_extra (void ); +| +| void yyset_extra (YY_EXTRA_TYPE user_defined ); +| +| FILE *yyget_in (void ); +| +| void yyset_in (FILE * in_str ); +| +| FILE *yyget_out (void ); +| +| void yyset_out (FILE * out_str ); +| +| yy_size_t yyget_leng (void ); +| +| char *yyget_text (void ); +| +| int yyget_lineno (void ); +| +| void yyset_lineno (int line_number ); +| +| /* Macros after this point can all be overridden by user definitions in +| * section 1. +| */ +| +| #ifndef YY_SKIP_YYWRAP +| #ifdef __cplusplus +| extern "C" int yywrap (void ); +| #else +| extern int yywrap (void ); +| #endif +| #endif +| +| static void yyunput (int c,char *buf_ptr ); +| +| #ifndef yytext_ptr +| static void yy_flex_strncpy (char *,yyconst char *,int ); +| #endif +| +| #ifdef YY_NEED_STRLEN +| static int yy_flex_strlen (yyconst char * ); +| #endif +| +| #ifndef YY_NO_INPUT +| +| #ifdef __cplusplus +| static int yyinput (void ); +| #else +| static int input (void ); +| #endif +| +| #endif +| +| /* Amount of stuff to slurp up with each read. */ +| #ifndef YY_READ_BUF_SIZE +| #define YY_READ_BUF_SIZE 8192 +| #endif +| +| /* Copy whatever the last rule matched to the standard output. */ +| #ifndef ECHO +| /* This used to be an fputs(), but since the string might contain NUL's, +| * we now use fwrite(). +| */ +| #define ECHO do { if (fwrite( yytext, yyleng, 1, yyout )) {} } while (0) +| #endif +| +| /* Gets input and stuffs it into "buf". number of characters read, or YY_NULL, +| * is returned in "result". +| */ +| #ifndef YY_INPUT +| #define YY_INPUT(buf,result,max_size) \ +| if ( YY_CURRENT_BUFFER_LVALUE->yy_is_interactive ) \ +| { \ +| int c = '*'; \ +| size_t n; \ +| for ( n = 0; n < max_size && \ +| (c = getc( yyin )) != EOF && c != '\n'; ++n ) \ +| buf[n] = (char) c; \ +| if ( c == '\n' ) \ +| buf[n++] = (char) c; \ +| if ( c == EOF && ferror( yyin ) ) \ +| YY_FATAL_ERROR( "input in flex scanner failed" ); \ +| result = n; \ +| } \ +| else \ +| { \ +| errno=0; \ +| while ( (result = fread(buf, 1, max_size, yyin))==0 && ferror(yyin)) \ +| { \ +| if( errno != EINTR) \ +| { \ +| YY_FATAL_ERROR( "input in flex scanner failed" ); \ +| break; \ +| } \ +| errno=0; \ +| clearerr(yyin); \ +| } \ +| }\ +| \ +| +| #endif +| +| /* No semi-colon after return; correct usage is to write "yyterminate();" - +| * we don't want an extra ';' after the "return" because that will cause +| * some compilers to complain about unreachable statements. +| */ +| #ifndef yyterminate +| #define yyterminate() return YY_NULL +| #endif +| +| /* Number of entries by which start-condition stack grows. */ +| #ifndef YY_START_STACK_INCR +| #define YY_START_STACK_INCR 25 +| #endif +| +| /* Report a fatal error. */ +| #ifndef YY_FATAL_ERROR +| #define YY_FATAL_ERROR(msg) yy_fatal_error( msg ) +| #endif +| +| /* end tables serialization structures and prototypes */ +| +| /* Default declaration of generated scanner - a define so the user can +| * easily add parameters. +| */ +| #ifndef YY_DECL +| #define YY_DECL_IS_OURS 1 +| +| extern int yylex (void); +| +| #define YY_DECL int yylex (void) +| #endif /* !YY_DECL */ +| +| /* Code executed at the beginning of each rule, after yytext and yyleng +| * have been set up. +| */ +| #ifndef YY_USER_ACTION +| #define YY_USER_ACTION +| #endif +| +| /* Code executed at the end of each rule. */ +| #ifndef YY_BREAK +| #define YY_BREAK break; +| #endif +| +| #define YY_RULE_SETUP \ +| YY_USER_ACTION +| +| /** The main scanner function which does all the work. +| */ +| YY_DECL +| { +| register yy_state_type yy_current_state; +| register char *yy_cp, *yy_bp; +| register int yy_act; +| +| #line 1 "conftest.l" +| +| #line 653 "lex.yy.c" +| +| if ( !(yy_init) ) +| { +| (yy_init) = 1; +| +| #ifdef YY_USER_INIT +| YY_USER_INIT; +| #endif +| +| /* Create the reject buffer large enough to save one state per allowed character. */ +| if ( ! (yy_state_buf) ) +| (yy_state_buf) = (yy_state_type *)yyalloc(YY_STATE_BUF_SIZE ); +| if ( ! (yy_state_buf) ) +| YY_FATAL_ERROR( "out of dynamic memory in yylex()" ); +| +| if ( ! (yy_start) ) +| (yy_start) = 1; /* first start state */ +| +| if ( ! yyin ) +| yyin = stdin; +| +| if ( ! yyout ) +| yyout = stdout; +| +| if ( ! YY_CURRENT_BUFFER ) { +| yyensure_buffer_stack (); +| YY_CURRENT_BUFFER_LVALUE = +| yy_create_buffer(yyin,YY_BUF_SIZE ); +| } +| +| yy_load_buffer_state( ); +| } +| +| while ( 1 ) /* loops until end-of-file is reached */ +| { +| (yy_more_len) = 0; +| if ( (yy_more_flag) ) +| { +| (yy_more_len) = (yy_c_buf_p) - (yytext_ptr); +| (yy_more_flag) = 0; +| } +| yy_cp = (yy_c_buf_p); +| +| /* Support of yytext. */ +| *yy_cp = (yy_hold_char); +| +| /* yy_bp points to the position in yy_ch_buf of the start of +| * the current run. +| */ +| yy_bp = yy_cp; +| +| yy_current_state = (yy_start); +| +| (yy_state_ptr) = (yy_state_buf); +| *(yy_state_ptr)++ = yy_current_state; +| +| yy_match: +| do +| { +| register YY_CHAR yy_c = yy_ec[YY_SC_TO_UI(*yy_cp)]; +| while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) +| { +| yy_current_state = (int) yy_def[yy_current_state]; +| if ( yy_current_state >= 13 ) +| yy_c = yy_meta[(unsigned int) yy_c]; +| } +| yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; +| *(yy_state_ptr)++ = yy_current_state; +| ++yy_cp; +| } +| while ( yy_base[yy_current_state] != 10 ); +| +| yy_find_action: +| yy_current_state = *--(yy_state_ptr); +| (yy_lp) = yy_accept[yy_current_state]; +| find_rule: /* we branch to this label when backing up */ +| for ( ; ; ) /* until we find what rule we matched */ +| { +| if ( (yy_lp) && (yy_lp) < yy_accept[yy_current_state + 1] ) +| { +| yy_act = yy_acclist[(yy_lp)]; +| { +| (yy_full_match) = yy_cp; +| break; +| } +| } +| --yy_cp; +| yy_current_state = *--(yy_state_ptr); +| (yy_lp) = yy_accept[yy_current_state]; +| } +| +| YY_DO_BEFORE_ACTION; +| +| do_action: /* This label is used only to access EOF actions. */ +| +| switch ( yy_act ) +| { /* beginning of action switch */ +| case 1: +| YY_RULE_SETUP +| #line 2 "conftest.l" +| { ECHO; } +| YY_BREAK +| case 2: +| YY_RULE_SETUP +| #line 3 "conftest.l" +| { REJECT; } +| YY_BREAK +| case 3: +| YY_RULE_SETUP +| #line 4 "conftest.l" +| { yymore (); } +| YY_BREAK +| case 4: +| YY_RULE_SETUP +| #line 5 "conftest.l" +| { yyless (1); } +| YY_BREAK +| case 5: +| YY_RULE_SETUP +| #line 6 "conftest.l" +| { yyless (input () != 0); } +| YY_BREAK +| case 6: +| YY_RULE_SETUP +| #line 7 "conftest.l" +| { unput (yytext[0]); } +| YY_BREAK +| case 7: +| YY_RULE_SETUP +| #line 8 "conftest.l" +| { BEGIN INITIAL; } +| YY_BREAK +| case 8: +| YY_RULE_SETUP +| #line 9 "conftest.l" +| ECHO; +| YY_BREAK +| #line 791 "lex.yy.c" +| case YY_STATE_EOF(INITIAL): +| yyterminate(); +| +| case YY_END_OF_BUFFER: +| { +| /* Amount of text matched not including the EOB char. */ +| int yy_amount_of_matched_text = (int) (yy_cp - (yytext_ptr)) - 1; +| +| /* Undo the effects of YY_DO_BEFORE_ACTION. */ +| *yy_cp = (yy_hold_char); +| YY_RESTORE_YY_MORE_OFFSET +| +| if ( YY_CURRENT_BUFFER_LVALUE->yy_buffer_status == YY_BUFFER_NEW ) +| { +| /* We're scanning a new file or input source. It's +| * possible that this happened because the user +| * just pointed yyin at a new source and called +| * yylex(). If so, then we have to assure +| * consistency between YY_CURRENT_BUFFER and our +| * globals. Here is the right place to do so, because +| * this is the first action (other than possibly a +| * back-up) that will match for the new input source. +| */ +| (yy_n_chars) = YY_CURRENT_BUFFER_LVALUE->yy_n_chars; +| YY_CURRENT_BUFFER_LVALUE->yy_input_file = yyin; +| YY_CURRENT_BUFFER_LVALUE->yy_buffer_status = YY_BUFFER_NORMAL; +| } +| +| /* Note that here we test for yy_c_buf_p "<=" to the position +| * of the first EOB in the buffer, since yy_c_buf_p will +| * already have been incremented past the NUL character +| * (since all states make transitions on EOB to the +| * end-of-buffer state). Contrast this with the test +| * in input(). +| */ +| if ( (yy_c_buf_p) <= &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)] ) +| { /* This was really a NUL. */ +| yy_state_type yy_next_state; +| +| (yy_c_buf_p) = (yytext_ptr) + yy_amount_of_matched_text; +| +| yy_current_state = yy_get_previous_state( ); +| +| /* Okay, we're now positioned to make the NUL +| * transition. We couldn't have +| * yy_get_previous_state() go ahead and do it +| * for us because it doesn't know how to deal +| * with the possibility of jamming (and we don't +| * want to build jamming into it because then it +| * will run more slowly). +| */ +| +| yy_next_state = yy_try_NUL_trans( yy_current_state ); +| +| yy_bp = (yytext_ptr) + YY_MORE_ADJ; +| +| if ( yy_next_state ) +| { +| /* Consume the NUL. */ +| yy_cp = ++(yy_c_buf_p); +| yy_current_state = yy_next_state; +| goto yy_match; +| } +| +| else +| { +| yy_cp = (yy_c_buf_p); +| goto yy_find_action; +| } +| } +| +| else switch ( yy_get_next_buffer( ) ) +| { +| case EOB_ACT_END_OF_FILE: +| { +| (yy_did_buffer_switch_on_eof) = 0; +| +| if ( yywrap( ) ) +| { +| /* Note: because we've taken care in +| * yy_get_next_buffer() to have set up +| * yytext, we can now set up +| * yy_c_buf_p so that if some total +| * hoser (like flex itself) wants to +| * call the scanner after we return the +| * YY_NULL, it'll still work - another +| * YY_NULL will get returned. +| */ +| (yy_c_buf_p) = (yytext_ptr) + YY_MORE_ADJ; +| +| yy_act = YY_STATE_EOF(YY_START); +| goto do_action; +| } +| +| else +| { +| if ( ! (yy_did_buffer_switch_on_eof) ) +| YY_NEW_FILE; +| } +| break; +| } +| +| case EOB_ACT_CONTINUE_SCAN: +| (yy_c_buf_p) = +| (yytext_ptr) + yy_amount_of_matched_text; +| +| yy_current_state = yy_get_previous_state( ); +| +| yy_cp = (yy_c_buf_p); +| yy_bp = (yytext_ptr) + YY_MORE_ADJ; +| goto yy_match; +| +| case EOB_ACT_LAST_MATCH: +| (yy_c_buf_p) = +| &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)]; +| +| yy_current_state = yy_get_previous_state( ); +| +| yy_cp = (yy_c_buf_p); +| yy_bp = (yytext_ptr) + YY_MORE_ADJ; +| goto yy_find_action; +| } +| break; +| } +| +| default: +| YY_FATAL_ERROR( +| "fatal flex scanner internal error--no action found" ); +| } /* end of action switch */ +| } /* end of scanning one token */ +| } /* end of yylex */ +| +| /* yy_get_next_buffer - try to read in a new buffer +| * +| * Returns a code representing an action: +| * EOB_ACT_LAST_MATCH - +| * EOB_ACT_CONTINUE_SCAN - continue scanning from current position +| * EOB_ACT_END_OF_FILE - end of file +| */ +| static int yy_get_next_buffer (void) +| { +| register char *dest = YY_CURRENT_BUFFER_LVALUE->yy_ch_buf; +| register char *source = (yytext_ptr); +| register int number_to_move, i; +| int ret_val; +| +| if ( (yy_c_buf_p) > &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars) + 1] ) +| YY_FATAL_ERROR( +| "fatal flex scanner internal error--end of buffer missed" ); +| +| if ( YY_CURRENT_BUFFER_LVALUE->yy_fill_buffer == 0 ) +| { /* Don't try to fill the buffer, so this is an EOF. */ +| if ( (yy_c_buf_p) - (yytext_ptr) - YY_MORE_ADJ == 1 ) +| { +| /* We matched a single character, the EOB, so +| * treat this as a final EOF. +| */ +| return EOB_ACT_END_OF_FILE; +| } +| +| else +| { +| /* We matched some text prior to the EOB, first +| * process it. +| */ +| return EOB_ACT_LAST_MATCH; +| } +| } +| +| /* Try to read more data. */ +| +| /* First move last chars to start of buffer. */ +| number_to_move = (int) ((yy_c_buf_p) - (yytext_ptr)) - 1; +| +| for ( i = 0; i < number_to_move; ++i ) +| *(dest++) = *(source++); +| +| if ( YY_CURRENT_BUFFER_LVALUE->yy_buffer_status == YY_BUFFER_EOF_PENDING ) +| /* don't do the read, it's not guaranteed to return an EOF, +| * just force an EOF +| */ +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars) = 0; +| +| else +| { +| yy_size_t num_to_read = +| YY_CURRENT_BUFFER_LVALUE->yy_buf_size - number_to_move - 1; +| +| while ( num_to_read <= 0 ) +| { /* Not enough room in the buffer - grow it. */ +| +| YY_FATAL_ERROR( +| "input buffer overflow, can't enlarge buffer because scanner uses REJECT" ); +| +| } +| +| if ( num_to_read > YY_READ_BUF_SIZE ) +| num_to_read = YY_READ_BUF_SIZE; +| +| /* Read in more data. */ +| YY_INPUT( (&YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[number_to_move]), +| (yy_n_chars), num_to_read ); +| +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars); +| } +| +| if ( (yy_n_chars) == 0 ) +| { +| if ( number_to_move == YY_MORE_ADJ ) +| { +| ret_val = EOB_ACT_END_OF_FILE; +| yyrestart(yyin ); +| } +| +| else +| { +| ret_val = EOB_ACT_LAST_MATCH; +| YY_CURRENT_BUFFER_LVALUE->yy_buffer_status = +| YY_BUFFER_EOF_PENDING; +| } +| } +| +| else +| ret_val = EOB_ACT_CONTINUE_SCAN; +| +| if ((yy_size_t) ((yy_n_chars) + number_to_move) > YY_CURRENT_BUFFER_LVALUE->yy_buf_size) { +| /* Extend the array by 50%, plus the number we really need. */ +| yy_size_t new_size = (yy_n_chars) + number_to_move + ((yy_n_chars) >> 1); +| YY_CURRENT_BUFFER_LVALUE->yy_ch_buf = (char *) yyrealloc((void *) YY_CURRENT_BUFFER_LVALUE->yy_ch_buf,new_size ); +| if ( ! YY_CURRENT_BUFFER_LVALUE->yy_ch_buf ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_get_next_buffer()" ); +| } +| +| (yy_n_chars) += number_to_move; +| YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)] = YY_END_OF_BUFFER_CHAR; +| YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars) + 1] = YY_END_OF_BUFFER_CHAR; +| +| (yytext_ptr) = &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[0]; +| +| return ret_val; +| } +| +| /* yy_get_previous_state - get the state just before the EOB char was reached */ +| +| static yy_state_type yy_get_previous_state (void) +| { +| register yy_state_type yy_current_state; +| register char *yy_cp; +| +| yy_current_state = (yy_start); +| +| (yy_state_ptr) = (yy_state_buf); +| *(yy_state_ptr)++ = yy_current_state; +| +| for ( yy_cp = (yytext_ptr) + YY_MORE_ADJ; yy_cp < (yy_c_buf_p); ++yy_cp ) +| { +| register YY_CHAR yy_c = (*yy_cp ? yy_ec[YY_SC_TO_UI(*yy_cp)] : 1); +| while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) +| { +| yy_current_state = (int) yy_def[yy_current_state]; +| if ( yy_current_state >= 13 ) +| yy_c = yy_meta[(unsigned int) yy_c]; +| } +| yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; +| *(yy_state_ptr)++ = yy_current_state; +| } +| +| return yy_current_state; +| } +| +| /* yy_try_NUL_trans - try to make a transition on the NUL character +| * +| * synopsis +| * next_state = yy_try_NUL_trans( current_state ); +| */ +| static yy_state_type yy_try_NUL_trans (yy_state_type yy_current_state ) +| { +| register int yy_is_jam; +| +| register YY_CHAR yy_c = 1; +| while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) +| { +| yy_current_state = (int) yy_def[yy_current_state]; +| if ( yy_current_state >= 13 ) +| yy_c = yy_meta[(unsigned int) yy_c]; +| } +| yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; +| yy_is_jam = (yy_current_state == 12); +| if ( ! yy_is_jam ) +| *(yy_state_ptr)++ = yy_current_state; +| +| return yy_is_jam ? 0 : yy_current_state; +| } +| +| static void yyunput (int c, register char * yy_bp ) +| { +| register char *yy_cp; +| +| yy_cp = (yy_c_buf_p); +| +| /* undo effects of setting up yytext */ +| *yy_cp = (yy_hold_char); +| +| if ( yy_cp < YY_CURRENT_BUFFER_LVALUE->yy_ch_buf + 2 ) +| { /* need to shift things up to make room */ +| /* +2 for EOB chars. */ +| register yy_size_t number_to_move = (yy_n_chars) + 2; +| register char *dest = &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[ +| YY_CURRENT_BUFFER_LVALUE->yy_buf_size + 2]; +| register char *source = +| &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[number_to_move]; +| +| while ( source > YY_CURRENT_BUFFER_LVALUE->yy_ch_buf ) +| *--dest = *--source; +| +| yy_cp += (int) (dest - source); +| yy_bp += (int) (dest - source); +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = +| (yy_n_chars) = YY_CURRENT_BUFFER_LVALUE->yy_buf_size; +| +| if ( yy_cp < YY_CURRENT_BUFFER_LVALUE->yy_ch_buf + 2 ) +| YY_FATAL_ERROR( "flex scanner push-back overflow" ); +| } +| +| *--yy_cp = (char) c; +| +| (yytext_ptr) = yy_bp; +| (yy_hold_char) = *yy_cp; +| (yy_c_buf_p) = yy_cp; +| } +| +| #ifndef YY_NO_INPUT +| #ifdef __cplusplus +| static int yyinput (void) +| #else +| static int input (void) +| #endif +| +| { +| int c; +| +| *(yy_c_buf_p) = (yy_hold_char); +| +| if ( *(yy_c_buf_p) == YY_END_OF_BUFFER_CHAR ) +| { +| /* yy_c_buf_p now points to the character we want to return. +| * If this occurs *before* the EOB characters, then it's a +| * valid NUL; if not, then we've hit the end of the buffer. +| */ +| if ( (yy_c_buf_p) < &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[(yy_n_chars)] ) +| /* This was really a NUL. */ +| *(yy_c_buf_p) = '\0'; +| +| else +| { /* need more input */ +| yy_size_t offset = (yy_c_buf_p) - (yytext_ptr); +| ++(yy_c_buf_p); +| +| switch ( yy_get_next_buffer( ) ) +| { +| case EOB_ACT_LAST_MATCH: +| /* This happens because yy_g_n_b() +| * sees that we've accumulated a +| * token and flags that we need to +| * try matching the token before +| * proceeding. But for input(), +| * there's no matching to consider. +| * So convert the EOB_ACT_LAST_MATCH +| * to EOB_ACT_END_OF_FILE. +| */ +| +| /* Reset buffer status. */ +| yyrestart(yyin ); +| +| /*FALLTHROUGH*/ +| +| case EOB_ACT_END_OF_FILE: +| { +| if ( yywrap( ) ) +| return EOF; +| +| if ( ! (yy_did_buffer_switch_on_eof) ) +| YY_NEW_FILE; +| #ifdef __cplusplus +| return yyinput(); +| #else +| return input(); +| #endif +| } +| +| case EOB_ACT_CONTINUE_SCAN: +| (yy_c_buf_p) = (yytext_ptr) + offset; +| break; +| } +| } +| } +| +| c = *(unsigned char *) (yy_c_buf_p); /* cast for 8-bit char's */ +| *(yy_c_buf_p) = '\0'; /* preserve yytext */ +| (yy_hold_char) = *++(yy_c_buf_p); +| +| return c; +| } +| #endif /* ifndef YY_NO_INPUT */ +| +| /** Immediately switch to a different input stream. +| * @param input_file A readable stream. +| * +| * @note This function does not reset the start condition to @c INITIAL . +| */ +| void yyrestart (FILE * input_file ) +| { +| +| if ( ! YY_CURRENT_BUFFER ){ +| yyensure_buffer_stack (); +| YY_CURRENT_BUFFER_LVALUE = +| yy_create_buffer(yyin,YY_BUF_SIZE ); +| } +| +| yy_init_buffer(YY_CURRENT_BUFFER,input_file ); +| yy_load_buffer_state( ); +| } +| +| /** Switch to a different input buffer. +| * @param new_buffer The new input buffer. +| * +| */ +| void yy_switch_to_buffer (YY_BUFFER_STATE new_buffer ) +| { +| +| /* TODO. We should be able to replace this entire function body +| * with +| * yypop_buffer_state(); +| * yypush_buffer_state(new_buffer); +| */ +| yyensure_buffer_stack (); +| if ( YY_CURRENT_BUFFER == new_buffer ) +| return; +| +| if ( YY_CURRENT_BUFFER ) +| { +| /* Flush out information for old buffer. */ +| *(yy_c_buf_p) = (yy_hold_char); +| YY_CURRENT_BUFFER_LVALUE->yy_buf_pos = (yy_c_buf_p); +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars); +| } +| +| YY_CURRENT_BUFFER_LVALUE = new_buffer; +| yy_load_buffer_state( ); +| +| /* We don't actually know whether we did this switch during +| * EOF (yywrap()) processing, but the only time this flag +| * is looked at is after yywrap() is called, so it's safe +| * to go ahead and always set it. +| */ +| (yy_did_buffer_switch_on_eof) = 1; +| } +| +| static void yy_load_buffer_state (void) +| { +| (yy_n_chars) = YY_CURRENT_BUFFER_LVALUE->yy_n_chars; +| (yytext_ptr) = (yy_c_buf_p) = YY_CURRENT_BUFFER_LVALUE->yy_buf_pos; +| yyin = YY_CURRENT_BUFFER_LVALUE->yy_input_file; +| (yy_hold_char) = *(yy_c_buf_p); +| } +| +| /** Allocate and initialize an input buffer state. +| * @param file A readable stream. +| * @param size The character buffer size in bytes. When in doubt, use @c YY_BUF_SIZE. +| * +| * @return the allocated buffer state. +| */ +| YY_BUFFER_STATE yy_create_buffer (FILE * file, int size ) +| { +| YY_BUFFER_STATE b; +| +| b = (YY_BUFFER_STATE) yyalloc(sizeof( struct yy_buffer_state ) ); +| if ( ! b ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_create_buffer()" ); +| +| b->yy_buf_size = size; +| +| /* yy_ch_buf has to be 2 characters longer than the size given because +| * we need to put in 2 end-of-buffer characters. +| */ +| b->yy_ch_buf = (char *) yyalloc(b->yy_buf_size + 2 ); +| if ( ! b->yy_ch_buf ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_create_buffer()" ); +| +| b->yy_is_our_buffer = 1; +| +| yy_init_buffer(b,file ); +| +| return b; +| } +| +| /** Destroy the buffer. +| * @param b a buffer created with yy_create_buffer() +| * +| */ +| void yy_delete_buffer (YY_BUFFER_STATE b ) +| { +| +| if ( ! b ) +| return; +| +| if ( b == YY_CURRENT_BUFFER ) /* Not sure if we should pop here. */ +| YY_CURRENT_BUFFER_LVALUE = (YY_BUFFER_STATE) 0; +| +| if ( b->yy_is_our_buffer ) +| yyfree((void *) b->yy_ch_buf ); +| +| yyfree((void *) b ); +| } +| +| /* Initializes or reinitializes a buffer. +| * This function is sometimes called more than once on the same buffer, +| * such as during a yyrestart() or at EOF. +| */ +| static void yy_init_buffer (YY_BUFFER_STATE b, FILE * file ) +| +| { +| int oerrno = errno; +| +| yy_flush_buffer(b ); +| +| b->yy_input_file = file; +| b->yy_fill_buffer = 1; +| +| /* If b is the current buffer, then yy_init_buffer was _probably_ +| * called from yyrestart() or through yy_get_next_buffer. +| * In that case, we don't want to reset the lineno or column. +| */ +| if (b != YY_CURRENT_BUFFER){ +| b->yy_bs_lineno = 1; +| b->yy_bs_column = 0; +| } +| +| b->yy_is_interactive = file ? (isatty( fileno(file) ) > 0) : 0; +| +| errno = oerrno; +| } +| +| /** Discard all buffered characters. On the next scan, YY_INPUT will be called. +| * @param b the buffer state to be flushed, usually @c YY_CURRENT_BUFFER. +| * +| */ +| void yy_flush_buffer (YY_BUFFER_STATE b ) +| { +| if ( ! b ) +| return; +| +| b->yy_n_chars = 0; +| +| /* We always need two end-of-buffer characters. The first causes +| * a transition to the end-of-buffer state. The second causes +| * a jam in that state. +| */ +| b->yy_ch_buf[0] = YY_END_OF_BUFFER_CHAR; +| b->yy_ch_buf[1] = YY_END_OF_BUFFER_CHAR; +| +| b->yy_buf_pos = &b->yy_ch_buf[0]; +| +| b->yy_at_bol = 1; +| b->yy_buffer_status = YY_BUFFER_NEW; +| +| if ( b == YY_CURRENT_BUFFER ) +| yy_load_buffer_state( ); +| } +| +| /** Pushes the new state onto the stack. The new state becomes +| * the current state. This function will allocate the stack +| * if necessary. +| * @param new_buffer The new state. +| * +| */ +| void yypush_buffer_state (YY_BUFFER_STATE new_buffer ) +| { +| if (new_buffer == NULL) +| return; +| +| yyensure_buffer_stack(); +| +| /* This block is copied from yy_switch_to_buffer. */ +| if ( YY_CURRENT_BUFFER ) +| { +| /* Flush out information for old buffer. */ +| *(yy_c_buf_p) = (yy_hold_char); +| YY_CURRENT_BUFFER_LVALUE->yy_buf_pos = (yy_c_buf_p); +| YY_CURRENT_BUFFER_LVALUE->yy_n_chars = (yy_n_chars); +| } +| +| /* Only push if top exists. Otherwise, replace top. */ +| if (YY_CURRENT_BUFFER) +| (yy_buffer_stack_top)++; +| YY_CURRENT_BUFFER_LVALUE = new_buffer; +| +| /* copied from yy_switch_to_buffer. */ +| yy_load_buffer_state( ); +| (yy_did_buffer_switch_on_eof) = 1; +| } +| +| /** Removes and deletes the top of the stack, if present. +| * The next element becomes the new top. +| * +| */ +| void yypop_buffer_state (void) +| { +| if (!YY_CURRENT_BUFFER) +| return; +| +| yy_delete_buffer(YY_CURRENT_BUFFER ); +| YY_CURRENT_BUFFER_LVALUE = NULL; +| if ((yy_buffer_stack_top) > 0) +| --(yy_buffer_stack_top); +| +| if (YY_CURRENT_BUFFER) { +| yy_load_buffer_state( ); +| (yy_did_buffer_switch_on_eof) = 1; +| } +| } +| +| /* Allocates the stack if it does not exist. +| * Guarantees space for at least one push. +| */ +| static void yyensure_buffer_stack (void) +| { +| yy_size_t num_to_alloc; +| +| if (!(yy_buffer_stack)) { +| +| /* First allocation is just for 2 elements, since we don't know if this +| * scanner will even need a stack. We use 2 instead of 1 to avoid an +| * immediate realloc on the next call. +| */ +| num_to_alloc = 1; +| (yy_buffer_stack) = (struct yy_buffer_state**)yyalloc +| (num_to_alloc * sizeof(struct yy_buffer_state*) +| ); +| if ( ! (yy_buffer_stack) ) +| YY_FATAL_ERROR( "out of dynamic memory in yyensure_buffer_stack()" ); +| +| memset((yy_buffer_stack), 0, num_to_alloc * sizeof(struct yy_buffer_state*)); +| +| (yy_buffer_stack_max) = num_to_alloc; +| (yy_buffer_stack_top) = 0; +| return; +| } +| +| if ((yy_buffer_stack_top) >= ((yy_buffer_stack_max)) - 1){ +| +| /* Increase the buffer to prepare for a possible push. */ +| int grow_size = 8 /* arbitrary grow size */; +| +| num_to_alloc = (yy_buffer_stack_max) + grow_size; +| (yy_buffer_stack) = (struct yy_buffer_state**)yyrealloc +| ((yy_buffer_stack), +| num_to_alloc * sizeof(struct yy_buffer_state*) +| ); +| if ( ! (yy_buffer_stack) ) +| YY_FATAL_ERROR( "out of dynamic memory in yyensure_buffer_stack()" ); +| +| /* zero only the new slots.*/ +| memset((yy_buffer_stack) + (yy_buffer_stack_max), 0, grow_size * sizeof(struct yy_buffer_state*)); +| (yy_buffer_stack_max) = num_to_alloc; +| } +| } +| +| /** Setup the input buffer state to scan directly from a user-specified character buffer. +| * @param base the character buffer +| * @param size the size in bytes of the character buffer +| * +| * @return the newly allocated buffer state object. +| */ +| YY_BUFFER_STATE yy_scan_buffer (char * base, yy_size_t size ) +| { +| YY_BUFFER_STATE b; +| +| if ( size < 2 || +| base[size-2] != YY_END_OF_BUFFER_CHAR || +| base[size-1] != YY_END_OF_BUFFER_CHAR ) +| /* They forgot to leave room for the EOB's. */ +| return 0; +| +| b = (YY_BUFFER_STATE) yyalloc(sizeof( struct yy_buffer_state ) ); +| if ( ! b ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_scan_buffer()" ); +| +| b->yy_buf_size = size - 2; /* "- 2" to take care of EOB's */ +| b->yy_buf_pos = b->yy_ch_buf = base; +| b->yy_is_our_buffer = 0; +| b->yy_input_file = 0; +| b->yy_n_chars = b->yy_buf_size; +| b->yy_is_interactive = 0; +| b->yy_at_bol = 1; +| b->yy_fill_buffer = 0; +| b->yy_buffer_status = YY_BUFFER_NEW; +| +| yy_switch_to_buffer(b ); +| +| return b; +| } +| +| /** Setup the input buffer state to scan a string. The next call to yylex() will +| * scan from a @e copy of @a str. +| * @param yystr a NUL-terminated string to scan +| * +| * @return the newly allocated buffer state object. +| * @note If you want to scan bytes that may contain NUL values, then use +| * yy_scan_bytes() instead. +| */ +| YY_BUFFER_STATE yy_scan_string (yyconst char * yystr ) +| { +| +| return yy_scan_bytes(yystr,strlen(yystr) ); +| } +| +| /** Setup the input buffer state to scan the given bytes. The next call to yylex() will +| * scan from a @e copy of @a bytes. +| * @param yybytes the byte buffer to scan +| * @param _yybytes_len the number of bytes in the buffer pointed to by @a bytes. +| * +| * @return the newly allocated buffer state object. +| */ +| YY_BUFFER_STATE yy_scan_bytes (yyconst char * yybytes, yy_size_t _yybytes_len ) +| { +| YY_BUFFER_STATE b; +| char *buf; +| yy_size_t n; +| yy_size_t i; +| +| /* Get memory for full buffer, including space for trailing EOB's. */ +| n = _yybytes_len + 2; +| buf = (char *) yyalloc(n ); +| if ( ! buf ) +| YY_FATAL_ERROR( "out of dynamic memory in yy_scan_bytes()" ); +| +| for ( i = 0; i < _yybytes_len; ++i ) +| buf[i] = yybytes[i]; +| +| buf[_yybytes_len] = buf[_yybytes_len+1] = YY_END_OF_BUFFER_CHAR; +| +| b = yy_scan_buffer(buf,n ); +| if ( ! b ) +| YY_FATAL_ERROR( "bad buffer in yy_scan_bytes()" ); +| +| /* It's okay to grow etc. this buffer, and we should throw it +| * away when we're done. +| */ +| b->yy_is_our_buffer = 1; +| +| return b; +| } +| +| #ifndef YY_EXIT_FAILURE +| #define YY_EXIT_FAILURE 2 +| #endif +| +| static void yy_fatal_error (yyconst char* msg ) +| { +| (void) fprintf( stderr, "%s\n", msg ); +| exit( YY_EXIT_FAILURE ); +| } +| +| /* Redefine yyless() so it works in section 3 code. */ +| +| #undef yyless +| #define yyless(n) \ +| do \ +| { \ +| /* Undo effects of setting up yytext. */ \ +| int yyless_macro_arg = (n); \ +| YY_LESS_LINENO(yyless_macro_arg);\ +| yytext[yyleng] = (yy_hold_char); \ +| (yy_c_buf_p) = yytext + yyless_macro_arg; \ +| (yy_hold_char) = *(yy_c_buf_p); \ +| *(yy_c_buf_p) = '\0'; \ +| yyleng = yyless_macro_arg; \ +| } \ +| while ( 0 ) +| +| /* Accessor methods (get/set functions) to struct members. */ +| +| /** Get the current line number. +| * +| */ +| int yyget_lineno (void) +| { +| +| return yylineno; +| } +| +| /** Get the input stream. +| * +| */ +| FILE *yyget_in (void) +| { +| return yyin; +| } +| +| /** Get the output stream. +| * +| */ +| FILE *yyget_out (void) +| { +| return yyout; +| } +| +| /** Get the length of the current token. +| * +| */ +| yy_size_t yyget_leng (void) +| { +| return yyleng; +| } +| +| /** Get the current token. +| * +| */ +| +| char *yyget_text (void) +| { +| return yytext; +| } +| +| /** Set the current line number. +| * @param line_number +| * +| */ +| void yyset_lineno (int line_number ) +| { +| +| yylineno = line_number; +| } +| +| /** Set the input stream. This does not discard the current +| * input buffer. +| * @param in_str A readable stream. +| * +| * @see yy_switch_to_buffer +| */ +| void yyset_in (FILE * in_str ) +| { +| yyin = in_str ; +| } +| +| void yyset_out (FILE * out_str ) +| { +| yyout = out_str ; +| } +| +| int yyget_debug (void) +| { +| return yy_flex_debug; +| } +| +| void yyset_debug (int bdebug ) +| { +| yy_flex_debug = bdebug ; +| } +| +| static int yy_init_globals (void) +| { +| /* Initialization is the same as for the non-reentrant scanner. +| * This function is called from yylex_destroy(), so don't allocate here. +| */ +| +| (yy_buffer_stack) = 0; +| (yy_buffer_stack_top) = 0; +| (yy_buffer_stack_max) = 0; +| (yy_c_buf_p) = (char *) 0; +| (yy_init) = 0; +| (yy_start) = 0; +| +| (yy_state_buf) = 0; +| (yy_state_ptr) = 0; +| (yy_full_match) = 0; +| (yy_lp) = 0; +| +| /* Defined in main.c */ +| #ifdef YY_STDINIT +| yyin = stdin; +| yyout = stdout; +| #else +| yyin = (FILE *) 0; +| yyout = (FILE *) 0; +| #endif +| +| /* For future reference: Set errno on error, since we are called by +| * yylex_init() +| */ +| return 0; +| } +| +| /* yylex_destroy is for both reentrant and non-reentrant scanners. */ +| int yylex_destroy (void) +| { +| +| /* Pop the buffer stack, destroying each element. */ +| while(YY_CURRENT_BUFFER){ +| yy_delete_buffer(YY_CURRENT_BUFFER ); +| YY_CURRENT_BUFFER_LVALUE = NULL; +| yypop_buffer_state(); +| } +| +| /* Destroy the stack itself. */ +| yyfree((yy_buffer_stack) ); +| (yy_buffer_stack) = NULL; +| +| yyfree ( (yy_state_buf) ); +| (yy_state_buf) = NULL; +| +| /* Reset the globals. This is important in a non-reentrant scanner so the next time +| * yylex() is called, initialization will occur. */ +| yy_init_globals( ); +| +| return 0; +| } +| +| /* +| * Internal utility routines. +| */ +| +| #ifndef yytext_ptr +| static void yy_flex_strncpy (char* s1, yyconst char * s2, int n ) +| { +| register int i; +| for ( i = 0; i < n; ++i ) +| s1[i] = s2[i]; +| } +| #endif +| +| #ifdef YY_NEED_STRLEN +| static int yy_flex_strlen (yyconst char * s ) +| { +| register int n; +| for ( n = 0; s[n]; ++n ) +| ; +| +| return n; +| } +| #endif +| +| void *yyalloc (yy_size_t size ) +| { +| return (void *) malloc( size ); +| } +| +| void *yyrealloc (void * ptr, yy_size_t size ) +| { +| /* The cast to (char *) in the following accommodates both +| * implementations that use char* generic pointers, and those +| * that use void* generic pointers. It works with the latter +| * because both ANSI C and C++ allow castless assignment from +| * any pointer type to void*, and deal with argument conversions +| * as though doing an assignment. +| */ +| return (void *) realloc( (char *) ptr, size ); +| } +| +| void yyfree (void * ptr ) +| { +| free( (char *) ptr ); /* see yyrealloc() for (char *) cast */ +| } +| +| #define YYTABLES_NAME "yytables" +| +| #line 9 "conftest.l" +| +| +| #ifdef YYTEXT_POINTER +| extern char *yytext; +| #endif +| int +| main (void) +| { +| return ! yylex () + ! yywrap (); +| } +configure:16346: result: no +configure:16373: checking for bison +configure:16389: found /usr/bin/bison +configure:16400: result: bison -y +configure:16422: checking for compiler switch to enable full C/C++ warnings +configure:16440: result: -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter, -Wall -Wshadow -Wextra -Wno-unused-parameter +configure:16448: checking for ANSI C header files +configure:16552: result: yes +configure:16563: checking for unistd.h +configure:16563: result: yes +configure:16563: checking for stdint.h +configure:16563: result: yes +configure:16563: checking xlocale.h usability +configure:16563: gcc -c -g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter conftest.c >&5 +configure:16563: $? = 0 +configure:16563: result: yes +configure:16563: checking xlocale.h presence +configure:16563: gcc -E conftest.c +configure:16563: $? = 0 +configure:16563: result: yes +configure:16563: checking for xlocale.h +configure:16563: result: yes +configure:16574: checking for an ANSI C-conforming const +configure:16639: gcc -c -g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter conftest.c >&5 +conftest.c: In function 'main': +conftest.c:62:7: warning: 't' is used uninitialized in this function [-Wuninitialized] + *t++ = 0; + ^ +conftest.c:84:13: warning: 'cs[0]' is used uninitialized in this function [-Wuninitialized] + return !cs[0] && !zero.x; + ^ +configure:16639: $? = 0 +configure:16646: result: yes +configure:16659: checking for newlocale +configure:16659: gcc -o conftest -g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter conftest.c >&5 +configure:16659: $? = 0 +configure:16659: result: yes +configure:16659: checking for uselocale +configure:16659: gcc -o conftest -g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter conftest.c >&5 +configure:16659: $? = 0 +configure:16659: result: yes +configure:16659: checking for freelocale +configure:16659: gcc -o conftest -g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter conftest.c >&5 +configure:16659: $? = 0 +configure:16659: result: yes +configure:16882: creating ./config.status + +## ---------------------- ## +## Running config.status. ## +## ---------------------- ## + +This file was extended by libconfig config.status 1.4.9, which was +generated by GNU Autoconf 2.68. Invocation command line was + + CONFIG_FILES = + CONFIG_HEADERS = + CONFIG_LINKS = + CONFIG_COMMANDS = + $ ./config.status + +on timor.sen.cwi.nl + +config.status:1191: creating Makefile +config.status:1191: creating lib/Makefile +config.status:1191: creating lib/libconfig.pc +config.status:1191: creating lib/libconfig++.pc +config.status:1191: creating doc/Makefile +config.status:1191: creating examples/Makefile +config.status:1191: creating examples/c/Makefile +config.status:1191: creating examples/c++/Makefile +config.status:1191: creating tinytest/Makefile +config.status:1191: creating tests/Makefile +config.status:1191: creating libconfig.spec +config.status:1191: creating ac_config.h +config.status:1420: executing depfiles commands +config.status:1420: executing libtool commands + +## ---------------- ## +## Cache variables. ## +## ---------------- ## + +ac_cv_build=x86_64-unknown-linux-gnu +ac_cv_c_compiler_gnu=yes +ac_cv_c_const=yes +ac_cv_cxx_compiler_gnu=yes +ac_cv_env_CCC_set= +ac_cv_env_CCC_value= +ac_cv_env_CC_set= +ac_cv_env_CC_value= +ac_cv_env_CFLAGS_set= +ac_cv_env_CFLAGS_value= +ac_cv_env_CPPFLAGS_set= +ac_cv_env_CPPFLAGS_value= +ac_cv_env_CPP_set= +ac_cv_env_CPP_value= +ac_cv_env_CXXCPP_set= +ac_cv_env_CXXCPP_value= +ac_cv_env_CXXFLAGS_set= +ac_cv_env_CXXFLAGS_value= +ac_cv_env_CXX_set= +ac_cv_env_CXX_value= +ac_cv_env_LDFLAGS_set= +ac_cv_env_LDFLAGS_value= +ac_cv_env_LIBS_set= +ac_cv_env_LIBS_value= +ac_cv_env_YACC_set= +ac_cv_env_YACC_value= +ac_cv_env_YFLAGS_set= +ac_cv_env_YFLAGS_value= +ac_cv_env_build_alias_set= +ac_cv_env_build_alias_value= +ac_cv_env_host_alias_set= +ac_cv_env_host_alias_value= +ac_cv_env_target_alias_set= +ac_cv_env_target_alias_value= +ac_cv_func_freelocale=yes +ac_cv_func_newlocale=yes +ac_cv_func_uselocale=yes +ac_cv_header_dlfcn_h=yes +ac_cv_header_inttypes_h=yes +ac_cv_header_memory_h=yes +ac_cv_header_minix_config_h=no +ac_cv_header_stdc=yes +ac_cv_header_stdint_h=yes +ac_cv_header_stdlib_h=yes +ac_cv_header_string_h=yes +ac_cv_header_strings_h=yes +ac_cv_header_sys_stat_h=yes +ac_cv_header_sys_types_h=yes +ac_cv_header_unistd_h=yes +ac_cv_header_xlocale_h=yes +ac_cv_host=x86_64-unknown-linux-gnu +ac_cv_lib_lex='none needed' +ac_cv_objext=o +ac_cv_path_EGREP='/usr/bin/grep -E' +ac_cv_path_FGREP='/usr/bin/grep -F' +ac_cv_path_GREP=/usr/bin/grep +ac_cv_path_SED=/usr/bin/sed +ac_cv_path_install='/usr/bin/install -c' +ac_cv_path_mkdir=/usr/bin/mkdir +ac_cv_prog_AWK=gawk +ac_cv_prog_CPP='gcc -E' +ac_cv_prog_CXXCPP='g++ -E' +ac_cv_prog_LEX=flex +ac_cv_prog_YACC='bison -y' +ac_cv_prog_ac_ct_AR=ar +ac_cv_prog_ac_ct_CC=gcc +ac_cv_prog_ac_ct_CXX=g++ +ac_cv_prog_ac_ct_OBJDUMP=objdump +ac_cv_prog_ac_ct_RANLIB=ranlib +ac_cv_prog_ac_ct_STRIP=strip +ac_cv_prog_cc_c89= +ac_cv_prog_cc_g=yes +ac_cv_prog_cc_gcc_c_o=yes +ac_cv_prog_cxx_g=yes +ac_cv_prog_lex_root=lex.yy +ac_cv_prog_lex_yytext_pointer=no +ac_cv_prog_make_make_set=yes +ac_cv_safe_to_define___extensions__=yes +ac_cv_target=x86_64-unknown-linux-gnu +am_cv_CC_dependencies_compiler_type=gcc3 +am_cv_CXX_dependencies_compiler_type=gcc3 +lt_cv_ar_at_file=@ +lt_cv_archive_cmds_need_lc=no +lt_cv_deplibs_check_method=pass_all +lt_cv_file_magic_cmd='$MAGIC_CMD' +lt_cv_file_magic_test_file= +lt_cv_ld_reload_flag=-r +lt_cv_nm_interface='BSD nm' +lt_cv_objdir=.libs +lt_cv_path_LD=/usr/bin/ld +lt_cv_path_LDCXX='/usr/bin/ld -m elf_x86_64' +lt_cv_path_NM='/usr/bin/nm -B' +lt_cv_path_mainfest_tool=no +lt_cv_prog_compiler_c_o=yes +lt_cv_prog_compiler_c_o_CXX=yes +lt_cv_prog_compiler_pic='-fPIC -DPIC' +lt_cv_prog_compiler_pic_CXX='-fPIC -DPIC' +lt_cv_prog_compiler_pic_works=yes +lt_cv_prog_compiler_pic_works_CXX=yes +lt_cv_prog_compiler_rtti_exceptions=no +lt_cv_prog_compiler_static_works=yes +lt_cv_prog_compiler_static_works_CXX=no +lt_cv_prog_gnu_ld=yes +lt_cv_prog_gnu_ldcxx=yes +lt_cv_sharedlib_from_linklib_cmd='printf %s\n' +lt_cv_shlibpath_overrides_runpath=no +lt_cv_sys_global_symbol_pipe='sed -n -e '\''s/^.*[ ]\([ABCDGIRSTW][ABCDGIRSTW]*\)[ ][ ]*\([_A-Za-z][_A-Za-z0-9]*\)$/\1 \2 \2/p'\'' | sed '\''/ __gnu_lto/d'\''' +lt_cv_sys_global_symbol_to_c_name_address='sed -n -e '\''s/^: \([^ ]*\)[ ]*$/ {\"\1\", (void *) 0},/p'\'' -e '\''s/^[ABCDGIRSTW]* \([^ ]*\) \([^ ]*\)$/ {"\2", (void *) \&\2},/p'\''' +lt_cv_sys_global_symbol_to_c_name_address_lib_prefix='sed -n -e '\''s/^: \([^ ]*\)[ ]*$/ {\"\1\", (void *) 0},/p'\'' -e '\''s/^[ABCDGIRSTW]* \([^ ]*\) \(lib[^ ]*\)$/ {"\2", (void *) \&\2},/p'\'' -e '\''s/^[ABCDGIRSTW]* \([^ ]*\) \([^ ]*\)$/ {"lib\2", (void *) \&\2},/p'\''' +lt_cv_sys_global_symbol_to_cdecl='sed -n -e '\''s/^T .* \(.*\)$/extern int \1();/p'\'' -e '\''s/^[ABCDGIRSTW]* .* \(.*\)$/extern char \1;/p'\''' +lt_cv_sys_max_cmd_len=1572864 +lt_cv_to_host_file_cmd=func_convert_file_noop +lt_cv_to_tool_file_cmd=func_convert_file_noop + +## ----------------- ## +## Output variables. ## +## ----------------- ## + +ACLOCAL='${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run aclocal-1.11' +AMDEPBACKSLASH='\' +AMDEP_FALSE='#' +AMDEP_TRUE='' +AMTAR='${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run tar' +AR='ar' +AS='as' +AUTOCONF='${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoconf' +AUTOHEADER='${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoheader' +AUTOMAKE='${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run automake-1.11' +AWK='gawk' +BUILDCXX_FALSE='' +BUILDCXX_TRUE='#' +BUILDEXAMPLES_FALSE='#' +BUILDEXAMPLES_TRUE='' +CC='gcc' +CCDEPMODE='depmode=gcc3' +CFLAGS='-g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter' +CPP='gcc -E' +CPPFLAGS='' +CXX='g++' +CXXCPP='g++ -E' +CXXDEPMODE='depmode=gcc3' +CXXFLAGS='-g -O2 -Wall -Wshadow -Wextra -Wno-unused-parameter' +CYGPATH_W='echo' +DEFS='-DHAVE_CONFIG_H' +DEPDIR='.deps' +DLLTOOL='false' +DSYMUTIL='' +DUMPBIN='' +ECHO_C='' +ECHO_N='-n' +ECHO_T='' +EGREP='/usr/bin/grep -E' +EXEEXT='' +FGREP='/usr/bin/grep -F' +GNU_WIN_FALSE='' +GNU_WIN_TRUE='#' +GREP='/usr/bin/grep' +INSTALL_DATA='${INSTALL} -m 644' +INSTALL_PROGRAM='${INSTALL}' +INSTALL_SCRIPT='${INSTALL}' +INSTALL_STRIP_PROGRAM='$(install_sh) -c -s' +LD='/usr/bin/ld -m elf_x86_64' +LDFLAGS='' +LEX='flex' +LEXLIB='' +LEX_OUTPUT_ROOT='lex.yy' +LIBOBJS='' +LIBS='' +LIBTOOL='$(SHELL) $(top_builddir)/libtool' +LIPO='' +LN_S='ln -s' +LTLIBOBJS='' +MAKEINFO='${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run makeinfo' +MANIFEST_TOOL=':' +MKDIR_P='/usr/bin/mkdir -p' +NM='/usr/bin/nm -B' +NMEDIT='' +OBJDUMP='objdump' +OBJEXT='o' +OTOOL64='' +OTOOL='' +PACKAGE='libconfig' +PACKAGE_BUGREPORT='hyperrealm@gmail.com' +PACKAGE_NAME='libconfig' +PACKAGE_STRING='libconfig 1.4.9' +PACKAGE_TARNAME='libconfig' +PACKAGE_URL='http://www.hyperrealm.com/main.php?s=libconfig' +PACKAGE_VERSION='1.4.9' +PATH_SEPARATOR=':' +RANLIB='ranlib' +SED='/usr/bin/sed' +SET_MAKE='' +SHELL='/bin/sh' +STRIP='strip' +VERSION='1.4.9' +YACC='bison -y' +YFLAGS='' +ac_ct_AR='ar' +ac_ct_CC='gcc' +ac_ct_CXX='g++' +ac_ct_DUMPBIN='' +am__EXEEXT_FALSE='' +am__EXEEXT_TRUE='#' +am__fastdepCC_FALSE='#' +am__fastdepCC_TRUE='' +am__fastdepCXX_FALSE='#' +am__fastdepCXX_TRUE='' +am__include='include' +am__isrc='' +am__leading_dot='.' +am__quote='' +am__tar='${AMTAR} chof - "$$tardir"' +am__untar='${AMTAR} xf -' +bindir='${exec_prefix}/bin' +build='x86_64-unknown-linux-gnu' +build_alias='' +build_cpu='x86_64' +build_os='linux-gnu' +build_vendor='unknown' +datadir='${datarootdir}' +datarootdir='${prefix}/share' +docdir='${datarootdir}/doc/${PACKAGE_TARNAME}' +dvidir='${docdir}' +exec_prefix='${prefix}' +host='x86_64-unknown-linux-gnu' +host_alias='' +host_cpu='x86_64' +host_os='linux-gnu' +host_vendor='unknown' +htmldir='${docdir}' +includedir='${prefix}/include' +infodir='${datarootdir}/info' +install_sh='${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/install-sh' +libdir='${exec_prefix}/lib' +libexecdir='${exec_prefix}/libexec' +localedir='${datarootdir}/locale' +localstatedir='${prefix}/var' +mandir='${datarootdir}/man' +mkdir_p='/usr/bin/mkdir -p' +oldincludedir='/usr/include' +pdfdir='${docdir}' +prefix='/usr/local' +program_transform_name='s,x,x,' +psdir='${docdir}' +sbindir='${exec_prefix}/sbin' +sharedstatedir='${prefix}/com' +sysconfdir='${prefix}/etc' +target='x86_64-unknown-linux-gnu' +target_alias='' +target_cpu='x86_64' +target_os='linux-gnu' +target_vendor='unknown' + +## ----------- ## +## confdefs.h. ## +## ----------- ## + +/* confdefs.h */ +#define PACKAGE_NAME "libconfig" +#define PACKAGE_TARNAME "libconfig" +#define PACKAGE_VERSION "1.4.9" +#define PACKAGE_STRING "libconfig 1.4.9" +#define PACKAGE_BUGREPORT "hyperrealm@gmail.com" +#define PACKAGE_URL "http://www.hyperrealm.com/main.php?s=libconfig" +#define PACKAGE "libconfig" +#define VERSION "1.4.9" +#define TARGET "x86_64-unknown-linux-gnu" +#define STDC_HEADERS 1 +#define HAVE_SYS_TYPES_H 1 +#define HAVE_SYS_STAT_H 1 +#define HAVE_STDLIB_H 1 +#define HAVE_STRING_H 1 +#define HAVE_MEMORY_H 1 +#define HAVE_STRINGS_H 1 +#define HAVE_INTTYPES_H 1 +#define HAVE_STDINT_H 1 +#define HAVE_UNISTD_H 1 +#define __EXTENSIONS__ 1 +#define _ALL_SOURCE 1 +#define _GNU_SOURCE 1 +#define _POSIX_PTHREAD_SEMANTICS 1 +#define _TANDEM_SOURCE 1 +#define HAVE_DLFCN_H 1 +#define LT_OBJDIR ".libs/" +#define STDC_HEADERS 1 +#define HAVE_UNISTD_H 1 +#define HAVE_STDINT_H 1 +#define HAVE_XLOCALE_H 1 +#define HAVE_NEWLOCALE 1 +#define HAVE_USELOCALE 1 +#define HAVE_FREELOCALE 1 + +configure: exit 0 diff --git a/libconfig-1.4.9/config.status b/libconfig-1.4.9/config.status new file mode 100755 index 0000000000000000000000000000000000000000..4834945033e5bef2b820d5733e5d867c739341fe --- /dev/null +++ b/libconfig-1.4.9/config.status @@ -0,0 +1,2327 @@ +#! /bin/sh +# Generated by configure. +# Run this file to recreate the current configuration. +# Compiler output produced by configure, useful for debugging +# configure, is in config.log if it exists. + +debug=false +ac_cs_recheck=false +ac_cs_silent=false + +SHELL=${CONFIG_SHELL-/bin/sh} +export SHELL +## -------------------- ## +## M4sh Initialization. ## +## -------------------- ## + +# Be more Bourne compatible +DUALCASE=1; export DUALCASE # for MKS sh +if test -n "${ZSH_VERSION+set}" && (emulate sh) >/dev/null 2>&1; then : + emulate sh + NULLCMD=: + # Pre-4.2 versions of Zsh do word splitting on ${1+"$@"}, which + # is contrary to our usage. Disable this feature. + alias -g '${1+"$@"}'='"$@"' + setopt NO_GLOB_SUBST +else + case `(set -o) 2>/dev/null` in #( + *posix*) : + set -o posix ;; #( + *) : + ;; +esac +fi + + +as_nl=' +' +export as_nl +# Printing a long string crashes Solaris 7 /usr/bin/printf. +as_echo='\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\' +as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo +as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo$as_echo +# Prefer a ksh shell builtin over an external printf program on Solaris, +# but without wasting forks for bash or zsh. +if test -z "$BASH_VERSION$ZSH_VERSION" \ + && (test "X`print -r -- $as_echo`" = "X$as_echo") 2>/dev/null; then + as_echo='print -r --' + as_echo_n='print -rn --' +elif (test "X`printf %s $as_echo`" = "X$as_echo") 2>/dev/null; then + as_echo='printf %s\n' + as_echo_n='printf %s' +else + if test "X`(/usr/ucb/echo -n -n $as_echo) 2>/dev/null`" = "X-n $as_echo"; then + as_echo_body='eval /usr/ucb/echo -n "$1$as_nl"' + as_echo_n='/usr/ucb/echo -n' + else + as_echo_body='eval expr "X$1" : "X\\(.*\\)"' + as_echo_n_body='eval + arg=$1; + case $arg in #( + *"$as_nl"*) + expr "X$arg" : "X\\(.*\\)$as_nl"; + arg=`expr "X$arg" : ".*$as_nl\\(.*\\)"`;; + esac; + expr "X$arg" : "X\\(.*\\)" | tr -d "$as_nl" + ' + export as_echo_n_body + as_echo_n='sh -c $as_echo_n_body as_echo' + fi + export as_echo_body + as_echo='sh -c $as_echo_body as_echo' +fi + +# The user is always right. +if test "${PATH_SEPARATOR+set}" != set; then + PATH_SEPARATOR=: + (PATH='/bin;/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 && { + (PATH='/bin:/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 || + PATH_SEPARATOR=';' + } +fi + + +# IFS +# We need space, tab and new line, in precisely that order. Quoting is +# there to prevent editors from complaining about space-tab. +# (If _AS_PATH_WALK were called with IFS unset, it would disable word +# splitting by setting IFS to empty value.) +IFS=" "" $as_nl" + +# Find who we are. Look in the path if we contain no directory separator. +as_myself= +case $0 in #(( + *[\\/]* ) as_myself=$0 ;; + *) as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + test -r "$as_dir/$0" && as_myself=$as_dir/$0 && break + done +IFS=$as_save_IFS + + ;; +esac +# We did not find ourselves, most probably we were run as `sh COMMAND' +# in which case we are not to be found in the path. +if test "x$as_myself" = x; then + as_myself=$0 +fi +if test ! -f "$as_myself"; then + $as_echo "$as_myself: error: cannot find myself; rerun with an absolute file name" >&2 + exit 1 +fi + +# Unset variables that we do not need and which cause bugs (e.g. in +# pre-3.0 UWIN ksh). But do not cause bugs in bash 2.01; the "|| exit 1" +# suppresses any "Segmentation fault" message there. '((' could +# trigger a bug in pdksh 5.2.14. +for as_var in BASH_ENV ENV MAIL MAILPATH +do eval test x\${$as_var+set} = xset \ + && ( (unset $as_var) || exit 1) >/dev/null 2>&1 && unset $as_var || : +done +PS1='$ ' +PS2='> ' +PS4='+ ' + +# NLS nuisances. +LC_ALL=C +export LC_ALL +LANGUAGE=C +export LANGUAGE + +# CDPATH. +(unset CDPATH) >/dev/null 2>&1 && unset CDPATH + + +# as_fn_error STATUS ERROR [LINENO LOG_FD] +# ---------------------------------------- +# Output "`basename $0`: error: ERROR" to stderr. If LINENO and LOG_FD are +# provided, also output the error to LOG_FD, referencing LINENO. Then exit the +# script with STATUS, using 1 if that was 0. +as_fn_error () +{ + as_status=$1; test $as_status -eq 0 && as_status=1 + if test "$4"; then + as_lineno=${as_lineno-"$3"} as_lineno_stack=as_lineno_stack=$as_lineno_stack + $as_echo "$as_me:${as_lineno-$LINENO}: error: $2" >&$4 + fi + $as_echo "$as_me: error: $2" >&2 + as_fn_exit $as_status +} # as_fn_error + + +# as_fn_set_status STATUS +# ----------------------- +# Set $? to STATUS, without forking. +as_fn_set_status () +{ + return $1 +} # as_fn_set_status + +# as_fn_exit STATUS +# ----------------- +# Exit the shell with STATUS, even in a "trap 0" or "set -e" context. +as_fn_exit () +{ + set +e + as_fn_set_status $1 + exit $1 +} # as_fn_exit + +# as_fn_unset VAR +# --------------- +# Portably unset VAR. +as_fn_unset () +{ + { eval $1=; unset $1;} +} +as_unset=as_fn_unset +# as_fn_append VAR VALUE +# ---------------------- +# Append the text in VALUE to the end of the definition contained in VAR. Take +# advantage of any shell optimizations that allow amortized linear growth over +# repeated appends, instead of the typical quadratic growth present in naive +# implementations. +if (eval "as_var=1; as_var+=2; test x\$as_var = x12") 2>/dev/null; then : + eval 'as_fn_append () + { + eval $1+=\$2 + }' +else + as_fn_append () + { + eval $1=\$$1\$2 + } +fi # as_fn_append + +# as_fn_arith ARG... +# ------------------ +# Perform arithmetic evaluation on the ARGs, and store the result in the +# global $as_val. Take advantage of shells that can avoid forks. The arguments +# must be portable across $(()) and expr. +if (eval "test \$(( 1 + 1 )) = 2") 2>/dev/null; then : + eval 'as_fn_arith () + { + as_val=$(( $* )) + }' +else + as_fn_arith () + { + as_val=`expr "$@" || test $? -eq 1` + } +fi # as_fn_arith + + +if expr a : '\(a\)' >/dev/null 2>&1 && + test "X`expr 00001 : '.*\(...\)'`" = X001; then + as_expr=expr +else + as_expr=false +fi + +if (basename -- /) >/dev/null 2>&1 && test "X`basename -- / 2>&1`" = "X/"; then + as_basename=basename +else + as_basename=false +fi + +if (as_dir=`dirname -- /` && test "X$as_dir" = X/) >/dev/null 2>&1; then + as_dirname=dirname +else + as_dirname=false +fi + +as_me=`$as_basename -- "$0" || +$as_expr X/"$0" : '.*/\([^/][^/]*\)/*$' \| \ + X"$0" : 'X\(//\)$' \| \ + X"$0" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X/"$0" | + sed '/^.*\/\([^/][^/]*\)\/*$/{ + s//\1/ + q + } + /^X\/\(\/\/\)$/{ + s//\1/ + q + } + /^X\/\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'` + +# Avoid depending upon Character Ranges. +as_cr_letters='abcdefghijklmnopqrstuvwxyz' +as_cr_LETTERS='ABCDEFGHIJKLMNOPQRSTUVWXYZ' +as_cr_Letters=$as_cr_letters$as_cr_LETTERS +as_cr_digits='0123456789' +as_cr_alnum=$as_cr_Letters$as_cr_digits + +ECHO_C= ECHO_N= ECHO_T= +case `echo -n x` in #((((( +-n*) + case `echo 'xy\c'` in + *c*) ECHO_T=' ';; # ECHO_T is single tab character. + xy) ECHO_C='\c';; + *) echo `echo ksh88 bug on AIX 6.1` > /dev/null + ECHO_T=' ';; + esac;; +*) + ECHO_N='-n';; +esac + +rm -f conf$$ conf$$.exe conf$$.file +if test -d conf$$.dir; then + rm -f conf$$.dir/conf$$.file +else + rm -f conf$$.dir + mkdir conf$$.dir 2>/dev/null +fi +if (echo >conf$$.file) 2>/dev/null; then + if ln -s conf$$.file conf$$ 2>/dev/null; then + as_ln_s='ln -s' + # ... but there are two gotchas: + # 1) On MSYS, both `ln -s file dir' and `ln file dir' fail. + # 2) DJGPP < 2.04 has no symlinks; `ln -s' creates a wrapper executable. + # In both cases, we have to default to `cp -p'. + ln -s conf$$.file conf$$.dir 2>/dev/null && test ! -f conf$$.exe || + as_ln_s='cp -p' + elif ln conf$$.file conf$$ 2>/dev/null; then + as_ln_s=ln + else + as_ln_s='cp -p' + fi +else + as_ln_s='cp -p' +fi +rm -f conf$$ conf$$.exe conf$$.dir/conf$$.file conf$$.file +rmdir conf$$.dir 2>/dev/null + + +# as_fn_mkdir_p +# ------------- +# Create "$as_dir" as a directory, including parents if necessary. +as_fn_mkdir_p () +{ + + case $as_dir in #( + -*) as_dir=./$as_dir;; + esac + test -d "$as_dir" || eval $as_mkdir_p || { + as_dirs= + while :; do + case $as_dir in #( + *\'*) as_qdir=`$as_echo "$as_dir" | sed "s/'/'\\\\\\\\''/g"`;; #'( + *) as_qdir=$as_dir;; + esac + as_dirs="'$as_qdir' $as_dirs" + as_dir=`$as_dirname -- "$as_dir" || +$as_expr X"$as_dir" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ + X"$as_dir" : 'X\(//\)[^/]' \| \ + X"$as_dir" : 'X\(//\)$' \| \ + X"$as_dir" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X"$as_dir" | + sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ + s//\1/ + q + } + /^X\(\/\/\)[^/].*/{ + s//\1/ + q + } + /^X\(\/\/\)$/{ + s//\1/ + q + } + /^X\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'` + test -d "$as_dir" && break + done + test -z "$as_dirs" || eval "mkdir $as_dirs" + } || test -d "$as_dir" || as_fn_error $? "cannot create directory $as_dir" + + +} # as_fn_mkdir_p +if mkdir -p . 2>/dev/null; then + as_mkdir_p='mkdir -p "$as_dir"' +else + test -d ./-p && rmdir ./-p + as_mkdir_p=false +fi + +if test -x / >/dev/null 2>&1; then + as_test_x='test -x' +else + if ls -dL / >/dev/null 2>&1; then + as_ls_L_option=L + else + as_ls_L_option= + fi + as_test_x=' + eval sh -c '\'' + if test -d "$1"; then + test -d "$1/."; + else + case $1 in #( + -*)set "./$1";; + esac; + case `ls -ld'$as_ls_L_option' "$1" 2>/dev/null` in #(( + ???[sx]*):;;*)false;;esac;fi + '\'' sh + ' +fi +as_executable_p=$as_test_x + +# Sed expression to map a string onto a valid CPP name. +as_tr_cpp="eval sed 'y%*$as_cr_letters%P$as_cr_LETTERS%;s%[^_$as_cr_alnum]%_%g'" + +# Sed expression to map a string onto a valid variable name. +as_tr_sh="eval sed 'y%*+%pp%;s%[^_$as_cr_alnum]%_%g'" + + +exec 6>&1 +## ----------------------------------- ## +## Main body of $CONFIG_STATUS script. ## +## ----------------------------------- ## +# Save the log message, to keep $0 and so on meaningful, and to +# report actual input values of CONFIG_FILES etc. instead of their +# values after options handling. +ac_log=" +This file was extended by libconfig $as_me 1.4.9, which was +generated by GNU Autoconf 2.68. Invocation command line was + + CONFIG_FILES = $CONFIG_FILES + CONFIG_HEADERS = $CONFIG_HEADERS + CONFIG_LINKS = $CONFIG_LINKS + CONFIG_COMMANDS = $CONFIG_COMMANDS + $ $0 $@ + +on `(hostname || uname -n) 2>/dev/null | sed 1q` +" + +# Files that config.status was made for. +config_files=" Makefile lib/Makefile lib/libconfig.pc lib/libconfig++.pc doc/Makefile examples/Makefile examples/c/Makefile examples/c++/Makefile tinytest/Makefile tests/Makefile libconfig.spec" +config_headers=" ac_config.h" +config_commands=" depfiles libtool" + +ac_cs_usage="\ +\`$as_me' instantiates files and other configuration actions +from templates according to the current configuration. Unless the files +and actions are specified as TAGs, all are instantiated by default. + +Usage: $0 [OPTION]... [TAG]... + + -h, --help print this help, then exit + -V, --version print version number and configuration settings, then exit + --config print configuration, then exit + -q, --quiet, --silent + do not print progress messages + -d, --debug don't remove temporary files + --recheck update $as_me by reconfiguring in the same conditions + --file=FILE[:TEMPLATE] + instantiate the configuration file FILE + --header=FILE[:TEMPLATE] + instantiate the configuration header FILE + +Configuration files: +$config_files + +Configuration headers: +$config_headers + +Configuration commands: +$config_commands + +Report bugs to . +libconfig home page: ." + +ac_cs_config="'--disable-cxx'" +ac_cs_version="\ +libconfig config.status 1.4.9 +configured by ./configure, generated by GNU Autoconf 2.68, + with options \"$ac_cs_config\" + +Copyright (C) 2010 Free Software Foundation, Inc. +This config.status script is free software; the Free Software Foundation +gives unlimited permission to copy, distribute and modify it." + +ac_pwd='/ufs/greta/zomer/pharcos/libconfig-1.4.9' +srcdir='.' +INSTALL='/usr/bin/install -c' +MKDIR_P='/usr/bin/mkdir -p' +AWK='gawk' +test -n "$AWK" || AWK=awk +# The default lists apply if the user does not specify any file. +ac_need_defaults=: +while test $# != 0 +do + case $1 in + --*=?*) + ac_option=`expr "X$1" : 'X\([^=]*\)='` + ac_optarg=`expr "X$1" : 'X[^=]*=\(.*\)'` + ac_shift=: + ;; + --*=) + ac_option=`expr "X$1" : 'X\([^=]*\)='` + ac_optarg= + ac_shift=: + ;; + *) + ac_option=$1 + ac_optarg=$2 + ac_shift=shift + ;; + esac + + case $ac_option in + # Handling of the options. + -recheck | --recheck | --rechec | --reche | --rech | --rec | --re | --r) + ac_cs_recheck=: ;; + --version | --versio | --versi | --vers | --ver | --ve | --v | -V ) + $as_echo "$ac_cs_version"; exit ;; + --config | --confi | --conf | --con | --co | --c ) + $as_echo "$ac_cs_config"; exit ;; + --debug | --debu | --deb | --de | --d | -d ) + debug=: ;; + --file | --fil | --fi | --f ) + $ac_shift + case $ac_optarg in + *\'*) ac_optarg=`$as_echo "$ac_optarg" | sed "s/'/'\\\\\\\\''/g"` ;; + '') as_fn_error $? "missing file argument" ;; + esac + as_fn_append CONFIG_FILES " '$ac_optarg'" + ac_need_defaults=false;; + --header | --heade | --head | --hea ) + $ac_shift + case $ac_optarg in + *\'*) ac_optarg=`$as_echo "$ac_optarg" | sed "s/'/'\\\\\\\\''/g"` ;; + esac + as_fn_append CONFIG_HEADERS " '$ac_optarg'" + ac_need_defaults=false;; + --he | --h) + # Conflict between --help and --header + as_fn_error $? "ambiguous option: \`$1' +Try \`$0 --help' for more information.";; + --help | --hel | -h ) + $as_echo "$ac_cs_usage"; exit ;; + -q | -quiet | --quiet | --quie | --qui | --qu | --q \ + | -silent | --silent | --silen | --sile | --sil | --si | --s) + ac_cs_silent=: ;; + + # This is an error. + -*) as_fn_error $? "unrecognized option: \`$1' +Try \`$0 --help' for more information." ;; + + *) as_fn_append ac_config_targets " $1" + ac_need_defaults=false ;; + + esac + shift +done + +ac_configure_extra_args= + +if $ac_cs_silent; then + exec 6>/dev/null + ac_configure_extra_args="$ac_configure_extra_args --silent" +fi + +if $ac_cs_recheck; then + set X '/bin/sh' './configure' '--disable-cxx' $ac_configure_extra_args --no-create --no-recursion + shift + $as_echo "running CONFIG_SHELL=/bin/sh $*" >&6 + CONFIG_SHELL='/bin/sh' + export CONFIG_SHELL + exec "$@" +fi + +exec 5>>config.log +{ + echo + sed 'h;s/./-/g;s/^.../## /;s/...$/ ##/;p;x;p;x' <<_ASBOX +## Running $as_me. ## +_ASBOX + $as_echo "$ac_log" +} >&5 + +# +# INIT-COMMANDS +# +AMDEP_TRUE="" ac_aux_dir="aux-build" + + +# The HP-UX ksh and POSIX shell print the target directory to stdout +# if CDPATH is set. +(unset CDPATH) >/dev/null 2>&1 && unset CDPATH + +sed_quote_subst='s/\(["`$\\]\)/\\\1/g' +double_quote_subst='s/\(["`\\]\)/\\\1/g' +delay_variable_subst='s/\\\\\\\\\\\$/\\\\\\$/g' +macro_version='2.4.2' +macro_revision='1.3337' +enable_shared='yes' +enable_static='yes' +pic_mode='default' +enable_fast_install='yes' +SHELL='/bin/sh' +ECHO='printf %s\n' +PATH_SEPARATOR=':' +host_alias='' +host='x86_64-unknown-linux-gnu' +host_os='linux-gnu' +build_alias='' +build='x86_64-unknown-linux-gnu' +build_os='linux-gnu' +SED='/usr/bin/sed' +Xsed='/usr/bin/sed -e 1s/^X//' +GREP='/usr/bin/grep' +EGREP='/usr/bin/grep -E' +FGREP='/usr/bin/grep -F' +LD='/usr/bin/ld -m elf_x86_64' +NM='/usr/bin/nm -B' +LN_S='ln -s' +max_cmd_len='1572864' +ac_objext='o' +exeext='' +lt_unset='unset' +lt_SP2NL='tr \040 \012' +lt_NL2SP='tr \015\012 \040\040' +lt_cv_to_host_file_cmd='func_convert_file_noop' +lt_cv_to_tool_file_cmd='func_convert_file_noop' +reload_flag=' -r' +reload_cmds='$LD$reload_flag -o $output$reload_objs' +OBJDUMP='objdump' +deplibs_check_method='pass_all' +file_magic_cmd='$MAGIC_CMD' +file_magic_glob='' +want_nocaseglob='no' +DLLTOOL='false' +sharedlib_from_linklib_cmd='printf %s\n' +AR='ar' +AR_FLAGS='cru' +archiver_list_spec='@' +STRIP='strip' +RANLIB='ranlib' +old_postinstall_cmds='chmod 644 $oldlib~$RANLIB $tool_oldlib' +old_postuninstall_cmds='' +old_archive_cmds='$AR $AR_FLAGS $oldlib$oldobjs~$RANLIB $tool_oldlib' +lock_old_archive_extraction='no' +CC='gcc' +CFLAGS='-g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter' +compiler='g++' +GCC='yes' +lt_cv_sys_global_symbol_pipe='sed -n -e '\''s/^.*[ ]\([ABCDGIRSTW][ABCDGIRSTW]*\)[ ][ ]*\([_A-Za-z][_A-Za-z0-9]*\)$/\1 \2 \2/p'\'' | sed '\''/ __gnu_lto/d'\''' +lt_cv_sys_global_symbol_to_cdecl='sed -n -e '\''s/^T .* \(.*\)$/extern int \1();/p'\'' -e '\''s/^[ABCDGIRSTW]* .* \(.*\)$/extern char \1;/p'\''' +lt_cv_sys_global_symbol_to_c_name_address='sed -n -e '\''s/^: \([^ ]*\)[ ]*$/ {\"\1\", (void *) 0},/p'\'' -e '\''s/^[ABCDGIRSTW]* \([^ ]*\) \([^ ]*\)$/ {"\2", (void *) \&\2},/p'\''' +lt_cv_sys_global_symbol_to_c_name_address_lib_prefix='sed -n -e '\''s/^: \([^ ]*\)[ ]*$/ {\"\1\", (void *) 0},/p'\'' -e '\''s/^[ABCDGIRSTW]* \([^ ]*\) \(lib[^ ]*\)$/ {"\2", (void *) \&\2},/p'\'' -e '\''s/^[ABCDGIRSTW]* \([^ ]*\) \([^ ]*\)$/ {"lib\2", (void *) \&\2},/p'\''' +nm_file_list_spec='@' +lt_sysroot='' +objdir='.libs' +MAGIC_CMD='file' +lt_prog_compiler_no_builtin_flag=' -fno-builtin' +lt_prog_compiler_pic=' -fPIC -DPIC' +lt_prog_compiler_wl='-Wl,' +lt_prog_compiler_static='-static' +lt_cv_prog_compiler_c_o='yes' +need_locks='no' +MANIFEST_TOOL=':' +DSYMUTIL='' +NMEDIT='' +LIPO='' +OTOOL='' +OTOOL64='' +libext='a' +shrext_cmds='.so' +extract_expsyms_cmds='' +archive_cmds_need_lc='no' +enable_shared_with_static_runtimes='no' +export_dynamic_flag_spec='${wl}--export-dynamic' +whole_archive_flag_spec='${wl}--whole-archive$convenience ${wl}--no-whole-archive' +compiler_needs_object='no' +old_archive_from_new_cmds='' +old_archive_from_expsyms_cmds='' +archive_cmds='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' +archive_expsym_cmds='echo "{ global:" > $output_objdir/$libname.ver~ + cat $export_symbols | sed -e "s/\(.*\)/\1;/" >> $output_objdir/$libname.ver~ + echo "local: *; };" >> $output_objdir/$libname.ver~ + $CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-version-script ${wl}$output_objdir/$libname.ver -o $lib' +module_cmds='' +module_expsym_cmds='' +with_gnu_ld='yes' +allow_undefined_flag='' +no_undefined_flag='' +hardcode_libdir_flag_spec='${wl}-rpath ${wl}$libdir' +hardcode_libdir_separator='' +hardcode_direct='no' +hardcode_direct_absolute='no' +hardcode_minus_L='no' +hardcode_shlibpath_var='unsupported' +hardcode_automatic='no' +inherit_rpath='no' +link_all_deplibs='unknown' +always_export_symbols='no' +export_symbols_cmds='$NM $libobjs $convenience | $global_symbol_pipe | $SED '\''s/.* //'\'' | sort | uniq > $export_symbols' +exclude_expsyms='_GLOBAL_OFFSET_TABLE_|_GLOBAL__F[ID]_.*' +include_expsyms='' +prelink_cmds='' +postlink_cmds='' +file_list_spec='' +variables_saved_for_relink='PATH LD_LIBRARY_PATH LD_RUN_PATH GCC_EXEC_PREFIX COMPILER_PATH LIBRARY_PATH' +need_lib_prefix='no' +need_version='no' +version_type='linux' +runpath_var='LD_RUN_PATH' +shlibpath_var='LD_LIBRARY_PATH' +shlibpath_overrides_runpath='no' +libname_spec='lib$name' +library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' +soname_spec='${libname}${release}${shared_ext}$major' +install_override_mode='' +postinstall_cmds='' +postuninstall_cmds='' +finish_cmds='PATH="\$PATH:/sbin" ldconfig -n $libdir' +finish_eval='' +hardcode_into_libs='yes' +sys_lib_search_path_spec='/usr/lib/gcc/x86_64-redhat-linux/4.8.3 /usr/lib64 /lib64 ' +sys_lib_dlsearch_path_spec='/lib /usr/lib /usr/lib64/R/lib /usr/lib64/atlas /usr/lib64/dyninst /usr/lib64/iscsi /usr/lib64/llvm /usr/lib64/mysql /usr/lib64/octave/3.6.4 /usr/lib/qt-3.3/lib /usr/lib64/qt-3.3/lib /usr/lib64/root /usr/lib64/tcl8.5/tclx8.4 /usr/lib64/tcl8.5 /usr/lib64/tracker-0.16 ' +hardcode_action='immediate' +enable_dlopen='unknown' +enable_dlopen_self='unknown' +enable_dlopen_self_static='unknown' +old_striplib='strip --strip-debug' +striplib='strip --strip-unneeded' +compiler_lib_search_dirs='' +predep_objects='' +postdep_objects='' +predeps='' +postdeps='' +compiler_lib_search_path='' +AS='as' +LD_CXX='/usr/bin/ld -m elf_x86_64' +reload_flag_CXX=' -r' +reload_cmds_CXX='$LD$reload_flag -o $output$reload_objs' +old_archive_cmds_CXX='$AR $AR_FLAGS $oldlib$oldobjs~$RANLIB $tool_oldlib' +compiler_CXX='g++' +GCC_CXX='yes' +lt_prog_compiler_no_builtin_flag_CXX=' -fno-builtin' +lt_prog_compiler_pic_CXX=' -fPIC -DPIC' +lt_prog_compiler_wl_CXX='-Wl,' +lt_prog_compiler_static_CXX='' +lt_cv_prog_compiler_c_o_CXX='yes' +archive_cmds_need_lc_CXX='no' +enable_shared_with_static_runtimes_CXX='no' +export_dynamic_flag_spec_CXX='${wl}--export-dynamic' +whole_archive_flag_spec_CXX='${wl}--whole-archive$convenience ${wl}--no-whole-archive' +compiler_needs_object_CXX='no' +old_archive_from_new_cmds_CXX='' +old_archive_from_expsyms_cmds_CXX='' +archive_cmds_CXX='$CC $pic_flag -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname -o $lib' +archive_expsym_cmds_CXX='$CC $pic_flag -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' +module_cmds_CXX='' +module_expsym_cmds_CXX='' +with_gnu_ld_CXX='yes' +allow_undefined_flag_CXX='' +no_undefined_flag_CXX='' +hardcode_libdir_flag_spec_CXX='${wl}-rpath ${wl}$libdir' +hardcode_libdir_separator_CXX='' +hardcode_direct_CXX='no' +hardcode_direct_absolute_CXX='no' +hardcode_minus_L_CXX='no' +hardcode_shlibpath_var_CXX='unsupported' +hardcode_automatic_CXX='no' +inherit_rpath_CXX='no' +link_all_deplibs_CXX='unknown' +always_export_symbols_CXX='no' +export_symbols_cmds_CXX='$NM $libobjs $convenience | $global_symbol_pipe | $SED '\''s/.* //'\'' | sort | uniq > $export_symbols' +exclude_expsyms_CXX='_GLOBAL_OFFSET_TABLE_|_GLOBAL__F[ID]_.*' +include_expsyms_CXX='' +prelink_cmds_CXX='' +postlink_cmds_CXX='' +file_list_spec_CXX='' +hardcode_action_CXX='immediate' +compiler_lib_search_dirs_CXX='/usr/lib/gcc/x86_64-redhat-linux/4.8.3 /usr/lib/gcc/x86_64-redhat-linux/4.8.3/../../../../lib64 /lib/../lib64 /usr/lib/../lib64 /usr/lib/gcc/x86_64-redhat-linux/4.8.3/../../..' +predep_objects_CXX='/usr/lib/gcc/x86_64-redhat-linux/4.8.3/../../../../lib64/crti.o /usr/lib/gcc/x86_64-redhat-linux/4.8.3/crtbeginS.o' +postdep_objects_CXX='/usr/lib/gcc/x86_64-redhat-linux/4.8.3/crtendS.o /usr/lib/gcc/x86_64-redhat-linux/4.8.3/../../../../lib64/crtn.o' +predeps_CXX='' +postdeps_CXX='-lstdc++ -lm -lgcc_s -lc -lgcc_s' +compiler_lib_search_path_CXX='-L/usr/lib/gcc/x86_64-redhat-linux/4.8.3 -L/usr/lib/gcc/x86_64-redhat-linux/4.8.3/../../../../lib64 -L/lib/../lib64 -L/usr/lib/../lib64 -L/usr/lib/gcc/x86_64-redhat-linux/4.8.3/../../..' + +LTCC='gcc' +LTCFLAGS='-g -O2' +compiler='gcc' + +# A function that is used when there is no print builtin or printf. +func_fallback_echo () +{ + eval 'cat <<_LTECHO_EOF +$1 +_LTECHO_EOF' +} + +# Quote evaled strings. +for var in SHELL ECHO PATH_SEPARATOR SED GREP EGREP FGREP LD NM LN_S lt_SP2NL lt_NL2SP reload_flag OBJDUMP deplibs_check_method file_magic_cmd file_magic_glob want_nocaseglob DLLTOOL sharedlib_from_linklib_cmd AR AR_FLAGS archiver_list_spec STRIP RANLIB CC CFLAGS compiler lt_cv_sys_global_symbol_pipe lt_cv_sys_global_symbol_to_cdecl lt_cv_sys_global_symbol_to_c_name_address lt_cv_sys_global_symbol_to_c_name_address_lib_prefix nm_file_list_spec lt_prog_compiler_no_builtin_flag lt_prog_compiler_pic lt_prog_compiler_wl lt_prog_compiler_static lt_cv_prog_compiler_c_o need_locks MANIFEST_TOOL DSYMUTIL NMEDIT LIPO OTOOL OTOOL64 shrext_cmds export_dynamic_flag_spec whole_archive_flag_spec compiler_needs_object with_gnu_ld allow_undefined_flag no_undefined_flag hardcode_libdir_flag_spec hardcode_libdir_separator exclude_expsyms include_expsyms file_list_spec variables_saved_for_relink libname_spec library_names_spec soname_spec install_override_mode finish_eval old_striplib striplib compiler_lib_search_dirs predep_objects postdep_objects predeps postdeps compiler_lib_search_path AS LD_CXX reload_flag_CXX compiler_CXX lt_prog_compiler_no_builtin_flag_CXX lt_prog_compiler_pic_CXX lt_prog_compiler_wl_CXX lt_prog_compiler_static_CXX lt_cv_prog_compiler_c_o_CXX export_dynamic_flag_spec_CXX whole_archive_flag_spec_CXX compiler_needs_object_CXX with_gnu_ld_CXX allow_undefined_flag_CXX no_undefined_flag_CXX hardcode_libdir_flag_spec_CXX hardcode_libdir_separator_CXX exclude_expsyms_CXX include_expsyms_CXX file_list_spec_CXX compiler_lib_search_dirs_CXX predep_objects_CXX postdep_objects_CXX predeps_CXX postdeps_CXX compiler_lib_search_path_CXX; do + case `eval \\$ECHO \\""\\$$var"\\"` in + *[\\\`\"\$]*) + eval "lt_$var=\\\"\`\$ECHO \"\$$var\" | \$SED \"\$sed_quote_subst\"\`\\\"" + ;; + *) + eval "lt_$var=\\\"\$$var\\\"" + ;; + esac +done + +# Double-quote double-evaled strings. +for var in reload_cmds old_postinstall_cmds old_postuninstall_cmds old_archive_cmds extract_expsyms_cmds old_archive_from_new_cmds old_archive_from_expsyms_cmds archive_cmds archive_expsym_cmds module_cmds module_expsym_cmds export_symbols_cmds prelink_cmds postlink_cmds postinstall_cmds postuninstall_cmds finish_cmds sys_lib_search_path_spec sys_lib_dlsearch_path_spec reload_cmds_CXX old_archive_cmds_CXX old_archive_from_new_cmds_CXX old_archive_from_expsyms_cmds_CXX archive_cmds_CXX archive_expsym_cmds_CXX module_cmds_CXX module_expsym_cmds_CXX export_symbols_cmds_CXX prelink_cmds_CXX postlink_cmds_CXX; do + case `eval \\$ECHO \\""\\$$var"\\"` in + *[\\\`\"\$]*) + eval "lt_$var=\\\"\`\$ECHO \"\$$var\" | \$SED -e \"\$double_quote_subst\" -e \"\$sed_quote_subst\" -e \"\$delay_variable_subst\"\`\\\"" + ;; + *) + eval "lt_$var=\\\"\$$var\\\"" + ;; + esac +done + +ac_aux_dir='aux-build' +xsi_shell='yes' +lt_shell_append='yes' + +# See if we are running on zsh, and set the options which allow our +# commands through without removal of \ escapes INIT. +if test -n "${ZSH_VERSION+set}" ; then + setopt NO_GLOB_SUBST +fi + + + PACKAGE='libconfig' + VERSION='1.4.9' + TIMESTAMP='' + RM='rm -f' + ofile='libtool' + + + + + + + +# Handling of arguments. +for ac_config_target in $ac_config_targets +do + case $ac_config_target in + "ac_config.h") CONFIG_HEADERS="$CONFIG_HEADERS ac_config.h" ;; + "depfiles") CONFIG_COMMANDS="$CONFIG_COMMANDS depfiles" ;; + "libtool") CONFIG_COMMANDS="$CONFIG_COMMANDS libtool" ;; + "Makefile") CONFIG_FILES="$CONFIG_FILES Makefile" ;; + "lib/Makefile") CONFIG_FILES="$CONFIG_FILES lib/Makefile" ;; + "lib/libconfig.pc") CONFIG_FILES="$CONFIG_FILES lib/libconfig.pc" ;; + "lib/libconfig++.pc") CONFIG_FILES="$CONFIG_FILES lib/libconfig++.pc" ;; + "doc/Makefile") CONFIG_FILES="$CONFIG_FILES doc/Makefile" ;; + "examples/Makefile") CONFIG_FILES="$CONFIG_FILES examples/Makefile" ;; + "examples/c/Makefile") CONFIG_FILES="$CONFIG_FILES examples/c/Makefile" ;; + "examples/c++/Makefile") CONFIG_FILES="$CONFIG_FILES examples/c++/Makefile" ;; + "tinytest/Makefile") CONFIG_FILES="$CONFIG_FILES tinytest/Makefile" ;; + "tests/Makefile") CONFIG_FILES="$CONFIG_FILES tests/Makefile" ;; + "libconfig.spec") CONFIG_FILES="$CONFIG_FILES libconfig.spec" ;; + + *) as_fn_error $? "invalid argument: \`$ac_config_target'" "$LINENO" 5;; + esac +done + + +# If the user did not use the arguments to specify the items to instantiate, +# then the envvar interface is used. Set only those that are not. +# We use the long form for the default assignment because of an extremely +# bizarre bug on SunOS 4.1.3. +if $ac_need_defaults; then + test "${CONFIG_FILES+set}" = set || CONFIG_FILES=$config_files + test "${CONFIG_HEADERS+set}" = set || CONFIG_HEADERS=$config_headers + test "${CONFIG_COMMANDS+set}" = set || CONFIG_COMMANDS=$config_commands +fi + +# Have a temporary directory for convenience. Make it in the build tree +# simply because there is no reason against having it here, and in addition, +# creating and moving files from /tmp can sometimes cause problems. +# Hook for its removal unless debugging. +# Note that there is a small window in which the directory will not be cleaned: +# after its creation but before its name has been assigned to `$tmp'. +$debug || +{ + tmp= ac_tmp= + trap 'exit_status=$? + : "${ac_tmp:=$tmp}" + { test ! -d "$ac_tmp" || rm -fr "$ac_tmp"; } && exit $exit_status +' 0 + trap 'as_fn_exit 1' 1 2 13 15 +} +# Create a (secure) tmp directory for tmp files. + +{ + tmp=`(umask 077 && mktemp -d "./confXXXXXX") 2>/dev/null` && + test -d "$tmp" +} || +{ + tmp=./conf$$-$RANDOM + (umask 077 && mkdir "$tmp") +} || as_fn_error $? "cannot create a temporary directory in ." "$LINENO" 5 +ac_tmp=$tmp + +# Set up the scripts for CONFIG_FILES section. +# No need to generate them if there are no CONFIG_FILES. +# This happens for instance with `./config.status config.h'. +if test -n "$CONFIG_FILES"; then + + +ac_cr=`echo X | tr X '\015'` +# On cygwin, bash can eat \r inside `` if the user requested igncr. +# But we know of no other shell where ac_cr would be empty at this +# point, so we can use a bashism as a fallback. +if test "x$ac_cr" = x; then + eval ac_cr=\$\'\\r\' +fi +ac_cs_awk_cr=`$AWK 'BEGIN { print "a\rb" }' /dev/null` +if test "$ac_cs_awk_cr" = "a${ac_cr}b"; then + ac_cs_awk_cr='\\r' +else + ac_cs_awk_cr=$ac_cr +fi + +echo 'BEGIN {' >"$ac_tmp/subs1.awk" && +cat >>"$ac_tmp/subs1.awk" <<\_ACAWK && +S["am__EXEEXT_FALSE"]="" +S["am__EXEEXT_TRUE"]="#" +S["LTLIBOBJS"]="" +S["LIBOBJS"]="" +S["GNU_WIN_FALSE"]="" +S["GNU_WIN_TRUE"]="#" +S["BUILDEXAMPLES_FALSE"]="#" +S["BUILDEXAMPLES_TRUE"]="" +S["BUILDCXX_FALSE"]="" +S["BUILDCXX_TRUE"]="#" +S["YFLAGS"]="" +S["YACC"]="bison -y" +S["LEXLIB"]="" +S["LEX_OUTPUT_ROOT"]="lex.yy" +S["LEX"]="flex" +S["AS"]="as" +S["CXXCPP"]="g++ -E" +S["am__fastdepCXX_FALSE"]="#" +S["am__fastdepCXX_TRUE"]="" +S["CXXDEPMODE"]="depmode=gcc3" +S["ac_ct_CXX"]="g++" +S["CXXFLAGS"]="-g -O2 -Wall -Wshadow -Wextra -Wno-unused-parameter" +S["CXX"]="g++" +S["OTOOL64"]="" +S["OTOOL"]="" +S["LIPO"]="" +S["NMEDIT"]="" +S["DSYMUTIL"]="" +S["MANIFEST_TOOL"]=":" +S["RANLIB"]="ranlib" +S["ac_ct_AR"]="ar" +S["AR"]="ar" +S["DLLTOOL"]="false" +S["OBJDUMP"]="objdump" +S["LN_S"]="ln -s" +S["NM"]="/usr/bin/nm -B" +S["ac_ct_DUMPBIN"]="" +S["DUMPBIN"]="" +S["LD"]="/usr/bin/ld -m elf_x86_64" +S["FGREP"]="/usr/bin/grep -F" +S["SED"]="/usr/bin/sed" +S["LIBTOOL"]="$(SHELL) $(top_builddir)/libtool" +S["EGREP"]="/usr/bin/grep -E" +S["GREP"]="/usr/bin/grep" +S["CPP"]="gcc -E" +S["am__fastdepCC_FALSE"]="#" +S["am__fastdepCC_TRUE"]="" +S["CCDEPMODE"]="depmode=gcc3" +S["AMDEPBACKSLASH"]="\\" +S["AMDEP_FALSE"]="#" +S["AMDEP_TRUE"]="" +S["am__quote"]="" +S["am__include"]="include" +S["DEPDIR"]=".deps" +S["OBJEXT"]="o" +S["EXEEXT"]="" +S["ac_ct_CC"]="gcc" +S["CPPFLAGS"]="" +S["LDFLAGS"]="" +S["CFLAGS"]="-g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter" +S["CC"]="gcc" +S["am__untar"]="${AMTAR} xf -" +S["am__tar"]="${AMTAR} chof - \"$$tardir\"" +S["AMTAR"]="${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run tar" +S["am__leading_dot"]="." +S["SET_MAKE"]="" +S["AWK"]="gawk" +S["mkdir_p"]="/usr/bin/mkdir -p" +S["MKDIR_P"]="/usr/bin/mkdir -p" +S["INSTALL_STRIP_PROGRAM"]="$(install_sh) -c -s" +S["STRIP"]="strip" +S["install_sh"]="${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/install-sh" +S["MAKEINFO"]="${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run makeinfo" +S["AUTOHEADER"]="${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoheader" +S["AUTOMAKE"]="${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run automake-1.11" +S["AUTOCONF"]="${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoconf" +S["ACLOCAL"]="${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run aclocal-1.11" +S["VERSION"]="1.4.9" +S["PACKAGE"]="libconfig" +S["CYGPATH_W"]="echo" +S["am__isrc"]="" +S["INSTALL_DATA"]="${INSTALL} -m 644" +S["INSTALL_SCRIPT"]="${INSTALL}" +S["INSTALL_PROGRAM"]="${INSTALL}" +S["target_os"]="linux-gnu" +S["target_vendor"]="unknown" +S["target_cpu"]="x86_64" +S["target"]="x86_64-unknown-linux-gnu" +S["host_os"]="linux-gnu" +S["host_vendor"]="unknown" +S["host_cpu"]="x86_64" +S["host"]="x86_64-unknown-linux-gnu" +S["build_os"]="linux-gnu" +S["build_vendor"]="unknown" +S["build_cpu"]="x86_64" +S["build"]="x86_64-unknown-linux-gnu" +S["target_alias"]="" +S["host_alias"]="" +S["build_alias"]="" +S["LIBS"]="" +S["ECHO_T"]="" +S["ECHO_N"]="-n" +S["ECHO_C"]="" +S["DEFS"]="-DHAVE_CONFIG_H" +S["mandir"]="${datarootdir}/man" +S["localedir"]="${datarootdir}/locale" +S["libdir"]="${exec_prefix}/lib" +S["psdir"]="${docdir}" +S["pdfdir"]="${docdir}" +S["dvidir"]="${docdir}" +S["htmldir"]="${docdir}" +S["infodir"]="${datarootdir}/info" +S["docdir"]="${datarootdir}/doc/${PACKAGE_TARNAME}" +S["oldincludedir"]="/usr/include" +S["includedir"]="${prefix}/include" +S["localstatedir"]="${prefix}/var" +S["sharedstatedir"]="${prefix}/com" +S["sysconfdir"]="${prefix}/etc" +S["datadir"]="${datarootdir}" +S["datarootdir"]="${prefix}/share" +S["libexecdir"]="${exec_prefix}/libexec" +S["sbindir"]="${exec_prefix}/sbin" +S["bindir"]="${exec_prefix}/bin" +S["program_transform_name"]="s,x,x," +S["prefix"]="/usr/local" +S["exec_prefix"]="${prefix}" +S["PACKAGE_URL"]="http://www.hyperrealm.com/main.php?s=libconfig" +S["PACKAGE_BUGREPORT"]="hyperrealm@gmail.com" +S["PACKAGE_STRING"]="libconfig 1.4.9" +S["PACKAGE_VERSION"]="1.4.9" +S["PACKAGE_TARNAME"]="libconfig" +S["PACKAGE_NAME"]="libconfig" +S["PATH_SEPARATOR"]=":" +S["SHELL"]="/bin/sh" +_ACAWK +cat >>"$ac_tmp/subs1.awk" <<_ACAWK && + for (key in S) S_is_set[key] = 1 + FS = "" + +} +{ + line = $ 0 + nfields = split(line, field, "@") + substed = 0 + len = length(field[1]) + for (i = 2; i < nfields; i++) { + key = field[i] + keylen = length(key) + if (S_is_set[key]) { + value = S[key] + line = substr(line, 1, len) "" value "" substr(line, len + keylen + 3) + len += length(value) + length(field[++i]) + substed = 1 + } else + len += 1 + keylen + } + + print line +} + +_ACAWK +if sed "s/$ac_cr//" < /dev/null > /dev/null 2>&1; then + sed "s/$ac_cr\$//; s/$ac_cr/$ac_cs_awk_cr/g" +else + cat +fi < "$ac_tmp/subs1.awk" > "$ac_tmp/subs.awk" \ + || as_fn_error $? "could not setup config files machinery" "$LINENO" 5 +fi # test -n "$CONFIG_FILES" + +# Set up the scripts for CONFIG_HEADERS section. +# No need to generate them if there are no CONFIG_HEADERS. +# This happens for instance with `./config.status Makefile'. +if test -n "$CONFIG_HEADERS"; then +cat >"$ac_tmp/defines.awk" <<\_ACAWK || +BEGIN { +D["PACKAGE_NAME"]=" \"libconfig\"" +D["PACKAGE_TARNAME"]=" \"libconfig\"" +D["PACKAGE_VERSION"]=" \"1.4.9\"" +D["PACKAGE_STRING"]=" \"libconfig 1.4.9\"" +D["PACKAGE_BUGREPORT"]=" \"hyperrealm@gmail.com\"" +D["PACKAGE_URL"]=" \"http://www.hyperrealm.com/main.php?s=libconfig\"" +D["PACKAGE"]=" \"libconfig\"" +D["VERSION"]=" \"1.4.9\"" +D["TARGET"]=" \"x86_64-unknown-linux-gnu\"" +D["STDC_HEADERS"]=" 1" +D["HAVE_SYS_TYPES_H"]=" 1" +D["HAVE_SYS_STAT_H"]=" 1" +D["HAVE_STDLIB_H"]=" 1" +D["HAVE_STRING_H"]=" 1" +D["HAVE_MEMORY_H"]=" 1" +D["HAVE_STRINGS_H"]=" 1" +D["HAVE_INTTYPES_H"]=" 1" +D["HAVE_STDINT_H"]=" 1" +D["HAVE_UNISTD_H"]=" 1" +D["__EXTENSIONS__"]=" 1" +D["_ALL_SOURCE"]=" 1" +D["_GNU_SOURCE"]=" 1" +D["_POSIX_PTHREAD_SEMANTICS"]=" 1" +D["_TANDEM_SOURCE"]=" 1" +D["HAVE_DLFCN_H"]=" 1" +D["LT_OBJDIR"]=" \".libs/\"" +D["STDC_HEADERS"]=" 1" +D["HAVE_UNISTD_H"]=" 1" +D["HAVE_STDINT_H"]=" 1" +D["HAVE_XLOCALE_H"]=" 1" +D["HAVE_NEWLOCALE"]=" 1" +D["HAVE_USELOCALE"]=" 1" +D["HAVE_FREELOCALE"]=" 1" + for (key in D) D_is_set[key] = 1 + FS = "" +} +/^[\t ]*#[\t ]*(define|undef)[\t ]+[_abcdefghijklmnopqrstuvwxyzABCDEFGHIJKLMNOPQRSTUVWXYZ][_abcdefghijklmnopqrstuvwxyzABCDEFGHIJKLMNOPQRSTUVWXYZ0123456789]*([\t (]|$)/ { + line = $ 0 + split(line, arg, " ") + if (arg[1] == "#") { + defundef = arg[2] + mac1 = arg[3] + } else { + defundef = substr(arg[1], 2) + mac1 = arg[2] + } + split(mac1, mac2, "(") #) + macro = mac2[1] + prefix = substr(line, 1, index(line, defundef) - 1) + if (D_is_set[macro]) { + # Preserve the white space surrounding the "#". + print prefix "define", macro P[macro] D[macro] + next + } else { + # Replace #undef with comments. This is necessary, for example, + # in the case of _POSIX_SOURCE, which is predefined and required + # on some systems where configure will not decide to define it. + if (defundef == "undef") { + print "/*", prefix defundef, macro, "*/" + next + } + } +} +{ print } +_ACAWK + as_fn_error $? "could not setup config headers machinery" "$LINENO" 5 +fi # test -n "$CONFIG_HEADERS" + + +eval set X " :F $CONFIG_FILES :H $CONFIG_HEADERS :C $CONFIG_COMMANDS" +shift +for ac_tag +do + case $ac_tag in + :[FHLC]) ac_mode=$ac_tag; continue;; + esac + case $ac_mode$ac_tag in + :[FHL]*:*);; + :L* | :C*:*) as_fn_error $? "invalid tag \`$ac_tag'" "$LINENO" 5;; + :[FH]-) ac_tag=-:-;; + :[FH]*) ac_tag=$ac_tag:$ac_tag.in;; + esac + ac_save_IFS=$IFS + IFS=: + set x $ac_tag + IFS=$ac_save_IFS + shift + ac_file=$1 + shift + + case $ac_mode in + :L) ac_source=$1;; + :[FH]) + ac_file_inputs= + for ac_f + do + case $ac_f in + -) ac_f="$ac_tmp/stdin";; + *) # Look for the file first in the build tree, then in the source tree + # (if the path is not absolute). The absolute path cannot be DOS-style, + # because $ac_f cannot contain `:'. + test -f "$ac_f" || + case $ac_f in + [\\/$]*) false;; + *) test -f "$srcdir/$ac_f" && ac_f="$srcdir/$ac_f";; + esac || + as_fn_error 1 "cannot find input file: \`$ac_f'" "$LINENO" 5;; + esac + case $ac_f in *\'*) ac_f=`$as_echo "$ac_f" | sed "s/'/'\\\\\\\\''/g"`;; esac + as_fn_append ac_file_inputs " '$ac_f'" + done + + # Let's still pretend it is `configure' which instantiates (i.e., don't + # use $as_me), people would be surprised to read: + # /* config.h. Generated by config.status. */ + configure_input='Generated from '` + $as_echo "$*" | sed 's|^[^:]*/||;s|:[^:]*/|, |g' + `' by configure.' + if test x"$ac_file" != x-; then + configure_input="$ac_file. $configure_input" + { $as_echo "$as_me:${as_lineno-$LINENO}: creating $ac_file" >&5 +$as_echo "$as_me: creating $ac_file" >&6;} + fi + # Neutralize special characters interpreted by sed in replacement strings. + case $configure_input in #( + *\&* | *\|* | *\\* ) + ac_sed_conf_input=`$as_echo "$configure_input" | + sed 's/[\\\\&|]/\\\\&/g'`;; #( + *) ac_sed_conf_input=$configure_input;; + esac + + case $ac_tag in + *:-:* | *:-) cat >"$ac_tmp/stdin" \ + || as_fn_error $? "could not create $ac_file" "$LINENO" 5 ;; + esac + ;; + esac + + ac_dir=`$as_dirname -- "$ac_file" || +$as_expr X"$ac_file" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ + X"$ac_file" : 'X\(//\)[^/]' \| \ + X"$ac_file" : 'X\(//\)$' \| \ + X"$ac_file" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X"$ac_file" | + sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ + s//\1/ + q + } + /^X\(\/\/\)[^/].*/{ + s//\1/ + q + } + /^X\(\/\/\)$/{ + s//\1/ + q + } + /^X\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'` + as_dir="$ac_dir"; as_fn_mkdir_p + ac_builddir=. + +case "$ac_dir" in +.) ac_dir_suffix= ac_top_builddir_sub=. ac_top_build_prefix= ;; +*) + ac_dir_suffix=/`$as_echo "$ac_dir" | sed 's|^\.[\\/]||'` + # A ".." for each directory in $ac_dir_suffix. + ac_top_builddir_sub=`$as_echo "$ac_dir_suffix" | sed 's|/[^\\/]*|/..|g;s|/||'` + case $ac_top_builddir_sub in + "") ac_top_builddir_sub=. ac_top_build_prefix= ;; + *) ac_top_build_prefix=$ac_top_builddir_sub/ ;; + esac ;; +esac +ac_abs_top_builddir=$ac_pwd +ac_abs_builddir=$ac_pwd$ac_dir_suffix +# for backward compatibility: +ac_top_builddir=$ac_top_build_prefix + +case $srcdir in + .) # We are building in place. + ac_srcdir=. + ac_top_srcdir=$ac_top_builddir_sub + ac_abs_top_srcdir=$ac_pwd ;; + [\\/]* | ?:[\\/]* ) # Absolute name. + ac_srcdir=$srcdir$ac_dir_suffix; + ac_top_srcdir=$srcdir + ac_abs_top_srcdir=$srcdir ;; + *) # Relative name. + ac_srcdir=$ac_top_build_prefix$srcdir$ac_dir_suffix + ac_top_srcdir=$ac_top_build_prefix$srcdir + ac_abs_top_srcdir=$ac_pwd/$srcdir ;; +esac +ac_abs_srcdir=$ac_abs_top_srcdir$ac_dir_suffix + + + case $ac_mode in + :F) + # + # CONFIG_FILE + # + + case $INSTALL in + [\\/$]* | ?:[\\/]* ) ac_INSTALL=$INSTALL ;; + *) ac_INSTALL=$ac_top_build_prefix$INSTALL ;; + esac + ac_MKDIR_P=$MKDIR_P + case $MKDIR_P in + [\\/$]* | ?:[\\/]* ) ;; + */*) ac_MKDIR_P=$ac_top_build_prefix$MKDIR_P ;; + esac +# If the template does not know about datarootdir, expand it. +# FIXME: This hack should be removed a few years after 2.60. +ac_datarootdir_hack=; ac_datarootdir_seen= +ac_sed_dataroot=' +/datarootdir/ { + p + q +} +/@datadir@/p +/@docdir@/p +/@infodir@/p +/@localedir@/p +/@mandir@/p' +case `eval "sed -n \"\$ac_sed_dataroot\" $ac_file_inputs"` in +*datarootdir*) ac_datarootdir_seen=yes;; +*@datadir@*|*@docdir@*|*@infodir@*|*@localedir@*|*@mandir@*) + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $ac_file_inputs seems to ignore the --datarootdir setting" >&5 +$as_echo "$as_me: WARNING: $ac_file_inputs seems to ignore the --datarootdir setting" >&2;} + ac_datarootdir_hack=' + s&@datadir@&${datarootdir}&g + s&@docdir@&${datarootdir}/doc/${PACKAGE_TARNAME}&g + s&@infodir@&${datarootdir}/info&g + s&@localedir@&${datarootdir}/locale&g + s&@mandir@&${datarootdir}/man&g + s&\${datarootdir}&${prefix}/share&g' ;; +esac +ac_sed_extra="/^[ ]*VPATH[ ]*=[ ]*/{ +h +s/// +s/^/:/ +s/[ ]*$/:/ +s/:\$(srcdir):/:/g +s/:\${srcdir}:/:/g +s/:@srcdir@:/:/g +s/^:*// +s/:*$// +x +s/\(=[ ]*\).*/\1/ +G +s/\n// +s/^[^=]*=[ ]*$// +} + +:t +/@[a-zA-Z_][a-zA-Z_0-9]*@/!b +s|@configure_input@|$ac_sed_conf_input|;t t +s&@top_builddir@&$ac_top_builddir_sub&;t t +s&@top_build_prefix@&$ac_top_build_prefix&;t t +s&@srcdir@&$ac_srcdir&;t t +s&@abs_srcdir@&$ac_abs_srcdir&;t t +s&@top_srcdir@&$ac_top_srcdir&;t t +s&@abs_top_srcdir@&$ac_abs_top_srcdir&;t t +s&@builddir@&$ac_builddir&;t t +s&@abs_builddir@&$ac_abs_builddir&;t t +s&@abs_top_builddir@&$ac_abs_top_builddir&;t t +s&@INSTALL@&$ac_INSTALL&;t t +s&@MKDIR_P@&$ac_MKDIR_P&;t t +$ac_datarootdir_hack +" +eval sed \"\$ac_sed_extra\" "$ac_file_inputs" | $AWK -f "$ac_tmp/subs.awk" \ + >$ac_tmp/out || as_fn_error $? "could not create $ac_file" "$LINENO" 5 + +test -z "$ac_datarootdir_hack$ac_datarootdir_seen" && + { ac_out=`sed -n '/\${datarootdir}/p' "$ac_tmp/out"`; test -n "$ac_out"; } && + { ac_out=`sed -n '/^[ ]*datarootdir[ ]*:*=/p' \ + "$ac_tmp/out"`; test -z "$ac_out"; } && + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $ac_file contains a reference to the variable \`datarootdir' +which seems to be undefined. Please make sure it is defined" >&5 +$as_echo "$as_me: WARNING: $ac_file contains a reference to the variable \`datarootdir' +which seems to be undefined. Please make sure it is defined" >&2;} + + rm -f "$ac_tmp/stdin" + case $ac_file in + -) cat "$ac_tmp/out" && rm -f "$ac_tmp/out";; + *) rm -f "$ac_file" && mv "$ac_tmp/out" "$ac_file";; + esac \ + || as_fn_error $? "could not create $ac_file" "$LINENO" 5 + ;; + :H) + # + # CONFIG_HEADER + # + if test x"$ac_file" != x-; then + { + $as_echo "/* $configure_input */" \ + && eval '$AWK -f "$ac_tmp/defines.awk"' "$ac_file_inputs" + } >"$ac_tmp/config.h" \ + || as_fn_error $? "could not create $ac_file" "$LINENO" 5 + if diff "$ac_file" "$ac_tmp/config.h" >/dev/null 2>&1; then + { $as_echo "$as_me:${as_lineno-$LINENO}: $ac_file is unchanged" >&5 +$as_echo "$as_me: $ac_file is unchanged" >&6;} + else + rm -f "$ac_file" + mv "$ac_tmp/config.h" "$ac_file" \ + || as_fn_error $? "could not create $ac_file" "$LINENO" 5 + fi + else + $as_echo "/* $configure_input */" \ + && eval '$AWK -f "$ac_tmp/defines.awk"' "$ac_file_inputs" \ + || as_fn_error $? "could not create -" "$LINENO" 5 + fi +# Compute "$ac_file"'s index in $config_headers. +_am_arg="$ac_file" +_am_stamp_count=1 +for _am_header in $config_headers :; do + case $_am_header in + $_am_arg | $_am_arg:* ) + break ;; + * ) + _am_stamp_count=`expr $_am_stamp_count + 1` ;; + esac +done +echo "timestamp for $_am_arg" >`$as_dirname -- "$_am_arg" || +$as_expr X"$_am_arg" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ + X"$_am_arg" : 'X\(//\)[^/]' \| \ + X"$_am_arg" : 'X\(//\)$' \| \ + X"$_am_arg" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X"$_am_arg" | + sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ + s//\1/ + q + } + /^X\(\/\/\)[^/].*/{ + s//\1/ + q + } + /^X\(\/\/\)$/{ + s//\1/ + q + } + /^X\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'`/stamp-h$_am_stamp_count + ;; + + :C) { $as_echo "$as_me:${as_lineno-$LINENO}: executing $ac_file commands" >&5 +$as_echo "$as_me: executing $ac_file commands" >&6;} + ;; + esac + + + case $ac_file$ac_mode in + "depfiles":C) test x"$AMDEP_TRUE" != x"" || { + # Autoconf 2.62 quotes --file arguments for eval, but not when files + # are listed without --file. Let's play safe and only enable the eval + # if we detect the quoting. + case $CONFIG_FILES in + *\'*) eval set x "$CONFIG_FILES" ;; + *) set x $CONFIG_FILES ;; + esac + shift + for mf + do + # Strip MF so we end up with the name of the file. + mf=`echo "$mf" | sed -e 's/:.*$//'` + # Check whether this is an Automake generated Makefile or not. + # We used to match only the files named `Makefile.in', but + # some people rename them; so instead we look at the file content. + # Grep'ing the first line is not enough: some people post-process + # each Makefile.in and add a new line on top of each file to say so. + # Grep'ing the whole file is not good either: AIX grep has a line + # limit of 2048, but all sed's we know have understand at least 4000. + if sed -n 's,^#.*generated by automake.*,X,p' "$mf" | grep X >/dev/null 2>&1; then + dirpart=`$as_dirname -- "$mf" || +$as_expr X"$mf" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ + X"$mf" : 'X\(//\)[^/]' \| \ + X"$mf" : 'X\(//\)$' \| \ + X"$mf" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X"$mf" | + sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ + s//\1/ + q + } + /^X\(\/\/\)[^/].*/{ + s//\1/ + q + } + /^X\(\/\/\)$/{ + s//\1/ + q + } + /^X\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'` + else + continue + fi + # Extract the definition of DEPDIR, am__include, and am__quote + # from the Makefile without running `make'. + DEPDIR=`sed -n 's/^DEPDIR = //p' < "$mf"` + test -z "$DEPDIR" && continue + am__include=`sed -n 's/^am__include = //p' < "$mf"` + test -z "am__include" && continue + am__quote=`sed -n 's/^am__quote = //p' < "$mf"` + # When using ansi2knr, U may be empty or an underscore; expand it + U=`sed -n 's/^U = //p' < "$mf"` + # Find all dependency output files, they are included files with + # $(DEPDIR) in their names. We invoke sed twice because it is the + # simplest approach to changing $(DEPDIR) to its actual value in the + # expansion. + for file in `sed -n " + s/^$am__include $am__quote\(.*(DEPDIR).*\)$am__quote"'$/\1/p' <"$mf" | \ + sed -e 's/\$(DEPDIR)/'"$DEPDIR"'/g' -e 's/\$U/'"$U"'/g'`; do + # Make sure the directory exists. + test -f "$dirpart/$file" && continue + fdir=`$as_dirname -- "$file" || +$as_expr X"$file" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ + X"$file" : 'X\(//\)[^/]' \| \ + X"$file" : 'X\(//\)$' \| \ + X"$file" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X"$file" | + sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ + s//\1/ + q + } + /^X\(\/\/\)[^/].*/{ + s//\1/ + q + } + /^X\(\/\/\)$/{ + s//\1/ + q + } + /^X\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'` + as_dir=$dirpart/$fdir; as_fn_mkdir_p + # echo "creating $dirpart/$file" + echo '# dummy' > "$dirpart/$file" + done + done +} + ;; + "libtool":C) + + # See if we are running on zsh, and set the options which allow our + # commands through without removal of \ escapes. + if test -n "${ZSH_VERSION+set}" ; then + setopt NO_GLOB_SUBST + fi + + cfgfile="${ofile}T" + trap "$RM \"$cfgfile\"; exit 1" 1 2 15 + $RM "$cfgfile" + + cat <<_LT_EOF >> "$cfgfile" +#! $SHELL + +# `$ECHO "$ofile" | sed 's%^.*/%%'` - Provide generalized library-building support services. +# Generated automatically by $as_me ($PACKAGE$TIMESTAMP) $VERSION +# Libtool was configured on host `(hostname || uname -n) 2>/dev/null | sed 1q`: +# NOTE: Changes made to this file will be lost: look at ltmain.sh. +# +# Copyright (C) 1996, 1997, 1998, 1999, 2000, 2001, 2003, 2004, 2005, +# 2006, 2007, 2008, 2009, 2010, 2011 Free Software +# Foundation, Inc. +# Written by Gordon Matzigkeit, 1996 +# +# This file is part of GNU Libtool. +# +# GNU Libtool is free software; you can redistribute it and/or +# modify it under the terms of the GNU General Public License as +# published by the Free Software Foundation; either version 2 of +# the License, or (at your option) any later version. +# +# As a special exception to the GNU General Public License, +# if you distribute this file as part of a program or library that +# is built using GNU Libtool, you may include this file under the +# same distribution terms that you use for the rest of that program. +# +# GNU Libtool is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY; without even the implied warranty of +# MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +# GNU General Public License for more details. +# +# You should have received a copy of the GNU General Public License +# along with GNU Libtool; see the file COPYING. If not, a copy +# can be downloaded from http://www.gnu.org/licenses/gpl.html, or +# obtained by writing to the Free Software Foundation, Inc., +# 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301, USA. + + +# The names of the tagged configurations supported by this script. +available_tags="CXX " + +# ### BEGIN LIBTOOL CONFIG + +# Which release of libtool.m4 was used? +macro_version=$macro_version +macro_revision=$macro_revision + +# Whether or not to build shared libraries. +build_libtool_libs=$enable_shared + +# Whether or not to build static libraries. +build_old_libs=$enable_static + +# What type of objects to build. +pic_mode=$pic_mode + +# Whether or not to optimize for fast installation. +fast_install=$enable_fast_install + +# Shell to use when invoking shell scripts. +SHELL=$lt_SHELL + +# An echo program that protects backslashes. +ECHO=$lt_ECHO + +# The PATH separator for the build system. +PATH_SEPARATOR=$lt_PATH_SEPARATOR + +# The host system. +host_alias=$host_alias +host=$host +host_os=$host_os + +# The build system. +build_alias=$build_alias +build=$build +build_os=$build_os + +# A sed program that does not truncate output. +SED=$lt_SED + +# Sed that helps us avoid accidentally triggering echo(1) options like -n. +Xsed="\$SED -e 1s/^X//" + +# A grep program that handles long lines. +GREP=$lt_GREP + +# An ERE matcher. +EGREP=$lt_EGREP + +# A literal string matcher. +FGREP=$lt_FGREP + +# A BSD- or MS-compatible name lister. +NM=$lt_NM + +# Whether we need soft or hard links. +LN_S=$lt_LN_S + +# What is the maximum length of a command? +max_cmd_len=$max_cmd_len + +# Object file suffix (normally "o"). +objext=$ac_objext + +# Executable file suffix (normally ""). +exeext=$exeext + +# whether the shell understands "unset". +lt_unset=$lt_unset + +# turn spaces into newlines. +SP2NL=$lt_lt_SP2NL + +# turn newlines into spaces. +NL2SP=$lt_lt_NL2SP + +# convert \$build file names to \$host format. +to_host_file_cmd=$lt_cv_to_host_file_cmd + +# convert \$build files to toolchain format. +to_tool_file_cmd=$lt_cv_to_tool_file_cmd + +# An object symbol dumper. +OBJDUMP=$lt_OBJDUMP + +# Method to check whether dependent libraries are shared objects. +deplibs_check_method=$lt_deplibs_check_method + +# Command to use when deplibs_check_method = "file_magic". +file_magic_cmd=$lt_file_magic_cmd + +# How to find potential files when deplibs_check_method = "file_magic". +file_magic_glob=$lt_file_magic_glob + +# Find potential files using nocaseglob when deplibs_check_method = "file_magic". +want_nocaseglob=$lt_want_nocaseglob + +# DLL creation program. +DLLTOOL=$lt_DLLTOOL + +# Command to associate shared and link libraries. +sharedlib_from_linklib_cmd=$lt_sharedlib_from_linklib_cmd + +# The archiver. +AR=$lt_AR + +# Flags to create an archive. +AR_FLAGS=$lt_AR_FLAGS + +# How to feed a file listing to the archiver. +archiver_list_spec=$lt_archiver_list_spec + +# A symbol stripping program. +STRIP=$lt_STRIP + +# Commands used to install an old-style archive. +RANLIB=$lt_RANLIB +old_postinstall_cmds=$lt_old_postinstall_cmds +old_postuninstall_cmds=$lt_old_postuninstall_cmds + +# Whether to use a lock for old archive extraction. +lock_old_archive_extraction=$lock_old_archive_extraction + +# A C compiler. +LTCC=$lt_CC + +# LTCC compiler flags. +LTCFLAGS=$lt_CFLAGS + +# Take the output of nm and produce a listing of raw symbols and C names. +global_symbol_pipe=$lt_lt_cv_sys_global_symbol_pipe + +# Transform the output of nm in a proper C declaration. +global_symbol_to_cdecl=$lt_lt_cv_sys_global_symbol_to_cdecl + +# Transform the output of nm in a C name address pair. +global_symbol_to_c_name_address=$lt_lt_cv_sys_global_symbol_to_c_name_address + +# Transform the output of nm in a C name address pair when lib prefix is needed. +global_symbol_to_c_name_address_lib_prefix=$lt_lt_cv_sys_global_symbol_to_c_name_address_lib_prefix + +# Specify filename containing input files for \$NM. +nm_file_list_spec=$lt_nm_file_list_spec + +# The root where to search for dependent libraries,and in which our libraries should be installed. +lt_sysroot=$lt_sysroot + +# The name of the directory that contains temporary libtool files. +objdir=$objdir + +# Used to examine libraries when file_magic_cmd begins with "file". +MAGIC_CMD=$MAGIC_CMD + +# Must we lock files when doing compilation? +need_locks=$lt_need_locks + +# Manifest tool. +MANIFEST_TOOL=$lt_MANIFEST_TOOL + +# Tool to manipulate archived DWARF debug symbol files on Mac OS X. +DSYMUTIL=$lt_DSYMUTIL + +# Tool to change global to local symbols on Mac OS X. +NMEDIT=$lt_NMEDIT + +# Tool to manipulate fat objects and archives on Mac OS X. +LIPO=$lt_LIPO + +# ldd/readelf like tool for Mach-O binaries on Mac OS X. +OTOOL=$lt_OTOOL + +# ldd/readelf like tool for 64 bit Mach-O binaries on Mac OS X 10.4. +OTOOL64=$lt_OTOOL64 + +# Old archive suffix (normally "a"). +libext=$libext + +# Shared library suffix (normally ".so"). +shrext_cmds=$lt_shrext_cmds + +# The commands to extract the exported symbol list from a shared archive. +extract_expsyms_cmds=$lt_extract_expsyms_cmds + +# Variables whose values should be saved in libtool wrapper scripts and +# restored at link time. +variables_saved_for_relink=$lt_variables_saved_for_relink + +# Do we need the "lib" prefix for modules? +need_lib_prefix=$need_lib_prefix + +# Do we need a version for libraries? +need_version=$need_version + +# Library versioning type. +version_type=$version_type + +# Shared library runtime path variable. +runpath_var=$runpath_var + +# Shared library path variable. +shlibpath_var=$shlibpath_var + +# Is shlibpath searched before the hard-coded library search path? +shlibpath_overrides_runpath=$shlibpath_overrides_runpath + +# Format of library name prefix. +libname_spec=$lt_libname_spec + +# List of archive names. First name is the real one, the rest are links. +# The last name is the one that the linker finds with -lNAME +library_names_spec=$lt_library_names_spec + +# The coded name of the library, if different from the real name. +soname_spec=$lt_soname_spec + +# Permission mode override for installation of shared libraries. +install_override_mode=$lt_install_override_mode + +# Command to use after installation of a shared archive. +postinstall_cmds=$lt_postinstall_cmds + +# Command to use after uninstallation of a shared archive. +postuninstall_cmds=$lt_postuninstall_cmds + +# Commands used to finish a libtool library installation in a directory. +finish_cmds=$lt_finish_cmds + +# As "finish_cmds", except a single script fragment to be evaled but +# not shown. +finish_eval=$lt_finish_eval + +# Whether we should hardcode library paths into libraries. +hardcode_into_libs=$hardcode_into_libs + +# Compile-time system search path for libraries. +sys_lib_search_path_spec=$lt_sys_lib_search_path_spec + +# Run-time system search path for libraries. +sys_lib_dlsearch_path_spec=$lt_sys_lib_dlsearch_path_spec + +# Whether dlopen is supported. +dlopen_support=$enable_dlopen + +# Whether dlopen of programs is supported. +dlopen_self=$enable_dlopen_self + +# Whether dlopen of statically linked programs is supported. +dlopen_self_static=$enable_dlopen_self_static + +# Commands to strip libraries. +old_striplib=$lt_old_striplib +striplib=$lt_striplib + +# Assembler program. +AS=$lt_AS + + +# The linker used to build libraries. +LD=$lt_LD + +# How to create reloadable object files. +reload_flag=$lt_reload_flag +reload_cmds=$lt_reload_cmds + +# Commands used to build an old-style archive. +old_archive_cmds=$lt_old_archive_cmds + +# A language specific compiler. +CC=$lt_compiler + +# Is the compiler the GNU compiler? +with_gcc=$GCC + +# Compiler flag to turn off builtin functions. +no_builtin_flag=$lt_lt_prog_compiler_no_builtin_flag + +# Additional compiler flags for building library objects. +pic_flag=$lt_lt_prog_compiler_pic + +# How to pass a linker flag through the compiler. +wl=$lt_lt_prog_compiler_wl + +# Compiler flag to prevent dynamic linking. +link_static_flag=$lt_lt_prog_compiler_static + +# Does compiler simultaneously support -c and -o options? +compiler_c_o=$lt_lt_cv_prog_compiler_c_o + +# Whether or not to add -lc for building shared libraries. +build_libtool_need_lc=$archive_cmds_need_lc + +# Whether or not to disallow shared libs when runtime libs are static. +allow_libtool_libs_with_static_runtimes=$enable_shared_with_static_runtimes + +# Compiler flag to allow reflexive dlopens. +export_dynamic_flag_spec=$lt_export_dynamic_flag_spec + +# Compiler flag to generate shared objects directly from archives. +whole_archive_flag_spec=$lt_whole_archive_flag_spec + +# Whether the compiler copes with passing no objects directly. +compiler_needs_object=$lt_compiler_needs_object + +# Create an old-style archive from a shared archive. +old_archive_from_new_cmds=$lt_old_archive_from_new_cmds + +# Create a temporary old-style archive to link instead of a shared archive. +old_archive_from_expsyms_cmds=$lt_old_archive_from_expsyms_cmds + +# Commands used to build a shared archive. +archive_cmds=$lt_archive_cmds +archive_expsym_cmds=$lt_archive_expsym_cmds + +# Commands used to build a loadable module if different from building +# a shared archive. +module_cmds=$lt_module_cmds +module_expsym_cmds=$lt_module_expsym_cmds + +# Whether we are building with GNU ld or not. +with_gnu_ld=$lt_with_gnu_ld + +# Flag that allows shared libraries with undefined symbols to be built. +allow_undefined_flag=$lt_allow_undefined_flag + +# Flag that enforces no undefined symbols. +no_undefined_flag=$lt_no_undefined_flag + +# Flag to hardcode \$libdir into a binary during linking. +# This must work even if \$libdir does not exist +hardcode_libdir_flag_spec=$lt_hardcode_libdir_flag_spec + +# Whether we need a single "-rpath" flag with a separated argument. +hardcode_libdir_separator=$lt_hardcode_libdir_separator + +# Set to "yes" if using DIR/libNAME\${shared_ext} during linking hardcodes +# DIR into the resulting binary. +hardcode_direct=$hardcode_direct + +# Set to "yes" if using DIR/libNAME\${shared_ext} during linking hardcodes +# DIR into the resulting binary and the resulting library dependency is +# "absolute",i.e impossible to change by setting \${shlibpath_var} if the +# library is relocated. +hardcode_direct_absolute=$hardcode_direct_absolute + +# Set to "yes" if using the -LDIR flag during linking hardcodes DIR +# into the resulting binary. +hardcode_minus_L=$hardcode_minus_L + +# Set to "yes" if using SHLIBPATH_VAR=DIR during linking hardcodes DIR +# into the resulting binary. +hardcode_shlibpath_var=$hardcode_shlibpath_var + +# Set to "yes" if building a shared library automatically hardcodes DIR +# into the library and all subsequent libraries and executables linked +# against it. +hardcode_automatic=$hardcode_automatic + +# Set to yes if linker adds runtime paths of dependent libraries +# to runtime path list. +inherit_rpath=$inherit_rpath + +# Whether libtool must link a program against all its dependency libraries. +link_all_deplibs=$link_all_deplibs + +# Set to "yes" if exported symbols are required. +always_export_symbols=$always_export_symbols + +# The commands to list exported symbols. +export_symbols_cmds=$lt_export_symbols_cmds + +# Symbols that should not be listed in the preloaded symbols. +exclude_expsyms=$lt_exclude_expsyms + +# Symbols that must always be exported. +include_expsyms=$lt_include_expsyms + +# Commands necessary for linking programs (against libraries) with templates. +prelink_cmds=$lt_prelink_cmds + +# Commands necessary for finishing linking programs. +postlink_cmds=$lt_postlink_cmds + +# Specify filename containing input files. +file_list_spec=$lt_file_list_spec + +# How to hardcode a shared library path into an executable. +hardcode_action=$hardcode_action + +# The directories searched by this compiler when creating a shared library. +compiler_lib_search_dirs=$lt_compiler_lib_search_dirs + +# Dependencies to place before and after the objects being linked to +# create a shared library. +predep_objects=$lt_predep_objects +postdep_objects=$lt_postdep_objects +predeps=$lt_predeps +postdeps=$lt_postdeps + +# The library search path used internally by the compiler when linking +# a shared library. +compiler_lib_search_path=$lt_compiler_lib_search_path + +# ### END LIBTOOL CONFIG + +_LT_EOF + + case $host_os in + aix3*) + cat <<\_LT_EOF >> "$cfgfile" +# AIX sometimes has problems with the GCC collect2 program. For some +# reason, if we set the COLLECT_NAMES environment variable, the problems +# vanish in a puff of smoke. +if test "X${COLLECT_NAMES+set}" != Xset; then + COLLECT_NAMES= + export COLLECT_NAMES +fi +_LT_EOF + ;; + esac + + +ltmain="$ac_aux_dir/ltmain.sh" + + + # We use sed instead of cat because bash on DJGPP gets confused if + # if finds mixed CR/LF and LF-only lines. Since sed operates in + # text mode, it properly converts lines to CR/LF. This bash problem + # is reportedly fixed, but why not run on old versions too? + sed '$q' "$ltmain" >> "$cfgfile" \ + || (rm -f "$cfgfile"; exit 1) + + if test x"$xsi_shell" = xyes; then + sed -e '/^func_dirname ()$/,/^} # func_dirname /c\ +func_dirname ()\ +{\ +\ case ${1} in\ +\ */*) func_dirname_result="${1%/*}${2}" ;;\ +\ * ) func_dirname_result="${3}" ;;\ +\ esac\ +} # Extended-shell func_dirname implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_basename ()$/,/^} # func_basename /c\ +func_basename ()\ +{\ +\ func_basename_result="${1##*/}"\ +} # Extended-shell func_basename implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_dirname_and_basename ()$/,/^} # func_dirname_and_basename /c\ +func_dirname_and_basename ()\ +{\ +\ case ${1} in\ +\ */*) func_dirname_result="${1%/*}${2}" ;;\ +\ * ) func_dirname_result="${3}" ;;\ +\ esac\ +\ func_basename_result="${1##*/}"\ +} # Extended-shell func_dirname_and_basename implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_stripname ()$/,/^} # func_stripname /c\ +func_stripname ()\ +{\ +\ # pdksh 5.2.14 does not do ${X%$Y} correctly if both X and Y are\ +\ # positional parameters, so assign one to ordinary parameter first.\ +\ func_stripname_result=${3}\ +\ func_stripname_result=${func_stripname_result#"${1}"}\ +\ func_stripname_result=${func_stripname_result%"${2}"}\ +} # Extended-shell func_stripname implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_split_long_opt ()$/,/^} # func_split_long_opt /c\ +func_split_long_opt ()\ +{\ +\ func_split_long_opt_name=${1%%=*}\ +\ func_split_long_opt_arg=${1#*=}\ +} # Extended-shell func_split_long_opt implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_split_short_opt ()$/,/^} # func_split_short_opt /c\ +func_split_short_opt ()\ +{\ +\ func_split_short_opt_arg=${1#??}\ +\ func_split_short_opt_name=${1%"$func_split_short_opt_arg"}\ +} # Extended-shell func_split_short_opt implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_lo2o ()$/,/^} # func_lo2o /c\ +func_lo2o ()\ +{\ +\ case ${1} in\ +\ *.lo) func_lo2o_result=${1%.lo}.${objext} ;;\ +\ *) func_lo2o_result=${1} ;;\ +\ esac\ +} # Extended-shell func_lo2o implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_xform ()$/,/^} # func_xform /c\ +func_xform ()\ +{\ + func_xform_result=${1%.*}.lo\ +} # Extended-shell func_xform implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_arith ()$/,/^} # func_arith /c\ +func_arith ()\ +{\ + func_arith_result=$(( $* ))\ +} # Extended-shell func_arith implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_len ()$/,/^} # func_len /c\ +func_len ()\ +{\ + func_len_result=${#1}\ +} # Extended-shell func_len implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + +fi + +if test x"$lt_shell_append" = xyes; then + sed -e '/^func_append ()$/,/^} # func_append /c\ +func_append ()\ +{\ + eval "${1}+=\\${2}"\ +} # Extended-shell func_append implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_append_quoted ()$/,/^} # func_append_quoted /c\ +func_append_quoted ()\ +{\ +\ func_quote_for_eval "${2}"\ +\ eval "${1}+=\\\\ \\$func_quote_for_eval_result"\ +} # Extended-shell func_append_quoted implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + # Save a `func_append' function call where possible by direct use of '+=' + sed -e 's%func_append \([a-zA-Z_]\{1,\}\) "%\1+="%g' $cfgfile > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") + test 0 -eq $? || _lt_function_replace_fail=: +else + # Save a `func_append' function call even when '+=' is not available + sed -e 's%func_append \([a-zA-Z_]\{1,\}\) "%\1="$\1%g' $cfgfile > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") + test 0 -eq $? || _lt_function_replace_fail=: +fi + +if test x"$_lt_function_replace_fail" = x":"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: Unable to substitute extended shell functions in $ofile" >&5 +$as_echo "$as_me: WARNING: Unable to substitute extended shell functions in $ofile" >&2;} +fi + + + mv -f "$cfgfile" "$ofile" || + (rm -f "$ofile" && cp "$cfgfile" "$ofile" && rm -f "$cfgfile") + chmod +x "$ofile" + + + cat <<_LT_EOF >> "$ofile" + +# ### BEGIN LIBTOOL TAG CONFIG: CXX + +# The linker used to build libraries. +LD=$lt_LD_CXX + +# How to create reloadable object files. +reload_flag=$lt_reload_flag_CXX +reload_cmds=$lt_reload_cmds_CXX + +# Commands used to build an old-style archive. +old_archive_cmds=$lt_old_archive_cmds_CXX + +# A language specific compiler. +CC=$lt_compiler_CXX + +# Is the compiler the GNU compiler? +with_gcc=$GCC_CXX + +# Compiler flag to turn off builtin functions. +no_builtin_flag=$lt_lt_prog_compiler_no_builtin_flag_CXX + +# Additional compiler flags for building library objects. +pic_flag=$lt_lt_prog_compiler_pic_CXX + +# How to pass a linker flag through the compiler. +wl=$lt_lt_prog_compiler_wl_CXX + +# Compiler flag to prevent dynamic linking. +link_static_flag=$lt_lt_prog_compiler_static_CXX + +# Does compiler simultaneously support -c and -o options? +compiler_c_o=$lt_lt_cv_prog_compiler_c_o_CXX + +# Whether or not to add -lc for building shared libraries. +build_libtool_need_lc=$archive_cmds_need_lc_CXX + +# Whether or not to disallow shared libs when runtime libs are static. +allow_libtool_libs_with_static_runtimes=$enable_shared_with_static_runtimes_CXX + +# Compiler flag to allow reflexive dlopens. +export_dynamic_flag_spec=$lt_export_dynamic_flag_spec_CXX + +# Compiler flag to generate shared objects directly from archives. +whole_archive_flag_spec=$lt_whole_archive_flag_spec_CXX + +# Whether the compiler copes with passing no objects directly. +compiler_needs_object=$lt_compiler_needs_object_CXX + +# Create an old-style archive from a shared archive. +old_archive_from_new_cmds=$lt_old_archive_from_new_cmds_CXX + +# Create a temporary old-style archive to link instead of a shared archive. +old_archive_from_expsyms_cmds=$lt_old_archive_from_expsyms_cmds_CXX + +# Commands used to build a shared archive. +archive_cmds=$lt_archive_cmds_CXX +archive_expsym_cmds=$lt_archive_expsym_cmds_CXX + +# Commands used to build a loadable module if different from building +# a shared archive. +module_cmds=$lt_module_cmds_CXX +module_expsym_cmds=$lt_module_expsym_cmds_CXX + +# Whether we are building with GNU ld or not. +with_gnu_ld=$lt_with_gnu_ld_CXX + +# Flag that allows shared libraries with undefined symbols to be built. +allow_undefined_flag=$lt_allow_undefined_flag_CXX + +# Flag that enforces no undefined symbols. +no_undefined_flag=$lt_no_undefined_flag_CXX + +# Flag to hardcode \$libdir into a binary during linking. +# This must work even if \$libdir does not exist +hardcode_libdir_flag_spec=$lt_hardcode_libdir_flag_spec_CXX + +# Whether we need a single "-rpath" flag with a separated argument. +hardcode_libdir_separator=$lt_hardcode_libdir_separator_CXX + +# Set to "yes" if using DIR/libNAME\${shared_ext} during linking hardcodes +# DIR into the resulting binary. +hardcode_direct=$hardcode_direct_CXX + +# Set to "yes" if using DIR/libNAME\${shared_ext} during linking hardcodes +# DIR into the resulting binary and the resulting library dependency is +# "absolute",i.e impossible to change by setting \${shlibpath_var} if the +# library is relocated. +hardcode_direct_absolute=$hardcode_direct_absolute_CXX + +# Set to "yes" if using the -LDIR flag during linking hardcodes DIR +# into the resulting binary. +hardcode_minus_L=$hardcode_minus_L_CXX + +# Set to "yes" if using SHLIBPATH_VAR=DIR during linking hardcodes DIR +# into the resulting binary. +hardcode_shlibpath_var=$hardcode_shlibpath_var_CXX + +# Set to "yes" if building a shared library automatically hardcodes DIR +# into the library and all subsequent libraries and executables linked +# against it. +hardcode_automatic=$hardcode_automatic_CXX + +# Set to yes if linker adds runtime paths of dependent libraries +# to runtime path list. +inherit_rpath=$inherit_rpath_CXX + +# Whether libtool must link a program against all its dependency libraries. +link_all_deplibs=$link_all_deplibs_CXX + +# Set to "yes" if exported symbols are required. +always_export_symbols=$always_export_symbols_CXX + +# The commands to list exported symbols. +export_symbols_cmds=$lt_export_symbols_cmds_CXX + +# Symbols that should not be listed in the preloaded symbols. +exclude_expsyms=$lt_exclude_expsyms_CXX + +# Symbols that must always be exported. +include_expsyms=$lt_include_expsyms_CXX + +# Commands necessary for linking programs (against libraries) with templates. +prelink_cmds=$lt_prelink_cmds_CXX + +# Commands necessary for finishing linking programs. +postlink_cmds=$lt_postlink_cmds_CXX + +# Specify filename containing input files. +file_list_spec=$lt_file_list_spec_CXX + +# How to hardcode a shared library path into an executable. +hardcode_action=$hardcode_action_CXX + +# The directories searched by this compiler when creating a shared library. +compiler_lib_search_dirs=$lt_compiler_lib_search_dirs_CXX + +# Dependencies to place before and after the objects being linked to +# create a shared library. +predep_objects=$lt_predep_objects_CXX +postdep_objects=$lt_postdep_objects_CXX +predeps=$lt_predeps_CXX +postdeps=$lt_postdeps_CXX + +# The library search path used internally by the compiler when linking +# a shared library. +compiler_lib_search_path=$lt_compiler_lib_search_path_CXX + +# ### END LIBTOOL TAG CONFIG: CXX +_LT_EOF + + ;; + + esac +done # for ac_tag + + +as_fn_exit 0 diff --git a/libconfig-1.4.9/configure b/libconfig-1.4.9/configure new file mode 100755 index 0000000000000000000000000000000000000000..071ac5bf9cad00b07f28babdd2916e53abb7fb78 --- /dev/null +++ b/libconfig-1.4.9/configure @@ -0,0 +1,19400 @@ +#! /bin/sh +# Guess values for system-dependent variables and create Makefiles. +# Generated by GNU Autoconf 2.68 for libconfig 1.4.9. +# +# Report bugs to . +# +# +# Copyright (C) 1992, 1993, 1994, 1995, 1996, 1998, 1999, 2000, 2001, +# 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010 Free Software +# Foundation, Inc. +# +# +# This configure script is free software; the Free Software Foundation +# gives unlimited permission to copy, distribute and modify it. +## -------------------- ## +## M4sh Initialization. ## +## -------------------- ## + +# Be more Bourne compatible +DUALCASE=1; export DUALCASE # for MKS sh +if test -n "${ZSH_VERSION+set}" && (emulate sh) >/dev/null 2>&1; then : + emulate sh + NULLCMD=: + # Pre-4.2 versions of Zsh do word splitting on ${1+"$@"}, which + # is contrary to our usage. Disable this feature. + alias -g '${1+"$@"}'='"$@"' + setopt NO_GLOB_SUBST +else + case `(set -o) 2>/dev/null` in #( + *posix*) : + set -o posix ;; #( + *) : + ;; +esac +fi + + +as_nl=' +' +export as_nl +# Printing a long string crashes Solaris 7 /usr/bin/printf. +as_echo='\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\' +as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo +as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo$as_echo +# Prefer a ksh shell builtin over an external printf program on Solaris, +# but without wasting forks for bash or zsh. +if test -z "$BASH_VERSION$ZSH_VERSION" \ + && (test "X`print -r -- $as_echo`" = "X$as_echo") 2>/dev/null; then + as_echo='print -r --' + as_echo_n='print -rn --' +elif (test "X`printf %s $as_echo`" = "X$as_echo") 2>/dev/null; then + as_echo='printf %s\n' + as_echo_n='printf %s' +else + if test "X`(/usr/ucb/echo -n -n $as_echo) 2>/dev/null`" = "X-n $as_echo"; then + as_echo_body='eval /usr/ucb/echo -n "$1$as_nl"' + as_echo_n='/usr/ucb/echo -n' + else + as_echo_body='eval expr "X$1" : "X\\(.*\\)"' + as_echo_n_body='eval + arg=$1; + case $arg in #( + *"$as_nl"*) + expr "X$arg" : "X\\(.*\\)$as_nl"; + arg=`expr "X$arg" : ".*$as_nl\\(.*\\)"`;; + esac; + expr "X$arg" : "X\\(.*\\)" | tr -d "$as_nl" + ' + export as_echo_n_body + as_echo_n='sh -c $as_echo_n_body as_echo' + fi + export as_echo_body + as_echo='sh -c $as_echo_body as_echo' +fi + +# The user is always right. +if test "${PATH_SEPARATOR+set}" != set; then + PATH_SEPARATOR=: + (PATH='/bin;/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 && { + (PATH='/bin:/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 || + PATH_SEPARATOR=';' + } +fi + + +# IFS +# We need space, tab and new line, in precisely that order. Quoting is +# there to prevent editors from complaining about space-tab. +# (If _AS_PATH_WALK were called with IFS unset, it would disable word +# splitting by setting IFS to empty value.) +IFS=" "" $as_nl" + +# Find who we are. Look in the path if we contain no directory separator. +as_myself= +case $0 in #(( + *[\\/]* ) as_myself=$0 ;; + *) as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + test -r "$as_dir/$0" && as_myself=$as_dir/$0 && break + done +IFS=$as_save_IFS + + ;; +esac +# We did not find ourselves, most probably we were run as `sh COMMAND' +# in which case we are not to be found in the path. +if test "x$as_myself" = x; then + as_myself=$0 +fi +if test ! -f "$as_myself"; then + $as_echo "$as_myself: error: cannot find myself; rerun with an absolute file name" >&2 + exit 1 +fi + +# Unset variables that we do not need and which cause bugs (e.g. in +# pre-3.0 UWIN ksh). But do not cause bugs in bash 2.01; the "|| exit 1" +# suppresses any "Segmentation fault" message there. '((' could +# trigger a bug in pdksh 5.2.14. +for as_var in BASH_ENV ENV MAIL MAILPATH +do eval test x\${$as_var+set} = xset \ + && ( (unset $as_var) || exit 1) >/dev/null 2>&1 && unset $as_var || : +done +PS1='$ ' +PS2='> ' +PS4='+ ' + +# NLS nuisances. +LC_ALL=C +export LC_ALL +LANGUAGE=C +export LANGUAGE + +# CDPATH. +(unset CDPATH) >/dev/null 2>&1 && unset CDPATH + +if test "x$CONFIG_SHELL" = x; then + as_bourne_compatible="if test -n \"\${ZSH_VERSION+set}\" && (emulate sh) >/dev/null 2>&1; then : + emulate sh + NULLCMD=: + # Pre-4.2 versions of Zsh do word splitting on \${1+\"\$@\"}, which + # is contrary to our usage. Disable this feature. + alias -g '\${1+\"\$@\"}'='\"\$@\"' + setopt NO_GLOB_SUBST +else + case \`(set -o) 2>/dev/null\` in #( + *posix*) : + set -o posix ;; #( + *) : + ;; +esac +fi +" + as_required="as_fn_return () { (exit \$1); } +as_fn_success () { as_fn_return 0; } +as_fn_failure () { as_fn_return 1; } +as_fn_ret_success () { return 0; } +as_fn_ret_failure () { return 1; } + +exitcode=0 +as_fn_success || { exitcode=1; echo as_fn_success failed.; } +as_fn_failure && { exitcode=1; echo as_fn_failure succeeded.; } +as_fn_ret_success || { exitcode=1; echo as_fn_ret_success failed.; } +as_fn_ret_failure && { exitcode=1; echo as_fn_ret_failure succeeded.; } +if ( set x; as_fn_ret_success y && test x = \"\$1\" ); then : + +else + exitcode=1; echo positional parameters were not saved. +fi +test x\$exitcode = x0 || exit 1" + as_suggested=" as_lineno_1=";as_suggested=$as_suggested$LINENO;as_suggested=$as_suggested" as_lineno_1a=\$LINENO + as_lineno_2=";as_suggested=$as_suggested$LINENO;as_suggested=$as_suggested" as_lineno_2a=\$LINENO + eval 'test \"x\$as_lineno_1'\$as_run'\" != \"x\$as_lineno_2'\$as_run'\" && + test \"x\`expr \$as_lineno_1'\$as_run' + 1\`\" = \"x\$as_lineno_2'\$as_run'\"' || exit 1 +test \$(( 1 + 1 )) = 2 || exit 1 + + test -n \"\${ZSH_VERSION+set}\${BASH_VERSION+set}\" || ( + ECHO='\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\' + ECHO=\$ECHO\$ECHO\$ECHO\$ECHO\$ECHO + ECHO=\$ECHO\$ECHO\$ECHO\$ECHO\$ECHO\$ECHO + PATH=/empty FPATH=/empty; export PATH FPATH + test \"X\`printf %s \$ECHO\`\" = \"X\$ECHO\" \\ + || test \"X\`print -r -- \$ECHO\`\" = \"X\$ECHO\" ) || exit 1" + if (eval "$as_required") 2>/dev/null; then : + as_have_required=yes +else + as_have_required=no +fi + if test x$as_have_required = xyes && (eval "$as_suggested") 2>/dev/null; then : + +else + as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +as_found=false +for as_dir in /bin$PATH_SEPARATOR/usr/bin$PATH_SEPARATOR$PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + as_found=: + case $as_dir in #( + /*) + for as_base in sh bash ksh sh5; do + # Try only shells that exist, to save several forks. + as_shell=$as_dir/$as_base + if { test -f "$as_shell" || test -f "$as_shell.exe"; } && + { $as_echo "$as_bourne_compatible""$as_required" | as_run=a "$as_shell"; } 2>/dev/null; then : + CONFIG_SHELL=$as_shell as_have_required=yes + if { $as_echo "$as_bourne_compatible""$as_suggested" | as_run=a "$as_shell"; } 2>/dev/null; then : + break 2 +fi +fi + done;; + esac + as_found=false +done +$as_found || { if { test -f "$SHELL" || test -f "$SHELL.exe"; } && + { $as_echo "$as_bourne_compatible""$as_required" | as_run=a "$SHELL"; } 2>/dev/null; then : + CONFIG_SHELL=$SHELL as_have_required=yes +fi; } +IFS=$as_save_IFS + + + if test "x$CONFIG_SHELL" != x; then : + # We cannot yet assume a decent shell, so we have to provide a + # neutralization value for shells without unset; and this also + # works around shells that cannot unset nonexistent variables. + # Preserve -v and -x to the replacement shell. + BASH_ENV=/dev/null + ENV=/dev/null + (unset BASH_ENV) >/dev/null 2>&1 && unset BASH_ENV ENV + export CONFIG_SHELL + case $- in # (((( + *v*x* | *x*v* ) as_opts=-vx ;; + *v* ) as_opts=-v ;; + *x* ) as_opts=-x ;; + * ) as_opts= ;; + esac + exec "$CONFIG_SHELL" $as_opts "$as_myself" ${1+"$@"} +fi + + if test x$as_have_required = xno; then : + $as_echo "$0: This script requires a shell more modern than all" + $as_echo "$0: the shells that I found on your system." + if test x${ZSH_VERSION+set} = xset ; then + $as_echo "$0: In particular, zsh $ZSH_VERSION has bugs and should" + $as_echo "$0: be upgraded to zsh 4.3.4 or later." + else + $as_echo "$0: Please tell bug-autoconf@gnu.org and +$0: hyperrealm@gmail.com about your system, including any +$0: error possibly output before this message. Then install +$0: a modern shell, or manually run the script under such a +$0: shell if you do have one." + fi + exit 1 +fi +fi +fi +SHELL=${CONFIG_SHELL-/bin/sh} +export SHELL +# Unset more variables known to interfere with behavior of common tools. +CLICOLOR_FORCE= GREP_OPTIONS= +unset CLICOLOR_FORCE GREP_OPTIONS + +## --------------------- ## +## M4sh Shell Functions. ## +## --------------------- ## +# as_fn_unset VAR +# --------------- +# Portably unset VAR. +as_fn_unset () +{ + { eval $1=; unset $1;} +} +as_unset=as_fn_unset + +# as_fn_set_status STATUS +# ----------------------- +# Set $? to STATUS, without forking. +as_fn_set_status () +{ + return $1 +} # as_fn_set_status + +# as_fn_exit STATUS +# ----------------- +# Exit the shell with STATUS, even in a "trap 0" or "set -e" context. +as_fn_exit () +{ + set +e + as_fn_set_status $1 + exit $1 +} # as_fn_exit + +# as_fn_mkdir_p +# ------------- +# Create "$as_dir" as a directory, including parents if necessary. +as_fn_mkdir_p () +{ + + case $as_dir in #( + -*) as_dir=./$as_dir;; + esac + test -d "$as_dir" || eval $as_mkdir_p || { + as_dirs= + while :; do + case $as_dir in #( + *\'*) as_qdir=`$as_echo "$as_dir" | sed "s/'/'\\\\\\\\''/g"`;; #'( + *) as_qdir=$as_dir;; + esac + as_dirs="'$as_qdir' $as_dirs" + as_dir=`$as_dirname -- "$as_dir" || +$as_expr X"$as_dir" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ + X"$as_dir" : 'X\(//\)[^/]' \| \ + X"$as_dir" : 'X\(//\)$' \| \ + X"$as_dir" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X"$as_dir" | + sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ + s//\1/ + q + } + /^X\(\/\/\)[^/].*/{ + s//\1/ + q + } + /^X\(\/\/\)$/{ + s//\1/ + q + } + /^X\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'` + test -d "$as_dir" && break + done + test -z "$as_dirs" || eval "mkdir $as_dirs" + } || test -d "$as_dir" || as_fn_error $? "cannot create directory $as_dir" + + +} # as_fn_mkdir_p +# as_fn_append VAR VALUE +# ---------------------- +# Append the text in VALUE to the end of the definition contained in VAR. Take +# advantage of any shell optimizations that allow amortized linear growth over +# repeated appends, instead of the typical quadratic growth present in naive +# implementations. +if (eval "as_var=1; as_var+=2; test x\$as_var = x12") 2>/dev/null; then : + eval 'as_fn_append () + { + eval $1+=\$2 + }' +else + as_fn_append () + { + eval $1=\$$1\$2 + } +fi # as_fn_append + +# as_fn_arith ARG... +# ------------------ +# Perform arithmetic evaluation on the ARGs, and store the result in the +# global $as_val. Take advantage of shells that can avoid forks. The arguments +# must be portable across $(()) and expr. +if (eval "test \$(( 1 + 1 )) = 2") 2>/dev/null; then : + eval 'as_fn_arith () + { + as_val=$(( $* )) + }' +else + as_fn_arith () + { + as_val=`expr "$@" || test $? -eq 1` + } +fi # as_fn_arith + + +# as_fn_error STATUS ERROR [LINENO LOG_FD] +# ---------------------------------------- +# Output "`basename $0`: error: ERROR" to stderr. If LINENO and LOG_FD are +# provided, also output the error to LOG_FD, referencing LINENO. Then exit the +# script with STATUS, using 1 if that was 0. +as_fn_error () +{ + as_status=$1; test $as_status -eq 0 && as_status=1 + if test "$4"; then + as_lineno=${as_lineno-"$3"} as_lineno_stack=as_lineno_stack=$as_lineno_stack + $as_echo "$as_me:${as_lineno-$LINENO}: error: $2" >&$4 + fi + $as_echo "$as_me: error: $2" >&2 + as_fn_exit $as_status +} # as_fn_error + +if expr a : '\(a\)' >/dev/null 2>&1 && + test "X`expr 00001 : '.*\(...\)'`" = X001; then + as_expr=expr +else + as_expr=false +fi + +if (basename -- /) >/dev/null 2>&1 && test "X`basename -- / 2>&1`" = "X/"; then + as_basename=basename +else + as_basename=false +fi + +if (as_dir=`dirname -- /` && test "X$as_dir" = X/) >/dev/null 2>&1; then + as_dirname=dirname +else + as_dirname=false +fi + +as_me=`$as_basename -- "$0" || +$as_expr X/"$0" : '.*/\([^/][^/]*\)/*$' \| \ + X"$0" : 'X\(//\)$' \| \ + X"$0" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X/"$0" | + sed '/^.*\/\([^/][^/]*\)\/*$/{ + s//\1/ + q + } + /^X\/\(\/\/\)$/{ + s//\1/ + q + } + /^X\/\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'` + +# Avoid depending upon Character Ranges. +as_cr_letters='abcdefghijklmnopqrstuvwxyz' +as_cr_LETTERS='ABCDEFGHIJKLMNOPQRSTUVWXYZ' +as_cr_Letters=$as_cr_letters$as_cr_LETTERS +as_cr_digits='0123456789' +as_cr_alnum=$as_cr_Letters$as_cr_digits + + + as_lineno_1=$LINENO as_lineno_1a=$LINENO + as_lineno_2=$LINENO as_lineno_2a=$LINENO + eval 'test "x$as_lineno_1'$as_run'" != "x$as_lineno_2'$as_run'" && + test "x`expr $as_lineno_1'$as_run' + 1`" = "x$as_lineno_2'$as_run'"' || { + # Blame Lee E. McMahon (1931-1989) for sed's syntax. :-) + sed -n ' + p + /[$]LINENO/= + ' <$as_myself | + sed ' + s/[$]LINENO.*/&-/ + t lineno + b + :lineno + N + :loop + s/[$]LINENO\([^'$as_cr_alnum'_].*\n\)\(.*\)/\2\1\2/ + t loop + s/-\n.*// + ' >$as_me.lineno && + chmod +x "$as_me.lineno" || + { $as_echo "$as_me: error: cannot create $as_me.lineno; rerun with a POSIX shell" >&2; as_fn_exit 1; } + + # Don't try to exec as it changes $[0], causing all sort of problems + # (the dirname of $[0] is not the place where we might find the + # original and so on. Autoconf is especially sensitive to this). + . "./$as_me.lineno" + # Exit status is that of the last command. + exit +} + +ECHO_C= ECHO_N= ECHO_T= +case `echo -n x` in #((((( +-n*) + case `echo 'xy\c'` in + *c*) ECHO_T=' ';; # ECHO_T is single tab character. + xy) ECHO_C='\c';; + *) echo `echo ksh88 bug on AIX 6.1` > /dev/null + ECHO_T=' ';; + esac;; +*) + ECHO_N='-n';; +esac + +rm -f conf$$ conf$$.exe conf$$.file +if test -d conf$$.dir; then + rm -f conf$$.dir/conf$$.file +else + rm -f conf$$.dir + mkdir conf$$.dir 2>/dev/null +fi +if (echo >conf$$.file) 2>/dev/null; then + if ln -s conf$$.file conf$$ 2>/dev/null; then + as_ln_s='ln -s' + # ... but there are two gotchas: + # 1) On MSYS, both `ln -s file dir' and `ln file dir' fail. + # 2) DJGPP < 2.04 has no symlinks; `ln -s' creates a wrapper executable. + # In both cases, we have to default to `cp -p'. + ln -s conf$$.file conf$$.dir 2>/dev/null && test ! -f conf$$.exe || + as_ln_s='cp -p' + elif ln conf$$.file conf$$ 2>/dev/null; then + as_ln_s=ln + else + as_ln_s='cp -p' + fi +else + as_ln_s='cp -p' +fi +rm -f conf$$ conf$$.exe conf$$.dir/conf$$.file conf$$.file +rmdir conf$$.dir 2>/dev/null + +if mkdir -p . 2>/dev/null; then + as_mkdir_p='mkdir -p "$as_dir"' +else + test -d ./-p && rmdir ./-p + as_mkdir_p=false +fi + +if test -x / >/dev/null 2>&1; then + as_test_x='test -x' +else + if ls -dL / >/dev/null 2>&1; then + as_ls_L_option=L + else + as_ls_L_option= + fi + as_test_x=' + eval sh -c '\'' + if test -d "$1"; then + test -d "$1/."; + else + case $1 in #( + -*)set "./$1";; + esac; + case `ls -ld'$as_ls_L_option' "$1" 2>/dev/null` in #(( + ???[sx]*):;;*)false;;esac;fi + '\'' sh + ' +fi +as_executable_p=$as_test_x + +# Sed expression to map a string onto a valid CPP name. +as_tr_cpp="eval sed 'y%*$as_cr_letters%P$as_cr_LETTERS%;s%[^_$as_cr_alnum]%_%g'" + +# Sed expression to map a string onto a valid variable name. +as_tr_sh="eval sed 'y%*+%pp%;s%[^_$as_cr_alnum]%_%g'" + +SHELL=${CONFIG_SHELL-/bin/sh} + + +test -n "$DJDIR" || exec 7<&0 &1 + +# Name of the host. +# hostname on some systems (SVR3.2, old GNU/Linux) returns a bogus exit status, +# so uname gets run too. +ac_hostname=`(hostname || uname -n) 2>/dev/null | sed 1q` + +# +# Initializations. +# +ac_default_prefix=/usr/local +ac_clean_files= +ac_config_libobj_dir=. +LIBOBJS= +cross_compiling=no +subdirs= +MFLAGS= +MAKEFLAGS= + +# Identity of this package. +PACKAGE_NAME='libconfig' +PACKAGE_TARNAME='libconfig' +PACKAGE_VERSION='1.4.9' +PACKAGE_STRING='libconfig 1.4.9' +PACKAGE_BUGREPORT='hyperrealm@gmail.com' +PACKAGE_URL='http://www.hyperrealm.com/main.php?s=libconfig' + +# Factoring default headers for most tests. +ac_includes_default="\ +#include +#ifdef HAVE_SYS_TYPES_H +# include +#endif +#ifdef HAVE_SYS_STAT_H +# include +#endif +#ifdef STDC_HEADERS +# include +# include +#else +# ifdef HAVE_STDLIB_H +# include +# endif +#endif +#ifdef HAVE_STRING_H +# if !defined STDC_HEADERS && defined HAVE_MEMORY_H +# include +# endif +# include +#endif +#ifdef HAVE_STRINGS_H +# include +#endif +#ifdef HAVE_INTTYPES_H +# include +#endif +#ifdef HAVE_STDINT_H +# include +#endif +#ifdef HAVE_UNISTD_H +# include +#endif" + +ac_subst_vars='am__EXEEXT_FALSE +am__EXEEXT_TRUE +LTLIBOBJS +LIBOBJS +GNU_WIN_FALSE +GNU_WIN_TRUE +BUILDEXAMPLES_FALSE +BUILDEXAMPLES_TRUE +BUILDCXX_FALSE +BUILDCXX_TRUE +YFLAGS +YACC +LEXLIB +LEX_OUTPUT_ROOT +LEX +AS +CXXCPP +am__fastdepCXX_FALSE +am__fastdepCXX_TRUE +CXXDEPMODE +ac_ct_CXX +CXXFLAGS +CXX +OTOOL64 +OTOOL +LIPO +NMEDIT +DSYMUTIL +MANIFEST_TOOL +RANLIB +ac_ct_AR +AR +DLLTOOL +OBJDUMP +LN_S +NM +ac_ct_DUMPBIN +DUMPBIN +LD +FGREP +SED +LIBTOOL +EGREP +GREP +CPP +am__fastdepCC_FALSE +am__fastdepCC_TRUE +CCDEPMODE +AMDEPBACKSLASH +AMDEP_FALSE +AMDEP_TRUE +am__quote +am__include +DEPDIR +OBJEXT +EXEEXT +ac_ct_CC +CPPFLAGS +LDFLAGS +CFLAGS +CC +am__untar +am__tar +AMTAR +am__leading_dot +SET_MAKE +AWK +mkdir_p +MKDIR_P +INSTALL_STRIP_PROGRAM +STRIP +install_sh +MAKEINFO +AUTOHEADER +AUTOMAKE +AUTOCONF +ACLOCAL +VERSION +PACKAGE +CYGPATH_W +am__isrc +INSTALL_DATA +INSTALL_SCRIPT +INSTALL_PROGRAM +target_os +target_vendor +target_cpu +target +host_os +host_vendor +host_cpu +host +build_os +build_vendor +build_cpu +build +target_alias +host_alias +build_alias +LIBS +ECHO_T +ECHO_N +ECHO_C +DEFS +mandir +localedir +libdir +psdir +pdfdir +dvidir +htmldir +infodir +docdir +oldincludedir +includedir +localstatedir +sharedstatedir +sysconfdir +datadir +datarootdir +libexecdir +sbindir +bindir +program_transform_name +prefix +exec_prefix +PACKAGE_URL +PACKAGE_BUGREPORT +PACKAGE_STRING +PACKAGE_VERSION +PACKAGE_TARNAME +PACKAGE_NAME +PATH_SEPARATOR +SHELL' +ac_subst_files='' +ac_user_opts=' +enable_option_checking +enable_dependency_tracking +enable_shared +enable_static +with_pic +enable_fast_install +with_gnu_ld +with_sysroot +enable_libtool_lock +enable_cxx +enable_examples +' + ac_precious_vars='build_alias +host_alias +target_alias +CC +CFLAGS +LDFLAGS +LIBS +CPPFLAGS +CPP +CXX +CXXFLAGS +CCC +CXXCPP +YACC +YFLAGS' + + +# Initialize some variables set by options. +ac_init_help= +ac_init_version=false +ac_unrecognized_opts= +ac_unrecognized_sep= +# The variables have the same names as the options, with +# dashes changed to underlines. +cache_file=/dev/null +exec_prefix=NONE +no_create= +no_recursion= +prefix=NONE +program_prefix=NONE +program_suffix=NONE +program_transform_name=s,x,x, +silent= +site= +srcdir= +verbose= +x_includes=NONE +x_libraries=NONE + +# Installation directory options. +# These are left unexpanded so users can "make install exec_prefix=/foo" +# and all the variables that are supposed to be based on exec_prefix +# by default will actually change. +# Use braces instead of parens because sh, perl, etc. also accept them. +# (The list follows the same order as the GNU Coding Standards.) +bindir='${exec_prefix}/bin' +sbindir='${exec_prefix}/sbin' +libexecdir='${exec_prefix}/libexec' +datarootdir='${prefix}/share' +datadir='${datarootdir}' +sysconfdir='${prefix}/etc' +sharedstatedir='${prefix}/com' +localstatedir='${prefix}/var' +includedir='${prefix}/include' +oldincludedir='/usr/include' +docdir='${datarootdir}/doc/${PACKAGE_TARNAME}' +infodir='${datarootdir}/info' +htmldir='${docdir}' +dvidir='${docdir}' +pdfdir='${docdir}' +psdir='${docdir}' +libdir='${exec_prefix}/lib' +localedir='${datarootdir}/locale' +mandir='${datarootdir}/man' + +ac_prev= +ac_dashdash= +for ac_option +do + # If the previous option needs an argument, assign it. + if test -n "$ac_prev"; then + eval $ac_prev=\$ac_option + ac_prev= + continue + fi + + case $ac_option in + *=?*) ac_optarg=`expr "X$ac_option" : '[^=]*=\(.*\)'` ;; + *=) ac_optarg= ;; + *) ac_optarg=yes ;; + esac + + # Accept the important Cygnus configure options, so we can diagnose typos. + + case $ac_dashdash$ac_option in + --) + ac_dashdash=yes ;; + + -bindir | --bindir | --bindi | --bind | --bin | --bi) + ac_prev=bindir ;; + -bindir=* | --bindir=* | --bindi=* | --bind=* | --bin=* | --bi=*) + bindir=$ac_optarg ;; + + -build | --build | --buil | --bui | --bu) + ac_prev=build_alias ;; + -build=* | --build=* | --buil=* | --bui=* | --bu=*) + build_alias=$ac_optarg ;; + + -cache-file | --cache-file | --cache-fil | --cache-fi \ + | --cache-f | --cache- | --cache | --cach | --cac | --ca | --c) + ac_prev=cache_file ;; + -cache-file=* | --cache-file=* | --cache-fil=* | --cache-fi=* \ + | --cache-f=* | --cache-=* | --cache=* | --cach=* | --cac=* | --ca=* | --c=*) + cache_file=$ac_optarg ;; + + --config-cache | -C) + cache_file=config.cache ;; + + -datadir | --datadir | --datadi | --datad) + ac_prev=datadir ;; + -datadir=* | --datadir=* | --datadi=* | --datad=*) + datadir=$ac_optarg ;; + + -datarootdir | --datarootdir | --datarootdi | --datarootd | --dataroot \ + | --dataroo | --dataro | --datar) + ac_prev=datarootdir ;; + -datarootdir=* | --datarootdir=* | --datarootdi=* | --datarootd=* \ + | --dataroot=* | --dataroo=* | --dataro=* | --datar=*) + datarootdir=$ac_optarg ;; + + -disable-* | --disable-*) + ac_useropt=`expr "x$ac_option" : 'x-*disable-\(.*\)'` + # Reject names that are not valid shell variable names. + expr "x$ac_useropt" : ".*[^-+._$as_cr_alnum]" >/dev/null && + as_fn_error $? "invalid feature name: $ac_useropt" + ac_useropt_orig=$ac_useropt + ac_useropt=`$as_echo "$ac_useropt" | sed 's/[-+.]/_/g'` + case $ac_user_opts in + *" +"enable_$ac_useropt" +"*) ;; + *) ac_unrecognized_opts="$ac_unrecognized_opts$ac_unrecognized_sep--disable-$ac_useropt_orig" + ac_unrecognized_sep=', ';; + esac + eval enable_$ac_useropt=no ;; + + -docdir | --docdir | --docdi | --doc | --do) + ac_prev=docdir ;; + -docdir=* | --docdir=* | --docdi=* | --doc=* | --do=*) + docdir=$ac_optarg ;; + + -dvidir | --dvidir | --dvidi | --dvid | --dvi | --dv) + ac_prev=dvidir ;; + -dvidir=* | --dvidir=* | --dvidi=* | --dvid=* | --dvi=* | --dv=*) + dvidir=$ac_optarg ;; + + -enable-* | --enable-*) + ac_useropt=`expr "x$ac_option" : 'x-*enable-\([^=]*\)'` + # Reject names that are not valid shell variable names. + expr "x$ac_useropt" : ".*[^-+._$as_cr_alnum]" >/dev/null && + as_fn_error $? "invalid feature name: $ac_useropt" + ac_useropt_orig=$ac_useropt + ac_useropt=`$as_echo "$ac_useropt" | sed 's/[-+.]/_/g'` + case $ac_user_opts in + *" +"enable_$ac_useropt" +"*) ;; + *) ac_unrecognized_opts="$ac_unrecognized_opts$ac_unrecognized_sep--enable-$ac_useropt_orig" + ac_unrecognized_sep=', ';; + esac + eval enable_$ac_useropt=\$ac_optarg ;; + + -exec-prefix | --exec_prefix | --exec-prefix | --exec-prefi \ + | --exec-pref | --exec-pre | --exec-pr | --exec-p | --exec- \ + | --exec | --exe | --ex) + ac_prev=exec_prefix ;; + -exec-prefix=* | --exec_prefix=* | --exec-prefix=* | --exec-prefi=* \ + | --exec-pref=* | --exec-pre=* | --exec-pr=* | --exec-p=* | --exec-=* \ + | --exec=* | --exe=* | --ex=*) + exec_prefix=$ac_optarg ;; + + -gas | --gas | --ga | --g) + # Obsolete; use --with-gas. + with_gas=yes ;; + + -help | --help | --hel | --he | -h) + ac_init_help=long ;; + -help=r* | --help=r* | --hel=r* | --he=r* | -hr*) + ac_init_help=recursive ;; + -help=s* | --help=s* | --hel=s* | --he=s* | -hs*) + ac_init_help=short ;; + + -host | --host | --hos | --ho) + ac_prev=host_alias ;; + -host=* | --host=* | --hos=* | --ho=*) + host_alias=$ac_optarg ;; + + -htmldir | --htmldir | --htmldi | --htmld | --html | --htm | --ht) + ac_prev=htmldir ;; + -htmldir=* | --htmldir=* | --htmldi=* | --htmld=* | --html=* | --htm=* \ + | --ht=*) + htmldir=$ac_optarg ;; + + -includedir | --includedir | --includedi | --included | --include \ + | --includ | --inclu | --incl | --inc) + ac_prev=includedir ;; + -includedir=* | --includedir=* | --includedi=* | --included=* | --include=* \ + | --includ=* | --inclu=* | --incl=* | --inc=*) + includedir=$ac_optarg ;; + + -infodir | --infodir | --infodi | --infod | --info | --inf) + ac_prev=infodir ;; + -infodir=* | --infodir=* | --infodi=* | --infod=* | --info=* | --inf=*) + infodir=$ac_optarg ;; + + -libdir | --libdir | --libdi | --libd) + ac_prev=libdir ;; + -libdir=* | --libdir=* | --libdi=* | --libd=*) + libdir=$ac_optarg ;; + + -libexecdir | --libexecdir | --libexecdi | --libexecd | --libexec \ + | --libexe | --libex | --libe) + ac_prev=libexecdir ;; + -libexecdir=* | --libexecdir=* | --libexecdi=* | --libexecd=* | --libexec=* \ + | --libexe=* | --libex=* | --libe=*) + libexecdir=$ac_optarg ;; + + -localedir | --localedir | --localedi | --localed | --locale) + ac_prev=localedir ;; + -localedir=* | --localedir=* | --localedi=* | --localed=* | --locale=*) + localedir=$ac_optarg ;; + + -localstatedir | --localstatedir | --localstatedi | --localstated \ + | --localstate | --localstat | --localsta | --localst | --locals) + ac_prev=localstatedir ;; + -localstatedir=* | --localstatedir=* | --localstatedi=* | --localstated=* \ + | --localstate=* | --localstat=* | --localsta=* | --localst=* | --locals=*) + localstatedir=$ac_optarg ;; + + -mandir | --mandir | --mandi | --mand | --man | --ma | --m) + ac_prev=mandir ;; + -mandir=* | --mandir=* | --mandi=* | --mand=* | --man=* | --ma=* | --m=*) + mandir=$ac_optarg ;; + + -nfp | --nfp | --nf) + # Obsolete; use --without-fp. + with_fp=no ;; + + -no-create | --no-create | --no-creat | --no-crea | --no-cre \ + | --no-cr | --no-c | -n) + no_create=yes ;; + + -no-recursion | --no-recursion | --no-recursio | --no-recursi \ + | --no-recurs | --no-recur | --no-recu | --no-rec | --no-re | --no-r) + no_recursion=yes ;; + + -oldincludedir | --oldincludedir | --oldincludedi | --oldincluded \ + | --oldinclude | --oldinclud | --oldinclu | --oldincl | --oldinc \ + | --oldin | --oldi | --old | --ol | --o) + ac_prev=oldincludedir ;; + -oldincludedir=* | --oldincludedir=* | --oldincludedi=* | --oldincluded=* \ + | --oldinclude=* | --oldinclud=* | --oldinclu=* | --oldincl=* | --oldinc=* \ + | --oldin=* | --oldi=* | --old=* | --ol=* | --o=*) + oldincludedir=$ac_optarg ;; + + -prefix | --prefix | --prefi | --pref | --pre | --pr | --p) + ac_prev=prefix ;; + -prefix=* | --prefix=* | --prefi=* | --pref=* | --pre=* | --pr=* | --p=*) + prefix=$ac_optarg ;; + + -program-prefix | --program-prefix | --program-prefi | --program-pref \ + | --program-pre | --program-pr | --program-p) + ac_prev=program_prefix ;; + -program-prefix=* | --program-prefix=* | --program-prefi=* \ + | --program-pref=* | --program-pre=* | --program-pr=* | --program-p=*) + program_prefix=$ac_optarg ;; + + -program-suffix | --program-suffix | --program-suffi | --program-suff \ + | --program-suf | --program-su | --program-s) + ac_prev=program_suffix ;; + -program-suffix=* | --program-suffix=* | --program-suffi=* \ + | --program-suff=* | --program-suf=* | --program-su=* | --program-s=*) + program_suffix=$ac_optarg ;; + + -program-transform-name | --program-transform-name \ + | --program-transform-nam | --program-transform-na \ + | --program-transform-n | --program-transform- \ + | --program-transform | --program-transfor \ + | --program-transfo | --program-transf \ + | --program-trans | --program-tran \ + | --progr-tra | --program-tr | --program-t) + ac_prev=program_transform_name ;; + -program-transform-name=* | --program-transform-name=* \ + | --program-transform-nam=* | --program-transform-na=* \ + | --program-transform-n=* | --program-transform-=* \ + | --program-transform=* | --program-transfor=* \ + | --program-transfo=* | --program-transf=* \ + | --program-trans=* | --program-tran=* \ + | --progr-tra=* | --program-tr=* | --program-t=*) + program_transform_name=$ac_optarg ;; + + -pdfdir | --pdfdir | --pdfdi | --pdfd | --pdf | --pd) + ac_prev=pdfdir ;; + -pdfdir=* | --pdfdir=* | --pdfdi=* | --pdfd=* | --pdf=* | --pd=*) + pdfdir=$ac_optarg ;; + + -psdir | --psdir | --psdi | --psd | --ps) + ac_prev=psdir ;; + -psdir=* | --psdir=* | --psdi=* | --psd=* | --ps=*) + psdir=$ac_optarg ;; + + -q | -quiet | --quiet | --quie | --qui | --qu | --q \ + | -silent | --silent | --silen | --sile | --sil) + silent=yes ;; + + -sbindir | --sbindir | --sbindi | --sbind | --sbin | --sbi | --sb) + ac_prev=sbindir ;; + -sbindir=* | --sbindir=* | --sbindi=* | --sbind=* | --sbin=* \ + | --sbi=* | --sb=*) + sbindir=$ac_optarg ;; + + -sharedstatedir | --sharedstatedir | --sharedstatedi \ + | --sharedstated | --sharedstate | --sharedstat | --sharedsta \ + | --sharedst | --shareds | --shared | --share | --shar \ + | --sha | --sh) + ac_prev=sharedstatedir ;; + -sharedstatedir=* | --sharedstatedir=* | --sharedstatedi=* \ + | --sharedstated=* | --sharedstate=* | --sharedstat=* | --sharedsta=* \ + | --sharedst=* | --shareds=* | --shared=* | --share=* | --shar=* \ + | --sha=* | --sh=*) + sharedstatedir=$ac_optarg ;; + + -site | --site | --sit) + ac_prev=site ;; + -site=* | --site=* | --sit=*) + site=$ac_optarg ;; + + -srcdir | --srcdir | --srcdi | --srcd | --src | --sr) + ac_prev=srcdir ;; + -srcdir=* | --srcdir=* | --srcdi=* | --srcd=* | --src=* | --sr=*) + srcdir=$ac_optarg ;; + + -sysconfdir | --sysconfdir | --sysconfdi | --sysconfd | --sysconf \ + | --syscon | --sysco | --sysc | --sys | --sy) + ac_prev=sysconfdir ;; + -sysconfdir=* | --sysconfdir=* | --sysconfdi=* | --sysconfd=* | --sysconf=* \ + | --syscon=* | --sysco=* | --sysc=* | --sys=* | --sy=*) + sysconfdir=$ac_optarg ;; + + -target | --target | --targe | --targ | --tar | --ta | --t) + ac_prev=target_alias ;; + -target=* | --target=* | --targe=* | --targ=* | --tar=* | --ta=* | --t=*) + target_alias=$ac_optarg ;; + + -v | -verbose | --verbose | --verbos | --verbo | --verb) + verbose=yes ;; + + -version | --version | --versio | --versi | --vers | -V) + ac_init_version=: ;; + + -with-* | --with-*) + ac_useropt=`expr "x$ac_option" : 'x-*with-\([^=]*\)'` + # Reject names that are not valid shell variable names. + expr "x$ac_useropt" : ".*[^-+._$as_cr_alnum]" >/dev/null && + as_fn_error $? "invalid package name: $ac_useropt" + ac_useropt_orig=$ac_useropt + ac_useropt=`$as_echo "$ac_useropt" | sed 's/[-+.]/_/g'` + case $ac_user_opts in + *" +"with_$ac_useropt" +"*) ;; + *) ac_unrecognized_opts="$ac_unrecognized_opts$ac_unrecognized_sep--with-$ac_useropt_orig" + ac_unrecognized_sep=', ';; + esac + eval with_$ac_useropt=\$ac_optarg ;; + + -without-* | --without-*) + ac_useropt=`expr "x$ac_option" : 'x-*without-\(.*\)'` + # Reject names that are not valid shell variable names. + expr "x$ac_useropt" : ".*[^-+._$as_cr_alnum]" >/dev/null && + as_fn_error $? "invalid package name: $ac_useropt" + ac_useropt_orig=$ac_useropt + ac_useropt=`$as_echo "$ac_useropt" | sed 's/[-+.]/_/g'` + case $ac_user_opts in + *" +"with_$ac_useropt" +"*) ;; + *) ac_unrecognized_opts="$ac_unrecognized_opts$ac_unrecognized_sep--without-$ac_useropt_orig" + ac_unrecognized_sep=', ';; + esac + eval with_$ac_useropt=no ;; + + --x) + # Obsolete; use --with-x. + with_x=yes ;; + + -x-includes | --x-includes | --x-include | --x-includ | --x-inclu \ + | --x-incl | --x-inc | --x-in | --x-i) + ac_prev=x_includes ;; + -x-includes=* | --x-includes=* | --x-include=* | --x-includ=* | --x-inclu=* \ + | --x-incl=* | --x-inc=* | --x-in=* | --x-i=*) + x_includes=$ac_optarg ;; + + -x-libraries | --x-libraries | --x-librarie | --x-librari \ + | --x-librar | --x-libra | --x-libr | --x-lib | --x-li | --x-l) + ac_prev=x_libraries ;; + -x-libraries=* | --x-libraries=* | --x-librarie=* | --x-librari=* \ + | --x-librar=* | --x-libra=* | --x-libr=* | --x-lib=* | --x-li=* | --x-l=*) + x_libraries=$ac_optarg ;; + + -*) as_fn_error $? "unrecognized option: \`$ac_option' +Try \`$0 --help' for more information" + ;; + + *=*) + ac_envvar=`expr "x$ac_option" : 'x\([^=]*\)='` + # Reject names that are not valid shell variable names. + case $ac_envvar in #( + '' | [0-9]* | *[!_$as_cr_alnum]* ) + as_fn_error $? "invalid variable name: \`$ac_envvar'" ;; + esac + eval $ac_envvar=\$ac_optarg + export $ac_envvar ;; + + *) + # FIXME: should be removed in autoconf 3.0. + $as_echo "$as_me: WARNING: you should use --build, --host, --target" >&2 + expr "x$ac_option" : ".*[^-._$as_cr_alnum]" >/dev/null && + $as_echo "$as_me: WARNING: invalid host type: $ac_option" >&2 + : "${build_alias=$ac_option} ${host_alias=$ac_option} ${target_alias=$ac_option}" + ;; + + esac +done + +if test -n "$ac_prev"; then + ac_option=--`echo $ac_prev | sed 's/_/-/g'` + as_fn_error $? "missing argument to $ac_option" +fi + +if test -n "$ac_unrecognized_opts"; then + case $enable_option_checking in + no) ;; + fatal) as_fn_error $? "unrecognized options: $ac_unrecognized_opts" ;; + *) $as_echo "$as_me: WARNING: unrecognized options: $ac_unrecognized_opts" >&2 ;; + esac +fi + +# Check all directory arguments for consistency. +for ac_var in exec_prefix prefix bindir sbindir libexecdir datarootdir \ + datadir sysconfdir sharedstatedir localstatedir includedir \ + oldincludedir docdir infodir htmldir dvidir pdfdir psdir \ + libdir localedir mandir +do + eval ac_val=\$$ac_var + # Remove trailing slashes. + case $ac_val in + */ ) + ac_val=`expr "X$ac_val" : 'X\(.*[^/]\)' \| "X$ac_val" : 'X\(.*\)'` + eval $ac_var=\$ac_val;; + esac + # Be sure to have absolute directory names. + case $ac_val in + [\\/$]* | ?:[\\/]* ) continue;; + NONE | '' ) case $ac_var in *prefix ) continue;; esac;; + esac + as_fn_error $? "expected an absolute directory name for --$ac_var: $ac_val" +done + +# There might be people who depend on the old broken behavior: `$host' +# used to hold the argument of --host etc. +# FIXME: To remove some day. +build=$build_alias +host=$host_alias +target=$target_alias + +# FIXME: To remove some day. +if test "x$host_alias" != x; then + if test "x$build_alias" = x; then + cross_compiling=maybe + $as_echo "$as_me: WARNING: if you wanted to set the --build type, don't use --host. + If a cross compiler is detected then cross compile mode will be used" >&2 + elif test "x$build_alias" != "x$host_alias"; then + cross_compiling=yes + fi +fi + +ac_tool_prefix= +test -n "$host_alias" && ac_tool_prefix=$host_alias- + +test "$silent" = yes && exec 6>/dev/null + + +ac_pwd=`pwd` && test -n "$ac_pwd" && +ac_ls_di=`ls -di .` && +ac_pwd_ls_di=`cd "$ac_pwd" && ls -di .` || + as_fn_error $? "working directory cannot be determined" +test "X$ac_ls_di" = "X$ac_pwd_ls_di" || + as_fn_error $? "pwd does not report name of working directory" + + +# Find the source files, if location was not specified. +if test -z "$srcdir"; then + ac_srcdir_defaulted=yes + # Try the directory containing this script, then the parent directory. + ac_confdir=`$as_dirname -- "$as_myself" || +$as_expr X"$as_myself" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ + X"$as_myself" : 'X\(//\)[^/]' \| \ + X"$as_myself" : 'X\(//\)$' \| \ + X"$as_myself" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X"$as_myself" | + sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ + s//\1/ + q + } + /^X\(\/\/\)[^/].*/{ + s//\1/ + q + } + /^X\(\/\/\)$/{ + s//\1/ + q + } + /^X\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'` + srcdir=$ac_confdir + if test ! -r "$srcdir/$ac_unique_file"; then + srcdir=.. + fi +else + ac_srcdir_defaulted=no +fi +if test ! -r "$srcdir/$ac_unique_file"; then + test "$ac_srcdir_defaulted" = yes && srcdir="$ac_confdir or .." + as_fn_error $? "cannot find sources ($ac_unique_file) in $srcdir" +fi +ac_msg="sources are in $srcdir, but \`cd $srcdir' does not work" +ac_abs_confdir=`( + cd "$srcdir" && test -r "./$ac_unique_file" || as_fn_error $? "$ac_msg" + pwd)` +# When building in place, set srcdir=. +if test "$ac_abs_confdir" = "$ac_pwd"; then + srcdir=. +fi +# Remove unnecessary trailing slashes from srcdir. +# Double slashes in file names in object file debugging info +# mess up M-x gdb in Emacs. +case $srcdir in +*/) srcdir=`expr "X$srcdir" : 'X\(.*[^/]\)' \| "X$srcdir" : 'X\(.*\)'`;; +esac +for ac_var in $ac_precious_vars; do + eval ac_env_${ac_var}_set=\${${ac_var}+set} + eval ac_env_${ac_var}_value=\$${ac_var} + eval ac_cv_env_${ac_var}_set=\${${ac_var}+set} + eval ac_cv_env_${ac_var}_value=\$${ac_var} +done + +# +# Report the --help message. +# +if test "$ac_init_help" = "long"; then + # Omit some internal or obsolete options to make the list less imposing. + # This message is too long to be a string in the A/UX 3.1 sh. + cat <<_ACEOF +\`configure' configures libconfig 1.4.9 to adapt to many kinds of systems. + +Usage: $0 [OPTION]... [VAR=VALUE]... + +To assign environment variables (e.g., CC, CFLAGS...), specify them as +VAR=VALUE. See below for descriptions of some of the useful variables. + +Defaults for the options are specified in brackets. + +Configuration: + -h, --help display this help and exit + --help=short display options specific to this package + --help=recursive display the short help of all the included packages + -V, --version display version information and exit + -q, --quiet, --silent do not print \`checking ...' messages + --cache-file=FILE cache test results in FILE [disabled] + -C, --config-cache alias for \`--cache-file=config.cache' + -n, --no-create do not create output files + --srcdir=DIR find the sources in DIR [configure dir or \`..'] + +Installation directories: + --prefix=PREFIX install architecture-independent files in PREFIX + [$ac_default_prefix] + --exec-prefix=EPREFIX install architecture-dependent files in EPREFIX + [PREFIX] + +By default, \`make install' will install all the files in +\`$ac_default_prefix/bin', \`$ac_default_prefix/lib' etc. You can specify +an installation prefix other than \`$ac_default_prefix' using \`--prefix', +for instance \`--prefix=\$HOME'. + +For better control, use the options below. + +Fine tuning of the installation directories: + --bindir=DIR user executables [EPREFIX/bin] + --sbindir=DIR system admin executables [EPREFIX/sbin] + --libexecdir=DIR program executables [EPREFIX/libexec] + --sysconfdir=DIR read-only single-machine data [PREFIX/etc] + --sharedstatedir=DIR modifiable architecture-independent data [PREFIX/com] + --localstatedir=DIR modifiable single-machine data [PREFIX/var] + --libdir=DIR object code libraries [EPREFIX/lib] + --includedir=DIR C header files [PREFIX/include] + --oldincludedir=DIR C header files for non-gcc [/usr/include] + --datarootdir=DIR read-only arch.-independent data root [PREFIX/share] + --datadir=DIR read-only architecture-independent data [DATAROOTDIR] + --infodir=DIR info documentation [DATAROOTDIR/info] + --localedir=DIR locale-dependent data [DATAROOTDIR/locale] + --mandir=DIR man documentation [DATAROOTDIR/man] + --docdir=DIR documentation root [DATAROOTDIR/doc/libconfig] + --htmldir=DIR html documentation [DOCDIR] + --dvidir=DIR dvi documentation [DOCDIR] + --pdfdir=DIR pdf documentation [DOCDIR] + --psdir=DIR ps documentation [DOCDIR] +_ACEOF + + cat <<\_ACEOF + +Program names: + --program-prefix=PREFIX prepend PREFIX to installed program names + --program-suffix=SUFFIX append SUFFIX to installed program names + --program-transform-name=PROGRAM run sed PROGRAM on installed program names + +System types: + --build=BUILD configure for building on BUILD [guessed] + --host=HOST cross-compile to build programs to run on HOST [BUILD] + --target=TARGET configure for building compilers for TARGET [HOST] +_ACEOF +fi + +if test -n "$ac_init_help"; then + case $ac_init_help in + short | recursive ) echo "Configuration of libconfig 1.4.9:";; + esac + cat <<\_ACEOF + +Optional Features: + --disable-option-checking ignore unrecognized --enable/--with options + --disable-FEATURE do not include FEATURE (same as --enable-FEATURE=no) + --enable-FEATURE[=ARG] include FEATURE [ARG=yes] + --disable-dependency-tracking speeds up one-time build + --enable-dependency-tracking do not reject slow dependency extractors + --enable-shared[=PKGS] build shared libraries [default=yes] + --enable-static[=PKGS] build static libraries [default=yes] + --enable-fast-install[=PKGS] + optimize for fast installation [default=yes] + --disable-libtool-lock avoid locking (might break parallel builds) + --disable-cxx Disable building of the C++ library + --disable-examples Disable building of the example programs + +Optional Packages: + --with-PACKAGE[=ARG] use PACKAGE [ARG=yes] + --without-PACKAGE do not use PACKAGE (same as --with-PACKAGE=no) + --with-pic[=PKGS] try to use only PIC/non-PIC objects [default=use + both] + --with-gnu-ld assume the C compiler uses GNU ld [default=no] + --with-sysroot=DIR Search for dependent libraries within DIR + (or the compiler's sysroot if not specified). + +Some influential environment variables: + CC C compiler command + CFLAGS C compiler flags + LDFLAGS linker flags, e.g. -L if you have libraries in a + nonstandard directory + LIBS libraries to pass to the linker, e.g. -l + CPPFLAGS (Objective) C/C++ preprocessor flags, e.g. -I if + you have headers in a nonstandard directory + CPP C preprocessor + CXX C++ compiler command + CXXFLAGS C++ compiler flags + CXXCPP C++ preprocessor + YACC The `Yet Another Compiler Compiler' implementation to use. + Defaults to the first program found out of: `bison -y', `byacc', + `yacc'. + YFLAGS The list of arguments that will be passed by default to $YACC. + This script will default YFLAGS to the empty string to avoid a + default value of `-d' given by some make applications. + +Use these variables to override the choices made by `configure' or to help +it to find libraries and programs with nonstandard names/locations. + +Report bugs to . +libconfig home page: . +_ACEOF +ac_status=$? +fi + +if test "$ac_init_help" = "recursive"; then + # If there are subdirs, report their specific --help. + for ac_dir in : $ac_subdirs_all; do test "x$ac_dir" = x: && continue + test -d "$ac_dir" || + { cd "$srcdir" && ac_pwd=`pwd` && srcdir=. && test -d "$ac_dir"; } || + continue + ac_builddir=. + +case "$ac_dir" in +.) ac_dir_suffix= ac_top_builddir_sub=. ac_top_build_prefix= ;; +*) + ac_dir_suffix=/`$as_echo "$ac_dir" | sed 's|^\.[\\/]||'` + # A ".." for each directory in $ac_dir_suffix. + ac_top_builddir_sub=`$as_echo "$ac_dir_suffix" | sed 's|/[^\\/]*|/..|g;s|/||'` + case $ac_top_builddir_sub in + "") ac_top_builddir_sub=. ac_top_build_prefix= ;; + *) ac_top_build_prefix=$ac_top_builddir_sub/ ;; + esac ;; +esac +ac_abs_top_builddir=$ac_pwd +ac_abs_builddir=$ac_pwd$ac_dir_suffix +# for backward compatibility: +ac_top_builddir=$ac_top_build_prefix + +case $srcdir in + .) # We are building in place. + ac_srcdir=. + ac_top_srcdir=$ac_top_builddir_sub + ac_abs_top_srcdir=$ac_pwd ;; + [\\/]* | ?:[\\/]* ) # Absolute name. + ac_srcdir=$srcdir$ac_dir_suffix; + ac_top_srcdir=$srcdir + ac_abs_top_srcdir=$srcdir ;; + *) # Relative name. + ac_srcdir=$ac_top_build_prefix$srcdir$ac_dir_suffix + ac_top_srcdir=$ac_top_build_prefix$srcdir + ac_abs_top_srcdir=$ac_pwd/$srcdir ;; +esac +ac_abs_srcdir=$ac_abs_top_srcdir$ac_dir_suffix + + cd "$ac_dir" || { ac_status=$?; continue; } + # Check for guested configure. + if test -f "$ac_srcdir/configure.gnu"; then + echo && + $SHELL "$ac_srcdir/configure.gnu" --help=recursive + elif test -f "$ac_srcdir/configure"; then + echo && + $SHELL "$ac_srcdir/configure" --help=recursive + else + $as_echo "$as_me: WARNING: no configuration information is in $ac_dir" >&2 + fi || ac_status=$? + cd "$ac_pwd" || { ac_status=$?; break; } + done +fi + +test -n "$ac_init_help" && exit $ac_status +if $ac_init_version; then + cat <<\_ACEOF +libconfig configure 1.4.9 +generated by GNU Autoconf 2.68 + +Copyright (C) 2010 Free Software Foundation, Inc. +This configure script is free software; the Free Software Foundation +gives unlimited permission to copy, distribute and modify it. +_ACEOF + exit +fi + +## ------------------------ ## +## Autoconf initialization. ## +## ------------------------ ## + +# ac_fn_c_try_compile LINENO +# -------------------------- +# Try to compile conftest.$ac_ext, and return whether this succeeded. +ac_fn_c_try_compile () +{ + as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack + rm -f conftest.$ac_objext + if { { ac_try="$ac_compile" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_compile") 2>conftest.err + ac_status=$? + if test -s conftest.err; then + grep -v '^ *+' conftest.err >conftest.er1 + cat conftest.er1 >&5 + mv -f conftest.er1 conftest.err + fi + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } && { + test -z "$ac_c_werror_flag" || + test ! -s conftest.err + } && test -s conftest.$ac_objext; then : + ac_retval=0 +else + $as_echo "$as_me: failed program was:" >&5 +sed 's/^/| /' conftest.$ac_ext >&5 + + ac_retval=1 +fi + eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno + as_fn_set_status $ac_retval + +} # ac_fn_c_try_compile + +# ac_fn_c_try_cpp LINENO +# ---------------------- +# Try to preprocess conftest.$ac_ext, and return whether this succeeded. +ac_fn_c_try_cpp () +{ + as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack + if { { ac_try="$ac_cpp conftest.$ac_ext" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_cpp conftest.$ac_ext") 2>conftest.err + ac_status=$? + if test -s conftest.err; then + grep -v '^ *+' conftest.err >conftest.er1 + cat conftest.er1 >&5 + mv -f conftest.er1 conftest.err + fi + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } > conftest.i && { + test -z "$ac_c_preproc_warn_flag$ac_c_werror_flag" || + test ! -s conftest.err + }; then : + ac_retval=0 +else + $as_echo "$as_me: failed program was:" >&5 +sed 's/^/| /' conftest.$ac_ext >&5 + + ac_retval=1 +fi + eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno + as_fn_set_status $ac_retval + +} # ac_fn_c_try_cpp + +# ac_fn_c_check_header_mongrel LINENO HEADER VAR INCLUDES +# ------------------------------------------------------- +# Tests whether HEADER exists, giving a warning if it cannot be compiled using +# the include files in INCLUDES and setting the cache variable VAR +# accordingly. +ac_fn_c_check_header_mongrel () +{ + as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack + if eval \${$3+:} false; then : + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for $2" >&5 +$as_echo_n "checking for $2... " >&6; } +if eval \${$3+:} false; then : + $as_echo_n "(cached) " >&6 +fi +eval ac_res=\$$3 + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_res" >&5 +$as_echo "$ac_res" >&6; } +else + # Is the header compilable? +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking $2 usability" >&5 +$as_echo_n "checking $2 usability... " >&6; } +cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +$4 +#include <$2> +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + ac_header_compiler=yes +else + ac_header_compiler=no +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_header_compiler" >&5 +$as_echo "$ac_header_compiler" >&6; } + +# Is the header present? +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking $2 presence" >&5 +$as_echo_n "checking $2 presence... " >&6; } +cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include <$2> +_ACEOF +if ac_fn_c_try_cpp "$LINENO"; then : + ac_header_preproc=yes +else + ac_header_preproc=no +fi +rm -f conftest.err conftest.i conftest.$ac_ext +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_header_preproc" >&5 +$as_echo "$ac_header_preproc" >&6; } + +# So? What about this header? +case $ac_header_compiler:$ac_header_preproc:$ac_c_preproc_warn_flag in #(( + yes:no: ) + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: accepted by the compiler, rejected by the preprocessor!" >&5 +$as_echo "$as_me: WARNING: $2: accepted by the compiler, rejected by the preprocessor!" >&2;} + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: proceeding with the compiler's result" >&5 +$as_echo "$as_me: WARNING: $2: proceeding with the compiler's result" >&2;} + ;; + no:yes:* ) + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: present but cannot be compiled" >&5 +$as_echo "$as_me: WARNING: $2: present but cannot be compiled" >&2;} + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: check for missing prerequisite headers?" >&5 +$as_echo "$as_me: WARNING: $2: check for missing prerequisite headers?" >&2;} + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: see the Autoconf documentation" >&5 +$as_echo "$as_me: WARNING: $2: see the Autoconf documentation" >&2;} + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: section \"Present But Cannot Be Compiled\"" >&5 +$as_echo "$as_me: WARNING: $2: section \"Present But Cannot Be Compiled\"" >&2;} + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $2: proceeding with the compiler's result" >&5 +$as_echo "$as_me: WARNING: $2: proceeding with the compiler's result" >&2;} +( $as_echo "## ----------------------------------- ## +## Report this to hyperrealm@gmail.com ## +## ----------------------------------- ##" + ) | sed "s/^/$as_me: WARNING: /" >&2 + ;; +esac + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for $2" >&5 +$as_echo_n "checking for $2... " >&6; } +if eval \${$3+:} false; then : + $as_echo_n "(cached) " >&6 +else + eval "$3=\$ac_header_compiler" +fi +eval ac_res=\$$3 + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_res" >&5 +$as_echo "$ac_res" >&6; } +fi + eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno + +} # ac_fn_c_check_header_mongrel + +# ac_fn_c_try_run LINENO +# ---------------------- +# Try to link conftest.$ac_ext, and return whether this succeeded. Assumes +# that executables *can* be run. +ac_fn_c_try_run () +{ + as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack + if { { ac_try="$ac_link" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_link") 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } && { ac_try='./conftest$ac_exeext' + { { case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_try") 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; }; then : + ac_retval=0 +else + $as_echo "$as_me: program exited with status $ac_status" >&5 + $as_echo "$as_me: failed program was:" >&5 +sed 's/^/| /' conftest.$ac_ext >&5 + + ac_retval=$ac_status +fi + rm -rf conftest.dSYM conftest_ipa8_conftest.oo + eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno + as_fn_set_status $ac_retval + +} # ac_fn_c_try_run + +# ac_fn_c_check_header_compile LINENO HEADER VAR INCLUDES +# ------------------------------------------------------- +# Tests whether HEADER exists and can be compiled using the include files in +# INCLUDES, setting the cache variable VAR accordingly. +ac_fn_c_check_header_compile () +{ + as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for $2" >&5 +$as_echo_n "checking for $2... " >&6; } +if eval \${$3+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +$4 +#include <$2> +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + eval "$3=yes" +else + eval "$3=no" +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext +fi +eval ac_res=\$$3 + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_res" >&5 +$as_echo "$ac_res" >&6; } + eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno + +} # ac_fn_c_check_header_compile + +# ac_fn_c_try_link LINENO +# ----------------------- +# Try to link conftest.$ac_ext, and return whether this succeeded. +ac_fn_c_try_link () +{ + as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack + rm -f conftest.$ac_objext conftest$ac_exeext + if { { ac_try="$ac_link" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_link") 2>conftest.err + ac_status=$? + if test -s conftest.err; then + grep -v '^ *+' conftest.err >conftest.er1 + cat conftest.er1 >&5 + mv -f conftest.er1 conftest.err + fi + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } && { + test -z "$ac_c_werror_flag" || + test ! -s conftest.err + } && test -s conftest$ac_exeext && { + test "$cross_compiling" = yes || + $as_test_x conftest$ac_exeext + }; then : + ac_retval=0 +else + $as_echo "$as_me: failed program was:" >&5 +sed 's/^/| /' conftest.$ac_ext >&5 + + ac_retval=1 +fi + # Delete the IPA/IPO (Inter Procedural Analysis/Optimization) information + # created by the PGI compiler (conftest_ipa8_conftest.oo), as it would + # interfere with the next link command; also delete a directory that is + # left behind by Apple's compiler. We do this before executing the actions. + rm -rf conftest.dSYM conftest_ipa8_conftest.oo + eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno + as_fn_set_status $ac_retval + +} # ac_fn_c_try_link + +# ac_fn_c_check_func LINENO FUNC VAR +# ---------------------------------- +# Tests whether FUNC exists, setting the cache variable VAR accordingly +ac_fn_c_check_func () +{ + as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for $2" >&5 +$as_echo_n "checking for $2... " >&6; } +if eval \${$3+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +/* Define $2 to an innocuous variant, in case declares $2. + For example, HP-UX 11i declares gettimeofday. */ +#define $2 innocuous_$2 + +/* System header to define __stub macros and hopefully few prototypes, + which can conflict with char $2 (); below. + Prefer to if __STDC__ is defined, since + exists even on freestanding compilers. */ + +#ifdef __STDC__ +# include +#else +# include +#endif + +#undef $2 + +/* Override any GCC internal prototype to avoid an error. + Use char because int might match the return type of a GCC + builtin and then its argument prototype would still apply. */ +#ifdef __cplusplus +extern "C" +#endif +char $2 (); +/* The GNU C library defines this for functions which it implements + to always fail with ENOSYS. Some functions are actually named + something starting with __ and the normal name is an alias. */ +#if defined __stub_$2 || defined __stub___$2 +choke me +#endif + +int +main () +{ +return $2 (); + ; + return 0; +} +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + eval "$3=yes" +else + eval "$3=no" +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext +fi +eval ac_res=\$$3 + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_res" >&5 +$as_echo "$ac_res" >&6; } + eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno + +} # ac_fn_c_check_func + +# ac_fn_cxx_try_compile LINENO +# ---------------------------- +# Try to compile conftest.$ac_ext, and return whether this succeeded. +ac_fn_cxx_try_compile () +{ + as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack + rm -f conftest.$ac_objext + if { { ac_try="$ac_compile" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_compile") 2>conftest.err + ac_status=$? + if test -s conftest.err; then + grep -v '^ *+' conftest.err >conftest.er1 + cat conftest.er1 >&5 + mv -f conftest.er1 conftest.err + fi + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } && { + test -z "$ac_cxx_werror_flag" || + test ! -s conftest.err + } && test -s conftest.$ac_objext; then : + ac_retval=0 +else + $as_echo "$as_me: failed program was:" >&5 +sed 's/^/| /' conftest.$ac_ext >&5 + + ac_retval=1 +fi + eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno + as_fn_set_status $ac_retval + +} # ac_fn_cxx_try_compile + +# ac_fn_cxx_try_cpp LINENO +# ------------------------ +# Try to preprocess conftest.$ac_ext, and return whether this succeeded. +ac_fn_cxx_try_cpp () +{ + as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack + if { { ac_try="$ac_cpp conftest.$ac_ext" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_cpp conftest.$ac_ext") 2>conftest.err + ac_status=$? + if test -s conftest.err; then + grep -v '^ *+' conftest.err >conftest.er1 + cat conftest.er1 >&5 + mv -f conftest.er1 conftest.err + fi + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } > conftest.i && { + test -z "$ac_cxx_preproc_warn_flag$ac_cxx_werror_flag" || + test ! -s conftest.err + }; then : + ac_retval=0 +else + $as_echo "$as_me: failed program was:" >&5 +sed 's/^/| /' conftest.$ac_ext >&5 + + ac_retval=1 +fi + eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno + as_fn_set_status $ac_retval + +} # ac_fn_cxx_try_cpp + +# ac_fn_cxx_try_link LINENO +# ------------------------- +# Try to link conftest.$ac_ext, and return whether this succeeded. +ac_fn_cxx_try_link () +{ + as_lineno=${as_lineno-"$1"} as_lineno_stack=as_lineno_stack=$as_lineno_stack + rm -f conftest.$ac_objext conftest$ac_exeext + if { { ac_try="$ac_link" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_link") 2>conftest.err + ac_status=$? + if test -s conftest.err; then + grep -v '^ *+' conftest.err >conftest.er1 + cat conftest.er1 >&5 + mv -f conftest.er1 conftest.err + fi + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } && { + test -z "$ac_cxx_werror_flag" || + test ! -s conftest.err + } && test -s conftest$ac_exeext && { + test "$cross_compiling" = yes || + $as_test_x conftest$ac_exeext + }; then : + ac_retval=0 +else + $as_echo "$as_me: failed program was:" >&5 +sed 's/^/| /' conftest.$ac_ext >&5 + + ac_retval=1 +fi + # Delete the IPA/IPO (Inter Procedural Analysis/Optimization) information + # created by the PGI compiler (conftest_ipa8_conftest.oo), as it would + # interfere with the next link command; also delete a directory that is + # left behind by Apple's compiler. We do this before executing the actions. + rm -rf conftest.dSYM conftest_ipa8_conftest.oo + eval $as_lineno_stack; ${as_lineno_stack:+:} unset as_lineno + as_fn_set_status $ac_retval + +} # ac_fn_cxx_try_link +cat >config.log <<_ACEOF +This file contains any messages produced by compilers while +running configure, to aid debugging if configure makes a mistake. + +It was created by libconfig $as_me 1.4.9, which was +generated by GNU Autoconf 2.68. Invocation command line was + + $ $0 $@ + +_ACEOF +exec 5>>config.log +{ +cat <<_ASUNAME +## --------- ## +## Platform. ## +## --------- ## + +hostname = `(hostname || uname -n) 2>/dev/null | sed 1q` +uname -m = `(uname -m) 2>/dev/null || echo unknown` +uname -r = `(uname -r) 2>/dev/null || echo unknown` +uname -s = `(uname -s) 2>/dev/null || echo unknown` +uname -v = `(uname -v) 2>/dev/null || echo unknown` + +/usr/bin/uname -p = `(/usr/bin/uname -p) 2>/dev/null || echo unknown` +/bin/uname -X = `(/bin/uname -X) 2>/dev/null || echo unknown` + +/bin/arch = `(/bin/arch) 2>/dev/null || echo unknown` +/usr/bin/arch -k = `(/usr/bin/arch -k) 2>/dev/null || echo unknown` +/usr/convex/getsysinfo = `(/usr/convex/getsysinfo) 2>/dev/null || echo unknown` +/usr/bin/hostinfo = `(/usr/bin/hostinfo) 2>/dev/null || echo unknown` +/bin/machine = `(/bin/machine) 2>/dev/null || echo unknown` +/usr/bin/oslevel = `(/usr/bin/oslevel) 2>/dev/null || echo unknown` +/bin/universe = `(/bin/universe) 2>/dev/null || echo unknown` + +_ASUNAME + +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + $as_echo "PATH: $as_dir" + done +IFS=$as_save_IFS + +} >&5 + +cat >&5 <<_ACEOF + + +## ----------- ## +## Core tests. ## +## ----------- ## + +_ACEOF + + +# Keep a trace of the command line. +# Strip out --no-create and --no-recursion so they do not pile up. +# Strip out --silent because we don't want to record it for future runs. +# Also quote any args containing shell meta-characters. +# Make two passes to allow for proper duplicate-argument suppression. +ac_configure_args= +ac_configure_args0= +ac_configure_args1= +ac_must_keep_next=false +for ac_pass in 1 2 +do + for ac_arg + do + case $ac_arg in + -no-create | --no-c* | -n | -no-recursion | --no-r*) continue ;; + -q | -quiet | --quiet | --quie | --qui | --qu | --q \ + | -silent | --silent | --silen | --sile | --sil) + continue ;; + *\'*) + ac_arg=`$as_echo "$ac_arg" | sed "s/'/'\\\\\\\\''/g"` ;; + esac + case $ac_pass in + 1) as_fn_append ac_configure_args0 " '$ac_arg'" ;; + 2) + as_fn_append ac_configure_args1 " '$ac_arg'" + if test $ac_must_keep_next = true; then + ac_must_keep_next=false # Got value, back to normal. + else + case $ac_arg in + *=* | --config-cache | -C | -disable-* | --disable-* \ + | -enable-* | --enable-* | -gas | --g* | -nfp | --nf* \ + | -q | -quiet | --q* | -silent | --sil* | -v | -verb* \ + | -with-* | --with-* | -without-* | --without-* | --x) + case "$ac_configure_args0 " in + "$ac_configure_args1"*" '$ac_arg' "* ) continue ;; + esac + ;; + -* ) ac_must_keep_next=true ;; + esac + fi + as_fn_append ac_configure_args " '$ac_arg'" + ;; + esac + done +done +{ ac_configure_args0=; unset ac_configure_args0;} +{ ac_configure_args1=; unset ac_configure_args1;} + +# When interrupted or exit'd, cleanup temporary files, and complete +# config.log. We remove comments because anyway the quotes in there +# would cause problems or look ugly. +# WARNING: Use '\'' to represent an apostrophe within the trap. +# WARNING: Do not start the trap code with a newline, due to a FreeBSD 4.0 bug. +trap 'exit_status=$? + # Save into config.log some information that might help in debugging. + { + echo + + $as_echo "## ---------------- ## +## Cache variables. ## +## ---------------- ##" + echo + # The following way of writing the cache mishandles newlines in values, +( + for ac_var in `(set) 2>&1 | sed -n '\''s/^\([a-zA-Z_][a-zA-Z0-9_]*\)=.*/\1/p'\''`; do + eval ac_val=\$$ac_var + case $ac_val in #( + *${as_nl}*) + case $ac_var in #( + *_cv_*) { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: cache variable $ac_var contains a newline" >&5 +$as_echo "$as_me: WARNING: cache variable $ac_var contains a newline" >&2;} ;; + esac + case $ac_var in #( + _ | IFS | as_nl) ;; #( + BASH_ARGV | BASH_SOURCE) eval $ac_var= ;; #( + *) { eval $ac_var=; unset $ac_var;} ;; + esac ;; + esac + done + (set) 2>&1 | + case $as_nl`(ac_space='\'' '\''; set) 2>&1` in #( + *${as_nl}ac_space=\ *) + sed -n \ + "s/'\''/'\''\\\\'\'''\''/g; + s/^\\([_$as_cr_alnum]*_cv_[_$as_cr_alnum]*\\)=\\(.*\\)/\\1='\''\\2'\''/p" + ;; #( + *) + sed -n "/^[_$as_cr_alnum]*_cv_[_$as_cr_alnum]*=/p" + ;; + esac | + sort +) + echo + + $as_echo "## ----------------- ## +## Output variables. ## +## ----------------- ##" + echo + for ac_var in $ac_subst_vars + do + eval ac_val=\$$ac_var + case $ac_val in + *\'\''*) ac_val=`$as_echo "$ac_val" | sed "s/'\''/'\''\\\\\\\\'\'''\''/g"`;; + esac + $as_echo "$ac_var='\''$ac_val'\''" + done | sort + echo + + if test -n "$ac_subst_files"; then + $as_echo "## ------------------- ## +## File substitutions. ## +## ------------------- ##" + echo + for ac_var in $ac_subst_files + do + eval ac_val=\$$ac_var + case $ac_val in + *\'\''*) ac_val=`$as_echo "$ac_val" | sed "s/'\''/'\''\\\\\\\\'\'''\''/g"`;; + esac + $as_echo "$ac_var='\''$ac_val'\''" + done | sort + echo + fi + + if test -s confdefs.h; then + $as_echo "## ----------- ## +## confdefs.h. ## +## ----------- ##" + echo + cat confdefs.h + echo + fi + test "$ac_signal" != 0 && + $as_echo "$as_me: caught signal $ac_signal" + $as_echo "$as_me: exit $exit_status" + } >&5 + rm -f core *.core core.conftest.* && + rm -f -r conftest* confdefs* conf$$* $ac_clean_files && + exit $exit_status +' 0 +for ac_signal in 1 2 13 15; do + trap 'ac_signal='$ac_signal'; as_fn_exit 1' $ac_signal +done +ac_signal=0 + +# confdefs.h avoids OS command line length limits that DEFS can exceed. +rm -f -r conftest* confdefs.h + +$as_echo "/* confdefs.h */" > confdefs.h + +# Predefined preprocessor variables. + +cat >>confdefs.h <<_ACEOF +#define PACKAGE_NAME "$PACKAGE_NAME" +_ACEOF + +cat >>confdefs.h <<_ACEOF +#define PACKAGE_TARNAME "$PACKAGE_TARNAME" +_ACEOF + +cat >>confdefs.h <<_ACEOF +#define PACKAGE_VERSION "$PACKAGE_VERSION" +_ACEOF + +cat >>confdefs.h <<_ACEOF +#define PACKAGE_STRING "$PACKAGE_STRING" +_ACEOF + +cat >>confdefs.h <<_ACEOF +#define PACKAGE_BUGREPORT "$PACKAGE_BUGREPORT" +_ACEOF + +cat >>confdefs.h <<_ACEOF +#define PACKAGE_URL "$PACKAGE_URL" +_ACEOF + + +# Let the site file select an alternate cache file if it wants to. +# Prefer an explicitly selected file to automatically selected ones. +ac_site_file1=NONE +ac_site_file2=NONE +if test -n "$CONFIG_SITE"; then + # We do not want a PATH search for config.site. + case $CONFIG_SITE in #(( + -*) ac_site_file1=./$CONFIG_SITE;; + */*) ac_site_file1=$CONFIG_SITE;; + *) ac_site_file1=./$CONFIG_SITE;; + esac +elif test "x$prefix" != xNONE; then + ac_site_file1=$prefix/share/config.site + ac_site_file2=$prefix/etc/config.site +else + ac_site_file1=$ac_default_prefix/share/config.site + ac_site_file2=$ac_default_prefix/etc/config.site +fi +for ac_site_file in "$ac_site_file1" "$ac_site_file2" +do + test "x$ac_site_file" = xNONE && continue + if test /dev/null != "$ac_site_file" && test -r "$ac_site_file"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: loading site script $ac_site_file" >&5 +$as_echo "$as_me: loading site script $ac_site_file" >&6;} + sed 's/^/| /' "$ac_site_file" >&5 + . "$ac_site_file" \ + || { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 +$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} +as_fn_error $? "failed to load site script $ac_site_file +See \`config.log' for more details" "$LINENO" 5; } + fi +done + +if test -r "$cache_file"; then + # Some versions of bash will fail to source /dev/null (special files + # actually), so we avoid doing that. DJGPP emulates it as a regular file. + if test /dev/null != "$cache_file" && test -f "$cache_file"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: loading cache $cache_file" >&5 +$as_echo "$as_me: loading cache $cache_file" >&6;} + case $cache_file in + [\\/]* | ?:[\\/]* ) . "$cache_file";; + *) . "./$cache_file";; + esac + fi +else + { $as_echo "$as_me:${as_lineno-$LINENO}: creating cache $cache_file" >&5 +$as_echo "$as_me: creating cache $cache_file" >&6;} + >$cache_file +fi + +# Check that the precious variables saved in the cache have kept the same +# value. +ac_cache_corrupted=false +for ac_var in $ac_precious_vars; do + eval ac_old_set=\$ac_cv_env_${ac_var}_set + eval ac_new_set=\$ac_env_${ac_var}_set + eval ac_old_val=\$ac_cv_env_${ac_var}_value + eval ac_new_val=\$ac_env_${ac_var}_value + case $ac_old_set,$ac_new_set in + set,) + { $as_echo "$as_me:${as_lineno-$LINENO}: error: \`$ac_var' was set to \`$ac_old_val' in the previous run" >&5 +$as_echo "$as_me: error: \`$ac_var' was set to \`$ac_old_val' in the previous run" >&2;} + ac_cache_corrupted=: ;; + ,set) + { $as_echo "$as_me:${as_lineno-$LINENO}: error: \`$ac_var' was not set in the previous run" >&5 +$as_echo "$as_me: error: \`$ac_var' was not set in the previous run" >&2;} + ac_cache_corrupted=: ;; + ,);; + *) + if test "x$ac_old_val" != "x$ac_new_val"; then + # differences in whitespace do not lead to failure. + ac_old_val_w=`echo x $ac_old_val` + ac_new_val_w=`echo x $ac_new_val` + if test "$ac_old_val_w" != "$ac_new_val_w"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: error: \`$ac_var' has changed since the previous run:" >&5 +$as_echo "$as_me: error: \`$ac_var' has changed since the previous run:" >&2;} + ac_cache_corrupted=: + else + { $as_echo "$as_me:${as_lineno-$LINENO}: warning: ignoring whitespace changes in \`$ac_var' since the previous run:" >&5 +$as_echo "$as_me: warning: ignoring whitespace changes in \`$ac_var' since the previous run:" >&2;} + eval $ac_var=\$ac_old_val + fi + { $as_echo "$as_me:${as_lineno-$LINENO}: former value: \`$ac_old_val'" >&5 +$as_echo "$as_me: former value: \`$ac_old_val'" >&2;} + { $as_echo "$as_me:${as_lineno-$LINENO}: current value: \`$ac_new_val'" >&5 +$as_echo "$as_me: current value: \`$ac_new_val'" >&2;} + fi;; + esac + # Pass precious variables to config.status. + if test "$ac_new_set" = set; then + case $ac_new_val in + *\'*) ac_arg=$ac_var=`$as_echo "$ac_new_val" | sed "s/'/'\\\\\\\\''/g"` ;; + *) ac_arg=$ac_var=$ac_new_val ;; + esac + case " $ac_configure_args " in + *" '$ac_arg' "*) ;; # Avoid dups. Use of quotes ensures accuracy. + *) as_fn_append ac_configure_args " '$ac_arg'" ;; + esac + fi +done +if $ac_cache_corrupted; then + { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 +$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} + { $as_echo "$as_me:${as_lineno-$LINENO}: error: changes in the environment can compromise the build" >&5 +$as_echo "$as_me: error: changes in the environment can compromise the build" >&2;} + as_fn_error $? "run \`make distclean' and/or \`rm $cache_file' and start over" "$LINENO" 5 +fi +## -------------------- ## +## Main body of script. ## +## -------------------- ## + +ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu + + +ac_aux_dir= +for ac_dir in aux-build "$srcdir"/aux-build; do + if test -f "$ac_dir/install-sh"; then + ac_aux_dir=$ac_dir + ac_install_sh="$ac_aux_dir/install-sh -c" + break + elif test -f "$ac_dir/install.sh"; then + ac_aux_dir=$ac_dir + ac_install_sh="$ac_aux_dir/install.sh -c" + break + elif test -f "$ac_dir/shtool"; then + ac_aux_dir=$ac_dir + ac_install_sh="$ac_aux_dir/shtool install -c" + break + fi +done +if test -z "$ac_aux_dir"; then + as_fn_error $? "cannot find install-sh, install.sh, or shtool in aux-build \"$srcdir\"/aux-build" "$LINENO" 5 +fi + +# These three variables are undocumented and unsupported, +# and are intended to be withdrawn in a future Autoconf release. +# They can cause serious problems if a builder's source tree is in a directory +# whose full name contains unusual characters. +ac_config_guess="$SHELL $ac_aux_dir/config.guess" # Please don't use this var. +ac_config_sub="$SHELL $ac_aux_dir/config.sub" # Please don't use this var. +ac_configure="$SHELL $ac_aux_dir/configure" # Please don't use this var. + + + +# Make sure we can run config.sub. +$SHELL "$ac_aux_dir/config.sub" sun4 >/dev/null 2>&1 || + as_fn_error $? "cannot run $SHELL $ac_aux_dir/config.sub" "$LINENO" 5 + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking build system type" >&5 +$as_echo_n "checking build system type... " >&6; } +if ${ac_cv_build+:} false; then : + $as_echo_n "(cached) " >&6 +else + ac_build_alias=$build_alias +test "x$ac_build_alias" = x && + ac_build_alias=`$SHELL "$ac_aux_dir/config.guess"` +test "x$ac_build_alias" = x && + as_fn_error $? "cannot guess build type; you must specify one" "$LINENO" 5 +ac_cv_build=`$SHELL "$ac_aux_dir/config.sub" $ac_build_alias` || + as_fn_error $? "$SHELL $ac_aux_dir/config.sub $ac_build_alias failed" "$LINENO" 5 + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_build" >&5 +$as_echo "$ac_cv_build" >&6; } +case $ac_cv_build in +*-*-*) ;; +*) as_fn_error $? "invalid value of canonical build" "$LINENO" 5;; +esac +build=$ac_cv_build +ac_save_IFS=$IFS; IFS='-' +set x $ac_cv_build +shift +build_cpu=$1 +build_vendor=$2 +shift; shift +# Remember, the first character of IFS is used to create $*, +# except with old shells: +build_os=$* +IFS=$ac_save_IFS +case $build_os in *\ *) build_os=`echo "$build_os" | sed 's/ /-/g'`;; esac + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking host system type" >&5 +$as_echo_n "checking host system type... " >&6; } +if ${ac_cv_host+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test "x$host_alias" = x; then + ac_cv_host=$ac_cv_build +else + ac_cv_host=`$SHELL "$ac_aux_dir/config.sub" $host_alias` || + as_fn_error $? "$SHELL $ac_aux_dir/config.sub $host_alias failed" "$LINENO" 5 +fi + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_host" >&5 +$as_echo "$ac_cv_host" >&6; } +case $ac_cv_host in +*-*-*) ;; +*) as_fn_error $? "invalid value of canonical host" "$LINENO" 5;; +esac +host=$ac_cv_host +ac_save_IFS=$IFS; IFS='-' +set x $ac_cv_host +shift +host_cpu=$1 +host_vendor=$2 +shift; shift +# Remember, the first character of IFS is used to create $*, +# except with old shells: +host_os=$* +IFS=$ac_save_IFS +case $host_os in *\ *) host_os=`echo "$host_os" | sed 's/ /-/g'`;; esac + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking target system type" >&5 +$as_echo_n "checking target system type... " >&6; } +if ${ac_cv_target+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test "x$target_alias" = x; then + ac_cv_target=$ac_cv_host +else + ac_cv_target=`$SHELL "$ac_aux_dir/config.sub" $target_alias` || + as_fn_error $? "$SHELL $ac_aux_dir/config.sub $target_alias failed" "$LINENO" 5 +fi + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_target" >&5 +$as_echo "$ac_cv_target" >&6; } +case $ac_cv_target in +*-*-*) ;; +*) as_fn_error $? "invalid value of canonical target" "$LINENO" 5;; +esac +target=$ac_cv_target +ac_save_IFS=$IFS; IFS='-' +set x $ac_cv_target +shift +target_cpu=$1 +target_vendor=$2 +shift; shift +# Remember, the first character of IFS is used to create $*, +# except with old shells: +target_os=$* +IFS=$ac_save_IFS +case $target_os in *\ *) target_os=`echo "$target_os" | sed 's/ /-/g'`;; esac + + +# The aliases save the names the user supplied, while $host etc. +# will get canonicalized. +test -n "$target_alias" && + test "$program_prefix$program_suffix$program_transform_name" = \ + NONENONEs,x,x, && + program_prefix=${target_alias}- +am__api_version='1.11' + +# Find a good install program. We prefer a C program (faster), +# so one script is as good as another. But avoid the broken or +# incompatible versions: +# SysV /etc/install, /usr/sbin/install +# SunOS /usr/etc/install +# IRIX /sbin/install +# AIX /bin/install +# AmigaOS /C/install, which installs bootblocks on floppy discs +# AIX 4 /usr/bin/installbsd, which doesn't work without a -g flag +# AFS /usr/afsws/bin/install, which mishandles nonexistent args +# SVR4 /usr/ucb/install, which tries to use the nonexistent group "staff" +# OS/2's system install, which has a completely different semantic +# ./install, which can be erroneously created by make from ./install.sh. +# Reject install programs that cannot install multiple files. +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for a BSD-compatible install" >&5 +$as_echo_n "checking for a BSD-compatible install... " >&6; } +if test -z "$INSTALL"; then +if ${ac_cv_path_install+:} false; then : + $as_echo_n "(cached) " >&6 +else + as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + # Account for people who put trailing slashes in PATH elements. +case $as_dir/ in #(( + ./ | .// | /[cC]/* | \ + /etc/* | /usr/sbin/* | /usr/etc/* | /sbin/* | /usr/afsws/bin/* | \ + ?:[\\/]os2[\\/]install[\\/]* | ?:[\\/]OS2[\\/]INSTALL[\\/]* | \ + /usr/ucb/* ) ;; + *) + # OSF1 and SCO ODT 3.0 have their own names for install. + # Don't use installbsd from OSF since it installs stuff as root + # by default. + for ac_prog in ginstall scoinst install; do + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_prog$ac_exec_ext" && $as_test_x "$as_dir/$ac_prog$ac_exec_ext"; }; then + if test $ac_prog = install && + grep dspmsg "$as_dir/$ac_prog$ac_exec_ext" >/dev/null 2>&1; then + # AIX install. It has an incompatible calling convention. + : + elif test $ac_prog = install && + grep pwplus "$as_dir/$ac_prog$ac_exec_ext" >/dev/null 2>&1; then + # program-specific install script used by HP pwplus--don't use. + : + else + rm -rf conftest.one conftest.two conftest.dir + echo one > conftest.one + echo two > conftest.two + mkdir conftest.dir + if "$as_dir/$ac_prog$ac_exec_ext" -c conftest.one conftest.two "`pwd`/conftest.dir" && + test -s conftest.one && test -s conftest.two && + test -s conftest.dir/conftest.one && + test -s conftest.dir/conftest.two + then + ac_cv_path_install="$as_dir/$ac_prog$ac_exec_ext -c" + break 3 + fi + fi + fi + done + done + ;; +esac + + done +IFS=$as_save_IFS + +rm -rf conftest.one conftest.two conftest.dir + +fi + if test "${ac_cv_path_install+set}" = set; then + INSTALL=$ac_cv_path_install + else + # As a last resort, use the slow shell script. Don't cache a + # value for INSTALL within a source directory, because that will + # break other packages using the cache if that directory is + # removed, or if the value is a relative name. + INSTALL=$ac_install_sh + fi +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $INSTALL" >&5 +$as_echo "$INSTALL" >&6; } + +# Use test -z because SunOS4 sh mishandles braces in ${var-val}. +# It thinks the first close brace ends the variable substitution. +test -z "$INSTALL_PROGRAM" && INSTALL_PROGRAM='${INSTALL}' + +test -z "$INSTALL_SCRIPT" && INSTALL_SCRIPT='${INSTALL}' + +test -z "$INSTALL_DATA" && INSTALL_DATA='${INSTALL} -m 644' + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether build environment is sane" >&5 +$as_echo_n "checking whether build environment is sane... " >&6; } +# Just in case +sleep 1 +echo timestamp > conftest.file +# Reject unsafe characters in $srcdir or the absolute working directory +# name. Accept space and tab only in the latter. +am_lf=' +' +case `pwd` in + *[\\\"\#\$\&\'\`$am_lf]*) + as_fn_error $? "unsafe absolute working directory name" "$LINENO" 5;; +esac +case $srcdir in + *[\\\"\#\$\&\'\`$am_lf\ \ ]*) + as_fn_error $? "unsafe srcdir value: \`$srcdir'" "$LINENO" 5;; +esac + +# Do `set' in a subshell so we don't clobber the current shell's +# arguments. Must try -L first in case configure is actually a +# symlink; some systems play weird games with the mod time of symlinks +# (eg FreeBSD returns the mod time of the symlink's containing +# directory). +if ( + set X `ls -Lt "$srcdir/configure" conftest.file 2> /dev/null` + if test "$*" = "X"; then + # -L didn't work. + set X `ls -t "$srcdir/configure" conftest.file` + fi + rm -f conftest.file + if test "$*" != "X $srcdir/configure conftest.file" \ + && test "$*" != "X conftest.file $srcdir/configure"; then + + # If neither matched, then we have a broken ls. This can happen + # if, for instance, CONFIG_SHELL is bash and it inherits a + # broken ls alias from the environment. This has actually + # happened. Such a system could not be considered "sane". + as_fn_error $? "ls -t appears to fail. Make sure there is not a broken +alias in your environment" "$LINENO" 5 + fi + + test "$2" = conftest.file + ) +then + # Ok. + : +else + as_fn_error $? "newly created file is older than distributed files! +Check your system clock" "$LINENO" 5 +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 +$as_echo "yes" >&6; } +test "$program_prefix" != NONE && + program_transform_name="s&^&$program_prefix&;$program_transform_name" +# Use a double $ so make ignores it. +test "$program_suffix" != NONE && + program_transform_name="s&\$&$program_suffix&;$program_transform_name" +# Double any \ or $. +# By default was `s,x,x', remove it if useless. +ac_script='s/[\\$]/&&/g;s/;s,x,x,$//' +program_transform_name=`$as_echo "$program_transform_name" | sed "$ac_script"` + +# expand $ac_aux_dir to an absolute path +am_aux_dir=`cd $ac_aux_dir && pwd` + +if test x"${MISSING+set}" != xset; then + case $am_aux_dir in + *\ * | *\ *) + MISSING="\${SHELL} \"$am_aux_dir/missing\"" ;; + *) + MISSING="\${SHELL} $am_aux_dir/missing" ;; + esac +fi +# Use eval to expand $SHELL +if eval "$MISSING --run true"; then + am_missing_run="$MISSING --run " +else + am_missing_run= + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: \`missing' script is too old or missing" >&5 +$as_echo "$as_me: WARNING: \`missing' script is too old or missing" >&2;} +fi + +if test x"${install_sh}" != xset; then + case $am_aux_dir in + *\ * | *\ *) + install_sh="\${SHELL} '$am_aux_dir/install-sh'" ;; + *) + install_sh="\${SHELL} $am_aux_dir/install-sh" + esac +fi + +# Installed binaries are usually stripped using `strip' when the user +# run `make install-strip'. However `strip' might not be the right +# tool to use in cross-compilation environments, therefore Automake +# will honor the `STRIP' environment variable to overrule this program. +if test "$cross_compiling" != no; then + if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}strip", so it can be a program name with args. +set dummy ${ac_tool_prefix}strip; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_STRIP+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$STRIP"; then + ac_cv_prog_STRIP="$STRIP" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_STRIP="${ac_tool_prefix}strip" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +STRIP=$ac_cv_prog_STRIP +if test -n "$STRIP"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $STRIP" >&5 +$as_echo "$STRIP" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_STRIP"; then + ac_ct_STRIP=$STRIP + # Extract the first word of "strip", so it can be a program name with args. +set dummy strip; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_STRIP+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_STRIP"; then + ac_cv_prog_ac_ct_STRIP="$ac_ct_STRIP" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_STRIP="strip" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_STRIP=$ac_cv_prog_ac_ct_STRIP +if test -n "$ac_ct_STRIP"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_STRIP" >&5 +$as_echo "$ac_ct_STRIP" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_STRIP" = x; then + STRIP=":" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + STRIP=$ac_ct_STRIP + fi +else + STRIP="$ac_cv_prog_STRIP" +fi + +fi +INSTALL_STRIP_PROGRAM="\$(install_sh) -c -s" + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for a thread-safe mkdir -p" >&5 +$as_echo_n "checking for a thread-safe mkdir -p... " >&6; } +if test -z "$MKDIR_P"; then + if ${ac_cv_path_mkdir+:} false; then : + $as_echo_n "(cached) " >&6 +else + as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH$PATH_SEPARATOR/opt/sfw/bin +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_prog in mkdir gmkdir; do + for ac_exec_ext in '' $ac_executable_extensions; do + { test -f "$as_dir/$ac_prog$ac_exec_ext" && $as_test_x "$as_dir/$ac_prog$ac_exec_ext"; } || continue + case `"$as_dir/$ac_prog$ac_exec_ext" --version 2>&1` in #( + 'mkdir (GNU coreutils) '* | \ + 'mkdir (coreutils) '* | \ + 'mkdir (fileutils) '4.1*) + ac_cv_path_mkdir=$as_dir/$ac_prog$ac_exec_ext + break 3;; + esac + done + done + done +IFS=$as_save_IFS + +fi + + test -d ./--version && rmdir ./--version + if test "${ac_cv_path_mkdir+set}" = set; then + MKDIR_P="$ac_cv_path_mkdir -p" + else + # As a last resort, use the slow shell script. Don't cache a + # value for MKDIR_P within a source directory, because that will + # break other packages using the cache if that directory is + # removed, or if the value is a relative name. + MKDIR_P="$ac_install_sh -d" + fi +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $MKDIR_P" >&5 +$as_echo "$MKDIR_P" >&6; } + +mkdir_p="$MKDIR_P" +case $mkdir_p in + [\\/$]* | ?:[\\/]*) ;; + */*) mkdir_p="\$(top_builddir)/$mkdir_p" ;; +esac + +for ac_prog in gawk mawk nawk awk +do + # Extract the first word of "$ac_prog", so it can be a program name with args. +set dummy $ac_prog; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_AWK+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$AWK"; then + ac_cv_prog_AWK="$AWK" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_AWK="$ac_prog" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +AWK=$ac_cv_prog_AWK +if test -n "$AWK"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $AWK" >&5 +$as_echo "$AWK" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + test -n "$AWK" && break +done + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether ${MAKE-make} sets \$(MAKE)" >&5 +$as_echo_n "checking whether ${MAKE-make} sets \$(MAKE)... " >&6; } +set x ${MAKE-make} +ac_make=`$as_echo "$2" | sed 's/+/p/g; s/[^a-zA-Z0-9_]/_/g'` +if eval \${ac_cv_prog_make_${ac_make}_set+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat >conftest.make <<\_ACEOF +SHELL = /bin/sh +all: + @echo '@@@%%%=$(MAKE)=@@@%%%' +_ACEOF +# GNU make sometimes prints "make[1]: Entering ...", which would confuse us. +case `${MAKE-make} -f conftest.make 2>/dev/null` in + *@@@%%%=?*=@@@%%%*) + eval ac_cv_prog_make_${ac_make}_set=yes;; + *) + eval ac_cv_prog_make_${ac_make}_set=no;; +esac +rm -f conftest.make +fi +if eval test \$ac_cv_prog_make_${ac_make}_set = yes; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 +$as_echo "yes" >&6; } + SET_MAKE= +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } + SET_MAKE="MAKE=${MAKE-make}" +fi + +rm -rf .tst 2>/dev/null +mkdir .tst 2>/dev/null +if test -d .tst; then + am__leading_dot=. +else + am__leading_dot=_ +fi +rmdir .tst 2>/dev/null + +if test "`cd $srcdir && pwd`" != "`pwd`"; then + # Use -I$(srcdir) only when $(srcdir) != ., so that make's output + # is not polluted with repeated "-I." + am__isrc=' -I$(srcdir)' + # test to see if srcdir already configured + if test -f $srcdir/config.status; then + as_fn_error $? "source directory already configured; run \"make distclean\" there first" "$LINENO" 5 + fi +fi + +# test whether we have cygpath +if test -z "$CYGPATH_W"; then + if (cygpath --version) >/dev/null 2>/dev/null; then + CYGPATH_W='cygpath -w' + else + CYGPATH_W=echo + fi +fi + + +# Define the identity of the package. + PACKAGE='libconfig' + VERSION='1.4.9' + + +cat >>confdefs.h <<_ACEOF +#define PACKAGE "$PACKAGE" +_ACEOF + + +cat >>confdefs.h <<_ACEOF +#define VERSION "$VERSION" +_ACEOF + +# Some tools Automake needs. + +ACLOCAL=${ACLOCAL-"${am_missing_run}aclocal-${am__api_version}"} + + +AUTOCONF=${AUTOCONF-"${am_missing_run}autoconf"} + + +AUTOMAKE=${AUTOMAKE-"${am_missing_run}automake-${am__api_version}"} + + +AUTOHEADER=${AUTOHEADER-"${am_missing_run}autoheader"} + + +MAKEINFO=${MAKEINFO-"${am_missing_run}makeinfo"} + +# We need awk for the "check" target. The system "awk" is bad on +# some platforms. +# Always define AMTAR for backward compatibility. + +AMTAR=${AMTAR-"${am_missing_run}tar"} + +am__tar='${AMTAR} chof - "$$tardir"'; am__untar='${AMTAR} xf -' + + + + + +ac_config_headers="$ac_config_headers ac_config.h" + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: libconfig - made with pride in California" >&5 +$as_echo "$as_me: libconfig - made with pride in California" >&6;} +sleep 3 + + +cat >>confdefs.h <<_ACEOF +#define TARGET "${target}" +_ACEOF + + +# Enable GNU extensions. +DEPDIR="${am__leading_dot}deps" + +ac_config_commands="$ac_config_commands depfiles" + + +am_make=${MAKE-make} +cat > confinc << 'END' +am__doit: + @echo this is the am__doit target +.PHONY: am__doit +END +# If we don't find an include directive, just comment out the code. +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for style of include used by $am_make" >&5 +$as_echo_n "checking for style of include used by $am_make... " >&6; } +am__include="#" +am__quote= +_am_result=none +# First try GNU make style include. +echo "include confinc" > confmf +# Ignore all kinds of additional output from `make'. +case `$am_make -s -f confmf 2> /dev/null` in #( +*the\ am__doit\ target*) + am__include=include + am__quote= + _am_result=GNU + ;; +esac +# Now try BSD make style include. +if test "$am__include" = "#"; then + echo '.include "confinc"' > confmf + case `$am_make -s -f confmf 2> /dev/null` in #( + *the\ am__doit\ target*) + am__include=.include + am__quote="\"" + _am_result=BSD + ;; + esac +fi + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $_am_result" >&5 +$as_echo "$_am_result" >&6; } +rm -f confinc confmf + +# Check whether --enable-dependency-tracking was given. +if test "${enable_dependency_tracking+set}" = set; then : + enableval=$enable_dependency_tracking; +fi + +if test "x$enable_dependency_tracking" != xno; then + am_depcomp="$ac_aux_dir/depcomp" + AMDEPBACKSLASH='\' +fi + if test "x$enable_dependency_tracking" != xno; then + AMDEP_TRUE= + AMDEP_FALSE='#' +else + AMDEP_TRUE='#' + AMDEP_FALSE= +fi + + +ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu +if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}gcc", so it can be a program name with args. +set dummy ${ac_tool_prefix}gcc; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_CC+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$CC"; then + ac_cv_prog_CC="$CC" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_CC="${ac_tool_prefix}gcc" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +CC=$ac_cv_prog_CC +if test -n "$CC"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 +$as_echo "$CC" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_CC"; then + ac_ct_CC=$CC + # Extract the first word of "gcc", so it can be a program name with args. +set dummy gcc; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_CC+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_CC"; then + ac_cv_prog_ac_ct_CC="$ac_ct_CC" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_CC="gcc" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_CC=$ac_cv_prog_ac_ct_CC +if test -n "$ac_ct_CC"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_CC" >&5 +$as_echo "$ac_ct_CC" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_CC" = x; then + CC="" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + CC=$ac_ct_CC + fi +else + CC="$ac_cv_prog_CC" +fi + +if test -z "$CC"; then + if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}cc", so it can be a program name with args. +set dummy ${ac_tool_prefix}cc; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_CC+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$CC"; then + ac_cv_prog_CC="$CC" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_CC="${ac_tool_prefix}cc" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +CC=$ac_cv_prog_CC +if test -n "$CC"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 +$as_echo "$CC" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + fi +fi +if test -z "$CC"; then + # Extract the first word of "cc", so it can be a program name with args. +set dummy cc; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_CC+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$CC"; then + ac_cv_prog_CC="$CC" # Let the user override the test. +else + ac_prog_rejected=no +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + if test "$as_dir/$ac_word$ac_exec_ext" = "/usr/ucb/cc"; then + ac_prog_rejected=yes + continue + fi + ac_cv_prog_CC="cc" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +if test $ac_prog_rejected = yes; then + # We found a bogon in the path, so make sure we never use it. + set dummy $ac_cv_prog_CC + shift + if test $# != 0; then + # We chose a different compiler from the bogus one. + # However, it has the same basename, so the bogon will be chosen + # first if we set CC to just the basename; use the full file name. + shift + ac_cv_prog_CC="$as_dir/$ac_word${1+' '}$@" + fi +fi +fi +fi +CC=$ac_cv_prog_CC +if test -n "$CC"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 +$as_echo "$CC" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$CC"; then + if test -n "$ac_tool_prefix"; then + for ac_prog in cl.exe + do + # Extract the first word of "$ac_tool_prefix$ac_prog", so it can be a program name with args. +set dummy $ac_tool_prefix$ac_prog; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_CC+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$CC"; then + ac_cv_prog_CC="$CC" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_CC="$ac_tool_prefix$ac_prog" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +CC=$ac_cv_prog_CC +if test -n "$CC"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 +$as_echo "$CC" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + test -n "$CC" && break + done +fi +if test -z "$CC"; then + ac_ct_CC=$CC + for ac_prog in cl.exe +do + # Extract the first word of "$ac_prog", so it can be a program name with args. +set dummy $ac_prog; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_CC+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_CC"; then + ac_cv_prog_ac_ct_CC="$ac_ct_CC" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_CC="$ac_prog" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_CC=$ac_cv_prog_ac_ct_CC +if test -n "$ac_ct_CC"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_CC" >&5 +$as_echo "$ac_ct_CC" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + test -n "$ac_ct_CC" && break +done + + if test "x$ac_ct_CC" = x; then + CC="" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + CC=$ac_ct_CC + fi +fi + +fi + + +test -z "$CC" && { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 +$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} +as_fn_error $? "no acceptable C compiler found in \$PATH +See \`config.log' for more details" "$LINENO" 5; } + +# Provide some information about the compiler. +$as_echo "$as_me:${as_lineno-$LINENO}: checking for C compiler version" >&5 +set X $ac_compile +ac_compiler=$2 +for ac_option in --version -v -V -qversion; do + { { ac_try="$ac_compiler $ac_option >&5" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_compiler $ac_option >&5") 2>conftest.err + ac_status=$? + if test -s conftest.err; then + sed '10a\ +... rest of stderr output deleted ... + 10q' conftest.err >conftest.er1 + cat conftest.er1 >&5 + fi + rm -f conftest.er1 conftest.err + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } +done + +cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +ac_clean_files_save=$ac_clean_files +ac_clean_files="$ac_clean_files a.out a.out.dSYM a.exe b.out" +# Try to create an executable without -o first, disregard a.out. +# It will help us diagnose broken compilers, and finding out an intuition +# of exeext. +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether the C compiler works" >&5 +$as_echo_n "checking whether the C compiler works... " >&6; } +ac_link_default=`$as_echo "$ac_link" | sed 's/ -o *conftest[^ ]*//'` + +# The possible output files: +ac_files="a.out conftest.exe conftest a.exe a_out.exe b.out conftest.*" + +ac_rmfiles= +for ac_file in $ac_files +do + case $ac_file in + *.$ac_ext | *.xcoff | *.tds | *.d | *.pdb | *.xSYM | *.bb | *.bbg | *.map | *.inf | *.dSYM | *.o | *.obj ) ;; + * ) ac_rmfiles="$ac_rmfiles $ac_file";; + esac +done +rm -f $ac_rmfiles + +if { { ac_try="$ac_link_default" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_link_default") 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; then : + # Autoconf-2.13 could set the ac_cv_exeext variable to `no'. +# So ignore a value of `no', otherwise this would lead to `EXEEXT = no' +# in a Makefile. We should not override ac_cv_exeext if it was cached, +# so that the user can short-circuit this test for compilers unknown to +# Autoconf. +for ac_file in $ac_files '' +do + test -f "$ac_file" || continue + case $ac_file in + *.$ac_ext | *.xcoff | *.tds | *.d | *.pdb | *.xSYM | *.bb | *.bbg | *.map | *.inf | *.dSYM | *.o | *.obj ) + ;; + [ab].out ) + # We found the default executable, but exeext='' is most + # certainly right. + break;; + *.* ) + if test "${ac_cv_exeext+set}" = set && test "$ac_cv_exeext" != no; + then :; else + ac_cv_exeext=`expr "$ac_file" : '[^.]*\(\..*\)'` + fi + # We set ac_cv_exeext here because the later test for it is not + # safe: cross compilers may not add the suffix if given an `-o' + # argument, so we may need to know it at that point already. + # Even if this section looks crufty: it has the advantage of + # actually working. + break;; + * ) + break;; + esac +done +test "$ac_cv_exeext" = no && ac_cv_exeext= + +else + ac_file='' +fi +if test -z "$ac_file"; then : + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +$as_echo "$as_me: failed program was:" >&5 +sed 's/^/| /' conftest.$ac_ext >&5 + +{ { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 +$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} +as_fn_error 77 "C compiler cannot create executables +See \`config.log' for more details" "$LINENO" 5; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 +$as_echo "yes" >&6; } +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for C compiler default output file name" >&5 +$as_echo_n "checking for C compiler default output file name... " >&6; } +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_file" >&5 +$as_echo "$ac_file" >&6; } +ac_exeext=$ac_cv_exeext + +rm -f -r a.out a.out.dSYM a.exe conftest$ac_cv_exeext b.out +ac_clean_files=$ac_clean_files_save +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for suffix of executables" >&5 +$as_echo_n "checking for suffix of executables... " >&6; } +if { { ac_try="$ac_link" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_link") 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; then : + # If both `conftest.exe' and `conftest' are `present' (well, observable) +# catch `conftest.exe'. For instance with Cygwin, `ls conftest' will +# work properly (i.e., refer to `conftest.exe'), while it won't with +# `rm'. +for ac_file in conftest.exe conftest conftest.*; do + test -f "$ac_file" || continue + case $ac_file in + *.$ac_ext | *.xcoff | *.tds | *.d | *.pdb | *.xSYM | *.bb | *.bbg | *.map | *.inf | *.dSYM | *.o | *.obj ) ;; + *.* ) ac_cv_exeext=`expr "$ac_file" : '[^.]*\(\..*\)'` + break;; + * ) break;; + esac +done +else + { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 +$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} +as_fn_error $? "cannot compute suffix of executables: cannot compile and link +See \`config.log' for more details" "$LINENO" 5; } +fi +rm -f conftest conftest$ac_cv_exeext +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_exeext" >&5 +$as_echo "$ac_cv_exeext" >&6; } + +rm -f conftest.$ac_ext +EXEEXT=$ac_cv_exeext +ac_exeext=$EXEEXT +cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include +int +main () +{ +FILE *f = fopen ("conftest.out", "w"); + return ferror (f) || fclose (f) != 0; + + ; + return 0; +} +_ACEOF +ac_clean_files="$ac_clean_files conftest.out" +# Check that the compiler produces executables we can run. If not, either +# the compiler is broken, or we cross compile. +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are cross compiling" >&5 +$as_echo_n "checking whether we are cross compiling... " >&6; } +if test "$cross_compiling" != yes; then + { { ac_try="$ac_link" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_link") 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } + if { ac_try='./conftest$ac_cv_exeext' + { { case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_try") 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; }; then + cross_compiling=no + else + if test "$cross_compiling" = maybe; then + cross_compiling=yes + else + { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 +$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} +as_fn_error $? "cannot run C compiled programs. +If you meant to cross compile, use \`--host'. +See \`config.log' for more details" "$LINENO" 5; } + fi + fi +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $cross_compiling" >&5 +$as_echo "$cross_compiling" >&6; } + +rm -f conftest.$ac_ext conftest$ac_cv_exeext conftest.out +ac_clean_files=$ac_clean_files_save +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for suffix of object files" >&5 +$as_echo_n "checking for suffix of object files... " >&6; } +if ${ac_cv_objext+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +rm -f conftest.o conftest.obj +if { { ac_try="$ac_compile" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_compile") 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; then : + for ac_file in conftest.o conftest.obj conftest.*; do + test -f "$ac_file" || continue; + case $ac_file in + *.$ac_ext | *.xcoff | *.tds | *.d | *.pdb | *.xSYM | *.bb | *.bbg | *.map | *.inf | *.dSYM ) ;; + *) ac_cv_objext=`expr "$ac_file" : '.*\.\(.*\)'` + break;; + esac +done +else + $as_echo "$as_me: failed program was:" >&5 +sed 's/^/| /' conftest.$ac_ext >&5 + +{ { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 +$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} +as_fn_error $? "cannot compute suffix of object files: cannot compile +See \`config.log' for more details" "$LINENO" 5; } +fi +rm -f conftest.$ac_cv_objext conftest.$ac_ext +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_objext" >&5 +$as_echo "$ac_cv_objext" >&6; } +OBJEXT=$ac_cv_objext +ac_objext=$OBJEXT +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are using the GNU C compiler" >&5 +$as_echo_n "checking whether we are using the GNU C compiler... " >&6; } +if ${ac_cv_c_compiler_gnu+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ +#ifndef __GNUC__ + choke me +#endif + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + ac_compiler_gnu=yes +else + ac_compiler_gnu=no +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext +ac_cv_c_compiler_gnu=$ac_compiler_gnu + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_c_compiler_gnu" >&5 +$as_echo "$ac_cv_c_compiler_gnu" >&6; } +if test $ac_compiler_gnu = yes; then + GCC=yes +else + GCC= +fi +ac_test_CFLAGS=${CFLAGS+set} +ac_save_CFLAGS=$CFLAGS +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $CC accepts -g" >&5 +$as_echo_n "checking whether $CC accepts -g... " >&6; } +if ${ac_cv_prog_cc_g+:} false; then : + $as_echo_n "(cached) " >&6 +else + ac_save_c_werror_flag=$ac_c_werror_flag + ac_c_werror_flag=yes + ac_cv_prog_cc_g=no + CFLAGS="-g" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + ac_cv_prog_cc_g=yes +else + CFLAGS="" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + +else + ac_c_werror_flag=$ac_save_c_werror_flag + CFLAGS="-g" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + ac_cv_prog_cc_g=yes +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext + ac_c_werror_flag=$ac_save_c_werror_flag +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_cc_g" >&5 +$as_echo "$ac_cv_prog_cc_g" >&6; } +if test "$ac_test_CFLAGS" = set; then + CFLAGS=$ac_save_CFLAGS +elif test $ac_cv_prog_cc_g = yes; then + if test "$GCC" = yes; then + CFLAGS="-g -O2" + else + CFLAGS="-g" + fi +else + if test "$GCC" = yes; then + CFLAGS="-O2" + else + CFLAGS= + fi +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $CC option to accept ISO C89" >&5 +$as_echo_n "checking for $CC option to accept ISO C89... " >&6; } +if ${ac_cv_prog_cc_c89+:} false; then : + $as_echo_n "(cached) " >&6 +else + ac_cv_prog_cc_c89=no +ac_save_CC=$CC +cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include +#include +#include +#include +/* Most of the following tests are stolen from RCS 5.7's src/conf.sh. */ +struct buf { int x; }; +FILE * (*rcsopen) (struct buf *, struct stat *, int); +static char *e (p, i) + char **p; + int i; +{ + return p[i]; +} +static char *f (char * (*g) (char **, int), char **p, ...) +{ + char *s; + va_list v; + va_start (v,p); + s = g (p, va_arg (v,int)); + va_end (v); + return s; +} + +/* OSF 4.0 Compaq cc is some sort of almost-ANSI by default. It has + function prototypes and stuff, but not '\xHH' hex character constants. + These don't provoke an error unfortunately, instead are silently treated + as 'x'. The following induces an error, until -std is added to get + proper ANSI mode. Curiously '\x00'!='x' always comes out true, for an + array size at least. It's necessary to write '\x00'==0 to get something + that's true only with -std. */ +int osf4_cc_array ['\x00' == 0 ? 1 : -1]; + +/* IBM C 6 for AIX is almost-ANSI by default, but it replaces macro parameters + inside strings and character constants. */ +#define FOO(x) 'x' +int xlc6_cc_array[FOO(a) == 'x' ? 1 : -1]; + +int test (int i, double x); +struct s1 {int (*f) (int a);}; +struct s2 {int (*f) (double a);}; +int pairnames (int, char **, FILE *(*)(struct buf *, struct stat *, int), int, int); +int argc; +char **argv; +int +main () +{ +return f (e, argv, 0) != argv[0] || f (e, argv, 1) != argv[1]; + ; + return 0; +} +_ACEOF +for ac_arg in '' -qlanglvl=extc89 -qlanglvl=ansi -std \ + -Ae "-Aa -D_HPUX_SOURCE" "-Xc -D__EXTENSIONS__" +do + CC="$ac_save_CC $ac_arg" + if ac_fn_c_try_compile "$LINENO"; then : + ac_cv_prog_cc_c89=$ac_arg +fi +rm -f core conftest.err conftest.$ac_objext + test "x$ac_cv_prog_cc_c89" != "xno" && break +done +rm -f conftest.$ac_ext +CC=$ac_save_CC + +fi +# AC_CACHE_VAL +case "x$ac_cv_prog_cc_c89" in + x) + { $as_echo "$as_me:${as_lineno-$LINENO}: result: none needed" >&5 +$as_echo "none needed" >&6; } ;; + xno) + { $as_echo "$as_me:${as_lineno-$LINENO}: result: unsupported" >&5 +$as_echo "unsupported" >&6; } ;; + *) + CC="$CC $ac_cv_prog_cc_c89" + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_cc_c89" >&5 +$as_echo "$ac_cv_prog_cc_c89" >&6; } ;; +esac +if test "x$ac_cv_prog_cc_c89" != xno; then : + +fi + +ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu + +depcc="$CC" am_compiler_list= + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking dependency style of $depcc" >&5 +$as_echo_n "checking dependency style of $depcc... " >&6; } +if ${am_cv_CC_dependencies_compiler_type+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -z "$AMDEP_TRUE" && test -f "$am_depcomp"; then + # We make a subdir and do the tests there. Otherwise we can end up + # making bogus files that we don't know about and never remove. For + # instance it was reported that on HP-UX the gcc test will end up + # making a dummy file named `D' -- because `-MD' means `put the output + # in D'. + mkdir conftest.dir + # Copy depcomp to subdir because otherwise we won't find it if we're + # using a relative directory. + cp "$am_depcomp" conftest.dir + cd conftest.dir + # We will build objects and dependencies in a subdirectory because + # it helps to detect inapplicable dependency modes. For instance + # both Tru64's cc and ICC support -MD to output dependencies as a + # side effect of compilation, but ICC will put the dependencies in + # the current directory while Tru64 will put them in the object + # directory. + mkdir sub + + am_cv_CC_dependencies_compiler_type=none + if test "$am_compiler_list" = ""; then + am_compiler_list=`sed -n 's/^#*\([a-zA-Z0-9]*\))$/\1/p' < ./depcomp` + fi + am__universal=false + case " $depcc " in #( + *\ -arch\ *\ -arch\ *) am__universal=true ;; + esac + + for depmode in $am_compiler_list; do + # Setup a source with many dependencies, because some compilers + # like to wrap large dependency lists on column 80 (with \), and + # we should not choose a depcomp mode which is confused by this. + # + # We need to recreate these files for each test, as the compiler may + # overwrite some of them when testing with obscure command lines. + # This happens at least with the AIX C compiler. + : > sub/conftest.c + for i in 1 2 3 4 5 6; do + echo '#include "conftst'$i'.h"' >> sub/conftest.c + # Using `: > sub/conftst$i.h' creates only sub/conftst1.h with + # Solaris 8's {/usr,}/bin/sh. + touch sub/conftst$i.h + done + echo "${am__include} ${am__quote}sub/conftest.Po${am__quote}" > confmf + + # We check with `-c' and `-o' for the sake of the "dashmstdout" + # mode. It turns out that the SunPro C++ compiler does not properly + # handle `-M -o', and we need to detect this. Also, some Intel + # versions had trouble with output in subdirs + am__obj=sub/conftest.${OBJEXT-o} + am__minus_obj="-o $am__obj" + case $depmode in + gcc) + # This depmode causes a compiler race in universal mode. + test "$am__universal" = false || continue + ;; + nosideeffect) + # after this tag, mechanisms are not by side-effect, so they'll + # only be used when explicitly requested + if test "x$enable_dependency_tracking" = xyes; then + continue + else + break + fi + ;; + msvisualcpp | msvcmsys) + # This compiler won't grok `-c -o', but also, the minuso test has + # not run yet. These depmodes are late enough in the game, and + # so weak that their functioning should not be impacted. + am__obj=conftest.${OBJEXT-o} + am__minus_obj= + ;; + none) break ;; + esac + if depmode=$depmode \ + source=sub/conftest.c object=$am__obj \ + depfile=sub/conftest.Po tmpdepfile=sub/conftest.TPo \ + $SHELL ./depcomp $depcc -c $am__minus_obj sub/conftest.c \ + >/dev/null 2>conftest.err && + grep sub/conftst1.h sub/conftest.Po > /dev/null 2>&1 && + grep sub/conftst6.h sub/conftest.Po > /dev/null 2>&1 && + grep $am__obj sub/conftest.Po > /dev/null 2>&1 && + ${MAKE-make} -s -f confmf > /dev/null 2>&1; then + # icc doesn't choke on unknown options, it will just issue warnings + # or remarks (even with -Werror). So we grep stderr for any message + # that says an option was ignored or not supported. + # When given -MP, icc 7.0 and 7.1 complain thusly: + # icc: Command line warning: ignoring option '-M'; no argument required + # The diagnosis changed in icc 8.0: + # icc: Command line remark: option '-MP' not supported + if (grep 'ignoring option' conftest.err || + grep 'not supported' conftest.err) >/dev/null 2>&1; then :; else + am_cv_CC_dependencies_compiler_type=$depmode + break + fi + fi + done + + cd .. + rm -rf conftest.dir +else + am_cv_CC_dependencies_compiler_type=none +fi + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $am_cv_CC_dependencies_compiler_type" >&5 +$as_echo "$am_cv_CC_dependencies_compiler_type" >&6; } +CCDEPMODE=depmode=$am_cv_CC_dependencies_compiler_type + + if + test "x$enable_dependency_tracking" != xno \ + && test "$am_cv_CC_dependencies_compiler_type" = gcc3; then + am__fastdepCC_TRUE= + am__fastdepCC_FALSE='#' +else + am__fastdepCC_TRUE='#' + am__fastdepCC_FALSE= +fi + + + +ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking how to run the C preprocessor" >&5 +$as_echo_n "checking how to run the C preprocessor... " >&6; } +# On Suns, sometimes $CPP names a directory. +if test -n "$CPP" && test -d "$CPP"; then + CPP= +fi +if test -z "$CPP"; then + if ${ac_cv_prog_CPP+:} false; then : + $as_echo_n "(cached) " >&6 +else + # Double quotes because CPP needs to be expanded + for CPP in "$CC -E" "$CC -E -traditional-cpp" "/lib/cpp" + do + ac_preproc_ok=false +for ac_c_preproc_warn_flag in '' yes +do + # Use a header file that comes with gcc, so configuring glibc + # with a fresh cross-compiler works. + # Prefer to if __STDC__ is defined, since + # exists even on freestanding compilers. + # On the NeXT, cc -E runs the code through the compiler's parser, + # not just through cpp. "Syntax error" is here to catch this case. + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#ifdef __STDC__ +# include +#else +# include +#endif + Syntax error +_ACEOF +if ac_fn_c_try_cpp "$LINENO"; then : + +else + # Broken: fails on valid input. +continue +fi +rm -f conftest.err conftest.i conftest.$ac_ext + + # OK, works on sane cases. Now check whether nonexistent headers + # can be detected and how. + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include +_ACEOF +if ac_fn_c_try_cpp "$LINENO"; then : + # Broken: success on invalid input. +continue +else + # Passes both tests. +ac_preproc_ok=: +break +fi +rm -f conftest.err conftest.i conftest.$ac_ext + +done +# Because of `break', _AC_PREPROC_IFELSE's cleaning code was skipped. +rm -f conftest.i conftest.err conftest.$ac_ext +if $ac_preproc_ok; then : + break +fi + + done + ac_cv_prog_CPP=$CPP + +fi + CPP=$ac_cv_prog_CPP +else + ac_cv_prog_CPP=$CPP +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $CPP" >&5 +$as_echo "$CPP" >&6; } +ac_preproc_ok=false +for ac_c_preproc_warn_flag in '' yes +do + # Use a header file that comes with gcc, so configuring glibc + # with a fresh cross-compiler works. + # Prefer to if __STDC__ is defined, since + # exists even on freestanding compilers. + # On the NeXT, cc -E runs the code through the compiler's parser, + # not just through cpp. "Syntax error" is here to catch this case. + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#ifdef __STDC__ +# include +#else +# include +#endif + Syntax error +_ACEOF +if ac_fn_c_try_cpp "$LINENO"; then : + +else + # Broken: fails on valid input. +continue +fi +rm -f conftest.err conftest.i conftest.$ac_ext + + # OK, works on sane cases. Now check whether nonexistent headers + # can be detected and how. + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include +_ACEOF +if ac_fn_c_try_cpp "$LINENO"; then : + # Broken: success on invalid input. +continue +else + # Passes both tests. +ac_preproc_ok=: +break +fi +rm -f conftest.err conftest.i conftest.$ac_ext + +done +# Because of `break', _AC_PREPROC_IFELSE's cleaning code was skipped. +rm -f conftest.i conftest.err conftest.$ac_ext +if $ac_preproc_ok; then : + +else + { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 +$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} +as_fn_error $? "C preprocessor \"$CPP\" fails sanity check +See \`config.log' for more details" "$LINENO" 5; } +fi + +ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for grep that handles long lines and -e" >&5 +$as_echo_n "checking for grep that handles long lines and -e... " >&6; } +if ${ac_cv_path_GREP+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -z "$GREP"; then + ac_path_GREP_found=false + # Loop through the user's path and test for each of PROGNAME-LIST + as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH$PATH_SEPARATOR/usr/xpg4/bin +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_prog in grep ggrep; do + for ac_exec_ext in '' $ac_executable_extensions; do + ac_path_GREP="$as_dir/$ac_prog$ac_exec_ext" + { test -f "$ac_path_GREP" && $as_test_x "$ac_path_GREP"; } || continue +# Check for GNU ac_path_GREP and select it if it is found. + # Check for GNU $ac_path_GREP +case `"$ac_path_GREP" --version 2>&1` in +*GNU*) + ac_cv_path_GREP="$ac_path_GREP" ac_path_GREP_found=:;; +*) + ac_count=0 + $as_echo_n 0123456789 >"conftest.in" + while : + do + cat "conftest.in" "conftest.in" >"conftest.tmp" + mv "conftest.tmp" "conftest.in" + cp "conftest.in" "conftest.nl" + $as_echo 'GREP' >> "conftest.nl" + "$ac_path_GREP" -e 'GREP$' -e '-(cannot match)-' < "conftest.nl" >"conftest.out" 2>/dev/null || break + diff "conftest.out" "conftest.nl" >/dev/null 2>&1 || break + as_fn_arith $ac_count + 1 && ac_count=$as_val + if test $ac_count -gt ${ac_path_GREP_max-0}; then + # Best one so far, save it but keep looking for a better one + ac_cv_path_GREP="$ac_path_GREP" + ac_path_GREP_max=$ac_count + fi + # 10*(2^10) chars as input seems more than enough + test $ac_count -gt 10 && break + done + rm -f conftest.in conftest.tmp conftest.nl conftest.out;; +esac + + $ac_path_GREP_found && break 3 + done + done + done +IFS=$as_save_IFS + if test -z "$ac_cv_path_GREP"; then + as_fn_error $? "no acceptable grep could be found in $PATH$PATH_SEPARATOR/usr/xpg4/bin" "$LINENO" 5 + fi +else + ac_cv_path_GREP=$GREP +fi + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_path_GREP" >&5 +$as_echo "$ac_cv_path_GREP" >&6; } + GREP="$ac_cv_path_GREP" + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for egrep" >&5 +$as_echo_n "checking for egrep... " >&6; } +if ${ac_cv_path_EGREP+:} false; then : + $as_echo_n "(cached) " >&6 +else + if echo a | $GREP -E '(a|b)' >/dev/null 2>&1 + then ac_cv_path_EGREP="$GREP -E" + else + if test -z "$EGREP"; then + ac_path_EGREP_found=false + # Loop through the user's path and test for each of PROGNAME-LIST + as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH$PATH_SEPARATOR/usr/xpg4/bin +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_prog in egrep; do + for ac_exec_ext in '' $ac_executable_extensions; do + ac_path_EGREP="$as_dir/$ac_prog$ac_exec_ext" + { test -f "$ac_path_EGREP" && $as_test_x "$ac_path_EGREP"; } || continue +# Check for GNU ac_path_EGREP and select it if it is found. + # Check for GNU $ac_path_EGREP +case `"$ac_path_EGREP" --version 2>&1` in +*GNU*) + ac_cv_path_EGREP="$ac_path_EGREP" ac_path_EGREP_found=:;; +*) + ac_count=0 + $as_echo_n 0123456789 >"conftest.in" + while : + do + cat "conftest.in" "conftest.in" >"conftest.tmp" + mv "conftest.tmp" "conftest.in" + cp "conftest.in" "conftest.nl" + $as_echo 'EGREP' >> "conftest.nl" + "$ac_path_EGREP" 'EGREP$' < "conftest.nl" >"conftest.out" 2>/dev/null || break + diff "conftest.out" "conftest.nl" >/dev/null 2>&1 || break + as_fn_arith $ac_count + 1 && ac_count=$as_val + if test $ac_count -gt ${ac_path_EGREP_max-0}; then + # Best one so far, save it but keep looking for a better one + ac_cv_path_EGREP="$ac_path_EGREP" + ac_path_EGREP_max=$ac_count + fi + # 10*(2^10) chars as input seems more than enough + test $ac_count -gt 10 && break + done + rm -f conftest.in conftest.tmp conftest.nl conftest.out;; +esac + + $ac_path_EGREP_found && break 3 + done + done + done +IFS=$as_save_IFS + if test -z "$ac_cv_path_EGREP"; then + as_fn_error $? "no acceptable egrep could be found in $PATH$PATH_SEPARATOR/usr/xpg4/bin" "$LINENO" 5 + fi +else + ac_cv_path_EGREP=$EGREP +fi + + fi +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_path_EGREP" >&5 +$as_echo "$ac_cv_path_EGREP" >&6; } + EGREP="$ac_cv_path_EGREP" + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for ANSI C header files" >&5 +$as_echo_n "checking for ANSI C header files... " >&6; } +if ${ac_cv_header_stdc+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include +#include +#include +#include + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + ac_cv_header_stdc=yes +else + ac_cv_header_stdc=no +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext + +if test $ac_cv_header_stdc = yes; then + # SunOS 4.x string.h does not declare mem*, contrary to ANSI. + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include + +_ACEOF +if (eval "$ac_cpp conftest.$ac_ext") 2>&5 | + $EGREP "memchr" >/dev/null 2>&1; then : + +else + ac_cv_header_stdc=no +fi +rm -f conftest* + +fi + +if test $ac_cv_header_stdc = yes; then + # ISC 2.0.2 stdlib.h does not declare free, contrary to ANSI. + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include + +_ACEOF +if (eval "$ac_cpp conftest.$ac_ext") 2>&5 | + $EGREP "free" >/dev/null 2>&1; then : + +else + ac_cv_header_stdc=no +fi +rm -f conftest* + +fi + +if test $ac_cv_header_stdc = yes; then + # /bin/cc in Irix-4.0.5 gets non-ANSI ctype macros unless using -ansi. + if test "$cross_compiling" = yes; then : + : +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include +#include +#if ((' ' & 0x0FF) == 0x020) +# define ISLOWER(c) ('a' <= (c) && (c) <= 'z') +# define TOUPPER(c) (ISLOWER(c) ? 'A' + ((c) - 'a') : (c)) +#else +# define ISLOWER(c) \ + (('a' <= (c) && (c) <= 'i') \ + || ('j' <= (c) && (c) <= 'r') \ + || ('s' <= (c) && (c) <= 'z')) +# define TOUPPER(c) (ISLOWER(c) ? ((c) | 0x40) : (c)) +#endif + +#define XOR(e, f) (((e) && !(f)) || (!(e) && (f))) +int +main () +{ + int i; + for (i = 0; i < 256; i++) + if (XOR (islower (i), ISLOWER (i)) + || toupper (i) != TOUPPER (i)) + return 2; + return 0; +} +_ACEOF +if ac_fn_c_try_run "$LINENO"; then : + +else + ac_cv_header_stdc=no +fi +rm -f core *.core core.conftest.* gmon.out bb.out conftest$ac_exeext \ + conftest.$ac_objext conftest.beam conftest.$ac_ext +fi + +fi +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_header_stdc" >&5 +$as_echo "$ac_cv_header_stdc" >&6; } +if test $ac_cv_header_stdc = yes; then + +$as_echo "#define STDC_HEADERS 1" >>confdefs.h + +fi + +# On IRIX 5.3, sys/types and inttypes.h are conflicting. +for ac_header in sys/types.h sys/stat.h stdlib.h string.h memory.h strings.h \ + inttypes.h stdint.h unistd.h +do : + as_ac_Header=`$as_echo "ac_cv_header_$ac_header" | $as_tr_sh` +ac_fn_c_check_header_compile "$LINENO" "$ac_header" "$as_ac_Header" "$ac_includes_default +" +if eval test \"x\$"$as_ac_Header"\" = x"yes"; then : + cat >>confdefs.h <<_ACEOF +#define `$as_echo "HAVE_$ac_header" | $as_tr_cpp` 1 +_ACEOF + +fi + +done + + + + ac_fn_c_check_header_mongrel "$LINENO" "minix/config.h" "ac_cv_header_minix_config_h" "$ac_includes_default" +if test "x$ac_cv_header_minix_config_h" = xyes; then : + MINIX=yes +else + MINIX= +fi + + + if test "$MINIX" = yes; then + +$as_echo "#define _POSIX_SOURCE 1" >>confdefs.h + + +$as_echo "#define _POSIX_1_SOURCE 2" >>confdefs.h + + +$as_echo "#define _MINIX 1" >>confdefs.h + + fi + + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether it is safe to define __EXTENSIONS__" >&5 +$as_echo_n "checking whether it is safe to define __EXTENSIONS__... " >&6; } +if ${ac_cv_safe_to_define___extensions__+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +# define __EXTENSIONS__ 1 + $ac_includes_default +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + ac_cv_safe_to_define___extensions__=yes +else + ac_cv_safe_to_define___extensions__=no +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_safe_to_define___extensions__" >&5 +$as_echo "$ac_cv_safe_to_define___extensions__" >&6; } + test $ac_cv_safe_to_define___extensions__ = yes && + $as_echo "#define __EXTENSIONS__ 1" >>confdefs.h + + $as_echo "#define _ALL_SOURCE 1" >>confdefs.h + + $as_echo "#define _GNU_SOURCE 1" >>confdefs.h + + $as_echo "#define _POSIX_PTHREAD_SEMANTICS 1" >>confdefs.h + + $as_echo "#define _TANDEM_SOURCE 1" >>confdefs.h + + + + +case `pwd` in + *\ * | *\ *) + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: Libtool does not cope well with whitespace in \`pwd\`" >&5 +$as_echo "$as_me: WARNING: Libtool does not cope well with whitespace in \`pwd\`" >&2;} ;; +esac + + + +macro_version='2.4.2' +macro_revision='1.3337' + + + + + + + + + + + + + +ltmain="$ac_aux_dir/ltmain.sh" + +# Backslashify metacharacters that are still active within +# double-quoted strings. +sed_quote_subst='s/\(["`$\\]\)/\\\1/g' + +# Same as above, but do not quote variable references. +double_quote_subst='s/\(["`\\]\)/\\\1/g' + +# Sed substitution to delay expansion of an escaped shell variable in a +# double_quote_subst'ed string. +delay_variable_subst='s/\\\\\\\\\\\$/\\\\\\$/g' + +# Sed substitution to delay expansion of an escaped single quote. +delay_single_quote_subst='s/'\''/'\'\\\\\\\'\''/g' + +# Sed substitution to avoid accidental globbing in evaled expressions +no_glob_subst='s/\*/\\\*/g' + +ECHO='\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\' +ECHO=$ECHO$ECHO$ECHO$ECHO$ECHO +ECHO=$ECHO$ECHO$ECHO$ECHO$ECHO$ECHO + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking how to print strings" >&5 +$as_echo_n "checking how to print strings... " >&6; } +# Test print first, because it will be a builtin if present. +if test "X`( print -r -- -n ) 2>/dev/null`" = X-n && \ + test "X`print -r -- $ECHO 2>/dev/null`" = "X$ECHO"; then + ECHO='print -r --' +elif test "X`printf %s $ECHO 2>/dev/null`" = "X$ECHO"; then + ECHO='printf %s\n' +else + # Use this function as a fallback that always works. + func_fallback_echo () + { + eval 'cat <<_LTECHO_EOF +$1 +_LTECHO_EOF' + } + ECHO='func_fallback_echo' +fi + +# func_echo_all arg... +# Invoke $ECHO with all args, space-separated. +func_echo_all () +{ + $ECHO "" +} + +case "$ECHO" in + printf*) { $as_echo "$as_me:${as_lineno-$LINENO}: result: printf" >&5 +$as_echo "printf" >&6; } ;; + print*) { $as_echo "$as_me:${as_lineno-$LINENO}: result: print -r" >&5 +$as_echo "print -r" >&6; } ;; + *) { $as_echo "$as_me:${as_lineno-$LINENO}: result: cat" >&5 +$as_echo "cat" >&6; } ;; +esac + + + + + + + + + + + + + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for a sed that does not truncate output" >&5 +$as_echo_n "checking for a sed that does not truncate output... " >&6; } +if ${ac_cv_path_SED+:} false; then : + $as_echo_n "(cached) " >&6 +else + ac_script=s/aaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaaa/bbbbbbbbbbbbbbbbbbbbbbbbbbbbbbbbb/ + for ac_i in 1 2 3 4 5 6 7; do + ac_script="$ac_script$as_nl$ac_script" + done + echo "$ac_script" 2>/dev/null | sed 99q >conftest.sed + { ac_script=; unset ac_script;} + if test -z "$SED"; then + ac_path_SED_found=false + # Loop through the user's path and test for each of PROGNAME-LIST + as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_prog in sed gsed; do + for ac_exec_ext in '' $ac_executable_extensions; do + ac_path_SED="$as_dir/$ac_prog$ac_exec_ext" + { test -f "$ac_path_SED" && $as_test_x "$ac_path_SED"; } || continue +# Check for GNU ac_path_SED and select it if it is found. + # Check for GNU $ac_path_SED +case `"$ac_path_SED" --version 2>&1` in +*GNU*) + ac_cv_path_SED="$ac_path_SED" ac_path_SED_found=:;; +*) + ac_count=0 + $as_echo_n 0123456789 >"conftest.in" + while : + do + cat "conftest.in" "conftest.in" >"conftest.tmp" + mv "conftest.tmp" "conftest.in" + cp "conftest.in" "conftest.nl" + $as_echo '' >> "conftest.nl" + "$ac_path_SED" -f conftest.sed < "conftest.nl" >"conftest.out" 2>/dev/null || break + diff "conftest.out" "conftest.nl" >/dev/null 2>&1 || break + as_fn_arith $ac_count + 1 && ac_count=$as_val + if test $ac_count -gt ${ac_path_SED_max-0}; then + # Best one so far, save it but keep looking for a better one + ac_cv_path_SED="$ac_path_SED" + ac_path_SED_max=$ac_count + fi + # 10*(2^10) chars as input seems more than enough + test $ac_count -gt 10 && break + done + rm -f conftest.in conftest.tmp conftest.nl conftest.out;; +esac + + $ac_path_SED_found && break 3 + done + done + done +IFS=$as_save_IFS + if test -z "$ac_cv_path_SED"; then + as_fn_error $? "no acceptable sed could be found in \$PATH" "$LINENO" 5 + fi +else + ac_cv_path_SED=$SED +fi + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_path_SED" >&5 +$as_echo "$ac_cv_path_SED" >&6; } + SED="$ac_cv_path_SED" + rm -f conftest.sed + +test -z "$SED" && SED=sed +Xsed="$SED -e 1s/^X//" + + + + + + + + + + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for fgrep" >&5 +$as_echo_n "checking for fgrep... " >&6; } +if ${ac_cv_path_FGREP+:} false; then : + $as_echo_n "(cached) " >&6 +else + if echo 'ab*c' | $GREP -F 'ab*c' >/dev/null 2>&1 + then ac_cv_path_FGREP="$GREP -F" + else + if test -z "$FGREP"; then + ac_path_FGREP_found=false + # Loop through the user's path and test for each of PROGNAME-LIST + as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH$PATH_SEPARATOR/usr/xpg4/bin +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_prog in fgrep; do + for ac_exec_ext in '' $ac_executable_extensions; do + ac_path_FGREP="$as_dir/$ac_prog$ac_exec_ext" + { test -f "$ac_path_FGREP" && $as_test_x "$ac_path_FGREP"; } || continue +# Check for GNU ac_path_FGREP and select it if it is found. + # Check for GNU $ac_path_FGREP +case `"$ac_path_FGREP" --version 2>&1` in +*GNU*) + ac_cv_path_FGREP="$ac_path_FGREP" ac_path_FGREP_found=:;; +*) + ac_count=0 + $as_echo_n 0123456789 >"conftest.in" + while : + do + cat "conftest.in" "conftest.in" >"conftest.tmp" + mv "conftest.tmp" "conftest.in" + cp "conftest.in" "conftest.nl" + $as_echo 'FGREP' >> "conftest.nl" + "$ac_path_FGREP" FGREP < "conftest.nl" >"conftest.out" 2>/dev/null || break + diff "conftest.out" "conftest.nl" >/dev/null 2>&1 || break + as_fn_arith $ac_count + 1 && ac_count=$as_val + if test $ac_count -gt ${ac_path_FGREP_max-0}; then + # Best one so far, save it but keep looking for a better one + ac_cv_path_FGREP="$ac_path_FGREP" + ac_path_FGREP_max=$ac_count + fi + # 10*(2^10) chars as input seems more than enough + test $ac_count -gt 10 && break + done + rm -f conftest.in conftest.tmp conftest.nl conftest.out;; +esac + + $ac_path_FGREP_found && break 3 + done + done + done +IFS=$as_save_IFS + if test -z "$ac_cv_path_FGREP"; then + as_fn_error $? "no acceptable fgrep could be found in $PATH$PATH_SEPARATOR/usr/xpg4/bin" "$LINENO" 5 + fi +else + ac_cv_path_FGREP=$FGREP +fi + + fi +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_path_FGREP" >&5 +$as_echo "$ac_cv_path_FGREP" >&6; } + FGREP="$ac_cv_path_FGREP" + + +test -z "$GREP" && GREP=grep + + + + + + + + + + + + + + + + + + + +# Check whether --with-gnu-ld was given. +if test "${with_gnu_ld+set}" = set; then : + withval=$with_gnu_ld; test "$withval" = no || with_gnu_ld=yes +else + with_gnu_ld=no +fi + +ac_prog=ld +if test "$GCC" = yes; then + # Check if gcc -print-prog-name=ld gives a path. + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for ld used by $CC" >&5 +$as_echo_n "checking for ld used by $CC... " >&6; } + case $host in + *-*-mingw*) + # gcc leaves a trailing carriage return which upsets mingw + ac_prog=`($CC -print-prog-name=ld) 2>&5 | tr -d '\015'` ;; + *) + ac_prog=`($CC -print-prog-name=ld) 2>&5` ;; + esac + case $ac_prog in + # Accept absolute paths. + [\\/]* | ?:[\\/]*) + re_direlt='/[^/][^/]*/\.\./' + # Canonicalize the pathname of ld + ac_prog=`$ECHO "$ac_prog"| $SED 's%\\\\%/%g'` + while $ECHO "$ac_prog" | $GREP "$re_direlt" > /dev/null 2>&1; do + ac_prog=`$ECHO $ac_prog| $SED "s%$re_direlt%/%"` + done + test -z "$LD" && LD="$ac_prog" + ;; + "") + # If it fails, then pretend we aren't using GCC. + ac_prog=ld + ;; + *) + # If it is relative, then search for the first ld in PATH. + with_gnu_ld=unknown + ;; + esac +elif test "$with_gnu_ld" = yes; then + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for GNU ld" >&5 +$as_echo_n "checking for GNU ld... " >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for non-GNU ld" >&5 +$as_echo_n "checking for non-GNU ld... " >&6; } +fi +if ${lt_cv_path_LD+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -z "$LD"; then + lt_save_ifs="$IFS"; IFS=$PATH_SEPARATOR + for ac_dir in $PATH; do + IFS="$lt_save_ifs" + test -z "$ac_dir" && ac_dir=. + if test -f "$ac_dir/$ac_prog" || test -f "$ac_dir/$ac_prog$ac_exeext"; then + lt_cv_path_LD="$ac_dir/$ac_prog" + # Check to see if the program is GNU ld. I'd rather use --version, + # but apparently some variants of GNU ld only accept -v. + # Break only if it was the GNU/non-GNU ld that we prefer. + case `"$lt_cv_path_LD" -v 2>&1 &5 +$as_echo "$LD" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi +test -z "$LD" && as_fn_error $? "no acceptable ld found in \$PATH" "$LINENO" 5 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking if the linker ($LD) is GNU ld" >&5 +$as_echo_n "checking if the linker ($LD) is GNU ld... " >&6; } +if ${lt_cv_prog_gnu_ld+:} false; then : + $as_echo_n "(cached) " >&6 +else + # I'd rather use --version here, but apparently some GNU lds only accept -v. +case `$LD -v 2>&1 &5 +$as_echo "$lt_cv_prog_gnu_ld" >&6; } +with_gnu_ld=$lt_cv_prog_gnu_ld + + + + + + + + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for BSD- or MS-compatible name lister (nm)" >&5 +$as_echo_n "checking for BSD- or MS-compatible name lister (nm)... " >&6; } +if ${lt_cv_path_NM+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$NM"; then + # Let the user override the test. + lt_cv_path_NM="$NM" +else + lt_nm_to_check="${ac_tool_prefix}nm" + if test -n "$ac_tool_prefix" && test "$build" = "$host"; then + lt_nm_to_check="$lt_nm_to_check nm" + fi + for lt_tmp_nm in $lt_nm_to_check; do + lt_save_ifs="$IFS"; IFS=$PATH_SEPARATOR + for ac_dir in $PATH /usr/ccs/bin/elf /usr/ccs/bin /usr/ucb /bin; do + IFS="$lt_save_ifs" + test -z "$ac_dir" && ac_dir=. + tmp_nm="$ac_dir/$lt_tmp_nm" + if test -f "$tmp_nm" || test -f "$tmp_nm$ac_exeext" ; then + # Check to see if the nm accepts a BSD-compat flag. + # Adding the `sed 1q' prevents false positives on HP-UX, which says: + # nm: unknown option "B" ignored + # Tru64's nm complains that /dev/null is an invalid object file + case `"$tmp_nm" -B /dev/null 2>&1 | sed '1q'` in + */dev/null* | *'Invalid file or object type'*) + lt_cv_path_NM="$tmp_nm -B" + break + ;; + *) + case `"$tmp_nm" -p /dev/null 2>&1 | sed '1q'` in + */dev/null*) + lt_cv_path_NM="$tmp_nm -p" + break + ;; + *) + lt_cv_path_NM=${lt_cv_path_NM="$tmp_nm"} # keep the first match, but + continue # so that we can try to find one that supports BSD flags + ;; + esac + ;; + esac + fi + done + IFS="$lt_save_ifs" + done + : ${lt_cv_path_NM=no} +fi +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_path_NM" >&5 +$as_echo "$lt_cv_path_NM" >&6; } +if test "$lt_cv_path_NM" != "no"; then + NM="$lt_cv_path_NM" +else + # Didn't find any BSD compatible name lister, look for dumpbin. + if test -n "$DUMPBIN"; then : + # Let the user override the test. + else + if test -n "$ac_tool_prefix"; then + for ac_prog in dumpbin "link -dump" + do + # Extract the first word of "$ac_tool_prefix$ac_prog", so it can be a program name with args. +set dummy $ac_tool_prefix$ac_prog; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_DUMPBIN+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$DUMPBIN"; then + ac_cv_prog_DUMPBIN="$DUMPBIN" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_DUMPBIN="$ac_tool_prefix$ac_prog" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +DUMPBIN=$ac_cv_prog_DUMPBIN +if test -n "$DUMPBIN"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $DUMPBIN" >&5 +$as_echo "$DUMPBIN" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + test -n "$DUMPBIN" && break + done +fi +if test -z "$DUMPBIN"; then + ac_ct_DUMPBIN=$DUMPBIN + for ac_prog in dumpbin "link -dump" +do + # Extract the first word of "$ac_prog", so it can be a program name with args. +set dummy $ac_prog; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_DUMPBIN+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_DUMPBIN"; then + ac_cv_prog_ac_ct_DUMPBIN="$ac_ct_DUMPBIN" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_DUMPBIN="$ac_prog" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_DUMPBIN=$ac_cv_prog_ac_ct_DUMPBIN +if test -n "$ac_ct_DUMPBIN"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_DUMPBIN" >&5 +$as_echo "$ac_ct_DUMPBIN" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + test -n "$ac_ct_DUMPBIN" && break +done + + if test "x$ac_ct_DUMPBIN" = x; then + DUMPBIN=":" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + DUMPBIN=$ac_ct_DUMPBIN + fi +fi + + case `$DUMPBIN -symbols /dev/null 2>&1 | sed '1q'` in + *COFF*) + DUMPBIN="$DUMPBIN -symbols" + ;; + *) + DUMPBIN=: + ;; + esac + fi + + if test "$DUMPBIN" != ":"; then + NM="$DUMPBIN" + fi +fi +test -z "$NM" && NM=nm + + + + + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking the name lister ($NM) interface" >&5 +$as_echo_n "checking the name lister ($NM) interface... " >&6; } +if ${lt_cv_nm_interface+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_nm_interface="BSD nm" + echo "int some_variable = 0;" > conftest.$ac_ext + (eval echo "\"\$as_me:$LINENO: $ac_compile\"" >&5) + (eval "$ac_compile" 2>conftest.err) + cat conftest.err >&5 + (eval echo "\"\$as_me:$LINENO: $NM \\\"conftest.$ac_objext\\\"\"" >&5) + (eval "$NM \"conftest.$ac_objext\"" 2>conftest.err > conftest.out) + cat conftest.err >&5 + (eval echo "\"\$as_me:$LINENO: output\"" >&5) + cat conftest.out >&5 + if $GREP 'External.*some_variable' conftest.out > /dev/null; then + lt_cv_nm_interface="MS dumpbin" + fi + rm -f conftest* +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_nm_interface" >&5 +$as_echo "$lt_cv_nm_interface" >&6; } + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether ln -s works" >&5 +$as_echo_n "checking whether ln -s works... " >&6; } +LN_S=$as_ln_s +if test "$LN_S" = "ln -s"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 +$as_echo "yes" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no, using $LN_S" >&5 +$as_echo "no, using $LN_S" >&6; } +fi + +# find the maximum length of command line arguments +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking the maximum length of command line arguments" >&5 +$as_echo_n "checking the maximum length of command line arguments... " >&6; } +if ${lt_cv_sys_max_cmd_len+:} false; then : + $as_echo_n "(cached) " >&6 +else + i=0 + teststring="ABCD" + + case $build_os in + msdosdjgpp*) + # On DJGPP, this test can blow up pretty badly due to problems in libc + # (any single argument exceeding 2000 bytes causes a buffer overrun + # during glob expansion). Even if it were fixed, the result of this + # check would be larger than it should be. + lt_cv_sys_max_cmd_len=12288; # 12K is about right + ;; + + gnu*) + # Under GNU Hurd, this test is not required because there is + # no limit to the length of command line arguments. + # Libtool will interpret -1 as no limit whatsoever + lt_cv_sys_max_cmd_len=-1; + ;; + + cygwin* | mingw* | cegcc*) + # On Win9x/ME, this test blows up -- it succeeds, but takes + # about 5 minutes as the teststring grows exponentially. + # Worse, since 9x/ME are not pre-emptively multitasking, + # you end up with a "frozen" computer, even though with patience + # the test eventually succeeds (with a max line length of 256k). + # Instead, let's just punt: use the minimum linelength reported by + # all of the supported platforms: 8192 (on NT/2K/XP). + lt_cv_sys_max_cmd_len=8192; + ;; + + mint*) + # On MiNT this can take a long time and run out of memory. + lt_cv_sys_max_cmd_len=8192; + ;; + + amigaos*) + # On AmigaOS with pdksh, this test takes hours, literally. + # So we just punt and use a minimum line length of 8192. + lt_cv_sys_max_cmd_len=8192; + ;; + + netbsd* | freebsd* | openbsd* | darwin* | dragonfly*) + # This has been around since 386BSD, at least. Likely further. + if test -x /sbin/sysctl; then + lt_cv_sys_max_cmd_len=`/sbin/sysctl -n kern.argmax` + elif test -x /usr/sbin/sysctl; then + lt_cv_sys_max_cmd_len=`/usr/sbin/sysctl -n kern.argmax` + else + lt_cv_sys_max_cmd_len=65536 # usable default for all BSDs + fi + # And add a safety zone + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \/ 4` + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \* 3` + ;; + + interix*) + # We know the value 262144 and hardcode it with a safety zone (like BSD) + lt_cv_sys_max_cmd_len=196608 + ;; + + os2*) + # The test takes a long time on OS/2. + lt_cv_sys_max_cmd_len=8192 + ;; + + osf*) + # Dr. Hans Ekkehard Plesser reports seeing a kernel panic running configure + # due to this test when exec_disable_arg_limit is 1 on Tru64. It is not + # nice to cause kernel panics so lets avoid the loop below. + # First set a reasonable default. + lt_cv_sys_max_cmd_len=16384 + # + if test -x /sbin/sysconfig; then + case `/sbin/sysconfig -q proc exec_disable_arg_limit` in + *1*) lt_cv_sys_max_cmd_len=-1 ;; + esac + fi + ;; + sco3.2v5*) + lt_cv_sys_max_cmd_len=102400 + ;; + sysv5* | sco5v6* | sysv4.2uw2*) + kargmax=`grep ARG_MAX /etc/conf/cf.d/stune 2>/dev/null` + if test -n "$kargmax"; then + lt_cv_sys_max_cmd_len=`echo $kargmax | sed 's/.*[ ]//'` + else + lt_cv_sys_max_cmd_len=32768 + fi + ;; + *) + lt_cv_sys_max_cmd_len=`(getconf ARG_MAX) 2> /dev/null` + if test -n "$lt_cv_sys_max_cmd_len"; then + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \/ 4` + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \* 3` + else + # Make teststring a little bigger before we do anything with it. + # a 1K string should be a reasonable start. + for i in 1 2 3 4 5 6 7 8 ; do + teststring=$teststring$teststring + done + SHELL=${SHELL-${CONFIG_SHELL-/bin/sh}} + # If test is not a shell built-in, we'll probably end up computing a + # maximum length that is only half of the actual maximum length, but + # we can't tell. + while { test "X"`env echo "$teststring$teststring" 2>/dev/null` \ + = "X$teststring$teststring"; } >/dev/null 2>&1 && + test $i != 17 # 1/2 MB should be enough + do + i=`expr $i + 1` + teststring=$teststring$teststring + done + # Only check the string length outside the loop. + lt_cv_sys_max_cmd_len=`expr "X$teststring" : ".*" 2>&1` + teststring= + # Add a significant safety factor because C++ compilers can tack on + # massive amounts of additional arguments before passing them to the + # linker. It appears as though 1/2 is a usable value. + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \/ 2` + fi + ;; + esac + +fi + +if test -n $lt_cv_sys_max_cmd_len ; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_sys_max_cmd_len" >&5 +$as_echo "$lt_cv_sys_max_cmd_len" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: none" >&5 +$as_echo "none" >&6; } +fi +max_cmd_len=$lt_cv_sys_max_cmd_len + + + + + + +: ${CP="cp -f"} +: ${MV="mv -f"} +: ${RM="rm -f"} + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether the shell understands some XSI constructs" >&5 +$as_echo_n "checking whether the shell understands some XSI constructs... " >&6; } +# Try some XSI features +xsi_shell=no +( _lt_dummy="a/b/c" + test "${_lt_dummy##*/},${_lt_dummy%/*},${_lt_dummy#??}"${_lt_dummy%"$_lt_dummy"}, \ + = c,a/b,b/c, \ + && eval 'test $(( 1 + 1 )) -eq 2 \ + && test "${#_lt_dummy}" -eq 5' ) >/dev/null 2>&1 \ + && xsi_shell=yes +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $xsi_shell" >&5 +$as_echo "$xsi_shell" >&6; } + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether the shell understands \"+=\"" >&5 +$as_echo_n "checking whether the shell understands \"+=\"... " >&6; } +lt_shell_append=no +( foo=bar; set foo baz; eval "$1+=\$2" && test "$foo" = barbaz ) \ + >/dev/null 2>&1 \ + && lt_shell_append=yes +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_shell_append" >&5 +$as_echo "$lt_shell_append" >&6; } + + +if ( (MAIL=60; unset MAIL) || exit) >/dev/null 2>&1; then + lt_unset=unset +else + lt_unset=false +fi + + + + + +# test EBCDIC or ASCII +case `echo X|tr X '\101'` in + A) # ASCII based system + # \n is not interpreted correctly by Solaris 8 /usr/ucb/tr + lt_SP2NL='tr \040 \012' + lt_NL2SP='tr \015\012 \040\040' + ;; + *) # EBCDIC based system + lt_SP2NL='tr \100 \n' + lt_NL2SP='tr \r\n \100\100' + ;; +esac + + + + + + + + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking how to convert $build file names to $host format" >&5 +$as_echo_n "checking how to convert $build file names to $host format... " >&6; } +if ${lt_cv_to_host_file_cmd+:} false; then : + $as_echo_n "(cached) " >&6 +else + case $host in + *-*-mingw* ) + case $build in + *-*-mingw* ) # actually msys + lt_cv_to_host_file_cmd=func_convert_file_msys_to_w32 + ;; + *-*-cygwin* ) + lt_cv_to_host_file_cmd=func_convert_file_cygwin_to_w32 + ;; + * ) # otherwise, assume *nix + lt_cv_to_host_file_cmd=func_convert_file_nix_to_w32 + ;; + esac + ;; + *-*-cygwin* ) + case $build in + *-*-mingw* ) # actually msys + lt_cv_to_host_file_cmd=func_convert_file_msys_to_cygwin + ;; + *-*-cygwin* ) + lt_cv_to_host_file_cmd=func_convert_file_noop + ;; + * ) # otherwise, assume *nix + lt_cv_to_host_file_cmd=func_convert_file_nix_to_cygwin + ;; + esac + ;; + * ) # unhandled hosts (and "normal" native builds) + lt_cv_to_host_file_cmd=func_convert_file_noop + ;; +esac + +fi + +to_host_file_cmd=$lt_cv_to_host_file_cmd +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_to_host_file_cmd" >&5 +$as_echo "$lt_cv_to_host_file_cmd" >&6; } + + + + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking how to convert $build file names to toolchain format" >&5 +$as_echo_n "checking how to convert $build file names to toolchain format... " >&6; } +if ${lt_cv_to_tool_file_cmd+:} false; then : + $as_echo_n "(cached) " >&6 +else + #assume ordinary cross tools, or native build. +lt_cv_to_tool_file_cmd=func_convert_file_noop +case $host in + *-*-mingw* ) + case $build in + *-*-mingw* ) # actually msys + lt_cv_to_tool_file_cmd=func_convert_file_msys_to_w32 + ;; + esac + ;; +esac + +fi + +to_tool_file_cmd=$lt_cv_to_tool_file_cmd +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_to_tool_file_cmd" >&5 +$as_echo "$lt_cv_to_tool_file_cmd" >&6; } + + + + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $LD option to reload object files" >&5 +$as_echo_n "checking for $LD option to reload object files... " >&6; } +if ${lt_cv_ld_reload_flag+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_ld_reload_flag='-r' +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_ld_reload_flag" >&5 +$as_echo "$lt_cv_ld_reload_flag" >&6; } +reload_flag=$lt_cv_ld_reload_flag +case $reload_flag in +"" | " "*) ;; +*) reload_flag=" $reload_flag" ;; +esac +reload_cmds='$LD$reload_flag -o $output$reload_objs' +case $host_os in + cygwin* | mingw* | pw32* | cegcc*) + if test "$GCC" != yes; then + reload_cmds=false + fi + ;; + darwin*) + if test "$GCC" = yes; then + reload_cmds='$LTCC $LTCFLAGS -nostdlib ${wl}-r -o $output$reload_objs' + else + reload_cmds='$LD$reload_flag -o $output$reload_objs' + fi + ;; +esac + + + + + + + + + +if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}objdump", so it can be a program name with args. +set dummy ${ac_tool_prefix}objdump; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_OBJDUMP+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$OBJDUMP"; then + ac_cv_prog_OBJDUMP="$OBJDUMP" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_OBJDUMP="${ac_tool_prefix}objdump" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +OBJDUMP=$ac_cv_prog_OBJDUMP +if test -n "$OBJDUMP"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $OBJDUMP" >&5 +$as_echo "$OBJDUMP" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_OBJDUMP"; then + ac_ct_OBJDUMP=$OBJDUMP + # Extract the first word of "objdump", so it can be a program name with args. +set dummy objdump; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_OBJDUMP+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_OBJDUMP"; then + ac_cv_prog_ac_ct_OBJDUMP="$ac_ct_OBJDUMP" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_OBJDUMP="objdump" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_OBJDUMP=$ac_cv_prog_ac_ct_OBJDUMP +if test -n "$ac_ct_OBJDUMP"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_OBJDUMP" >&5 +$as_echo "$ac_ct_OBJDUMP" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_OBJDUMP" = x; then + OBJDUMP="false" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + OBJDUMP=$ac_ct_OBJDUMP + fi +else + OBJDUMP="$ac_cv_prog_OBJDUMP" +fi + +test -z "$OBJDUMP" && OBJDUMP=objdump + + + + + + + + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking how to recognize dependent libraries" >&5 +$as_echo_n "checking how to recognize dependent libraries... " >&6; } +if ${lt_cv_deplibs_check_method+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_file_magic_cmd='$MAGIC_CMD' +lt_cv_file_magic_test_file= +lt_cv_deplibs_check_method='unknown' +# Need to set the preceding variable on all platforms that support +# interlibrary dependencies. +# 'none' -- dependencies not supported. +# `unknown' -- same as none, but documents that we really don't know. +# 'pass_all' -- all dependencies passed with no checks. +# 'test_compile' -- check by making test program. +# 'file_magic [[regex]]' -- check by looking for files in library path +# which responds to the $file_magic_cmd with a given extended regex. +# If you have `file' or equivalent on your system and you're not sure +# whether `pass_all' will *always* work, you probably want this one. + +case $host_os in +aix[4-9]*) + lt_cv_deplibs_check_method=pass_all + ;; + +beos*) + lt_cv_deplibs_check_method=pass_all + ;; + +bsdi[45]*) + lt_cv_deplibs_check_method='file_magic ELF [0-9][0-9]*-bit [ML]SB (shared object|dynamic lib)' + lt_cv_file_magic_cmd='/usr/bin/file -L' + lt_cv_file_magic_test_file=/shlib/libc.so + ;; + +cygwin*) + # func_win32_libid is a shell function defined in ltmain.sh + lt_cv_deplibs_check_method='file_magic ^x86 archive import|^x86 DLL' + lt_cv_file_magic_cmd='func_win32_libid' + ;; + +mingw* | pw32*) + # Base MSYS/MinGW do not provide the 'file' command needed by + # func_win32_libid shell function, so use a weaker test based on 'objdump', + # unless we find 'file', for example because we are cross-compiling. + # func_win32_libid assumes BSD nm, so disallow it if using MS dumpbin. + if ( test "$lt_cv_nm_interface" = "BSD nm" && file / ) >/dev/null 2>&1; then + lt_cv_deplibs_check_method='file_magic ^x86 archive import|^x86 DLL' + lt_cv_file_magic_cmd='func_win32_libid' + else + # Keep this pattern in sync with the one in func_win32_libid. + lt_cv_deplibs_check_method='file_magic file format (pei*-i386(.*architecture: i386)?|pe-arm-wince|pe-x86-64)' + lt_cv_file_magic_cmd='$OBJDUMP -f' + fi + ;; + +cegcc*) + # use the weaker test based on 'objdump'. See mingw*. + lt_cv_deplibs_check_method='file_magic file format pe-arm-.*little(.*architecture: arm)?' + lt_cv_file_magic_cmd='$OBJDUMP -f' + ;; + +darwin* | rhapsody*) + lt_cv_deplibs_check_method=pass_all + ;; + +freebsd* | dragonfly*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ > /dev/null; then + case $host_cpu in + i*86 ) + # Not sure whether the presence of OpenBSD here was a mistake. + # Let's accept both of them until this is cleared up. + lt_cv_deplibs_check_method='file_magic (FreeBSD|OpenBSD|DragonFly)/i[3-9]86 (compact )?demand paged shared library' + lt_cv_file_magic_cmd=/usr/bin/file + lt_cv_file_magic_test_file=`echo /usr/lib/libc.so.*` + ;; + esac + else + lt_cv_deplibs_check_method=pass_all + fi + ;; + +gnu*) + lt_cv_deplibs_check_method=pass_all + ;; + +haiku*) + lt_cv_deplibs_check_method=pass_all + ;; + +hpux10.20* | hpux11*) + lt_cv_file_magic_cmd=/usr/bin/file + case $host_cpu in + ia64*) + lt_cv_deplibs_check_method='file_magic (s[0-9][0-9][0-9]|ELF-[0-9][0-9]) shared object file - IA64' + lt_cv_file_magic_test_file=/usr/lib/hpux32/libc.so + ;; + hppa*64*) + lt_cv_deplibs_check_method='file_magic (s[0-9][0-9][0-9]|ELF[ -][0-9][0-9])(-bit)?( [LM]SB)? shared object( file)?[, -]* PA-RISC [0-9]\.[0-9]' + lt_cv_file_magic_test_file=/usr/lib/pa20_64/libc.sl + ;; + *) + lt_cv_deplibs_check_method='file_magic (s[0-9][0-9][0-9]|PA-RISC[0-9]\.[0-9]) shared library' + lt_cv_file_magic_test_file=/usr/lib/libc.sl + ;; + esac + ;; + +interix[3-9]*) + # PIC code is broken on Interix 3.x, that's why |\.a not |_pic\.a here + lt_cv_deplibs_check_method='match_pattern /lib[^/]+(\.so|\.a)$' + ;; + +irix5* | irix6* | nonstopux*) + case $LD in + *-32|*"-32 ") libmagic=32-bit;; + *-n32|*"-n32 ") libmagic=N32;; + *-64|*"-64 ") libmagic=64-bit;; + *) libmagic=never-match;; + esac + lt_cv_deplibs_check_method=pass_all + ;; + +# This must be glibc/ELF. +linux* | k*bsd*-gnu | kopensolaris*-gnu) + lt_cv_deplibs_check_method=pass_all + ;; + +netbsd*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ > /dev/null; then + lt_cv_deplibs_check_method='match_pattern /lib[^/]+(\.so\.[0-9]+\.[0-9]+|_pic\.a)$' + else + lt_cv_deplibs_check_method='match_pattern /lib[^/]+(\.so|_pic\.a)$' + fi + ;; + +newos6*) + lt_cv_deplibs_check_method='file_magic ELF [0-9][0-9]*-bit [ML]SB (executable|dynamic lib)' + lt_cv_file_magic_cmd=/usr/bin/file + lt_cv_file_magic_test_file=/usr/lib/libnls.so + ;; + +*nto* | *qnx*) + lt_cv_deplibs_check_method=pass_all + ;; + +openbsd*) + if test -z "`echo __ELF__ | $CC -E - | $GREP __ELF__`" || test "$host_os-$host_cpu" = "openbsd2.8-powerpc"; then + lt_cv_deplibs_check_method='match_pattern /lib[^/]+(\.so\.[0-9]+\.[0-9]+|\.so|_pic\.a)$' + else + lt_cv_deplibs_check_method='match_pattern /lib[^/]+(\.so\.[0-9]+\.[0-9]+|_pic\.a)$' + fi + ;; + +osf3* | osf4* | osf5*) + lt_cv_deplibs_check_method=pass_all + ;; + +rdos*) + lt_cv_deplibs_check_method=pass_all + ;; + +solaris*) + lt_cv_deplibs_check_method=pass_all + ;; + +sysv5* | sco3.2v5* | sco5v6* | unixware* | OpenUNIX* | sysv4*uw2*) + lt_cv_deplibs_check_method=pass_all + ;; + +sysv4 | sysv4.3*) + case $host_vendor in + motorola) + lt_cv_deplibs_check_method='file_magic ELF [0-9][0-9]*-bit [ML]SB (shared object|dynamic lib) M[0-9][0-9]* Version [0-9]' + lt_cv_file_magic_test_file=`echo /usr/lib/libc.so*` + ;; + ncr) + lt_cv_deplibs_check_method=pass_all + ;; + sequent) + lt_cv_file_magic_cmd='/bin/file' + lt_cv_deplibs_check_method='file_magic ELF [0-9][0-9]*-bit [LM]SB (shared object|dynamic lib )' + ;; + sni) + lt_cv_file_magic_cmd='/bin/file' + lt_cv_deplibs_check_method="file_magic ELF [0-9][0-9]*-bit [LM]SB dynamic lib" + lt_cv_file_magic_test_file=/lib/libc.so + ;; + siemens) + lt_cv_deplibs_check_method=pass_all + ;; + pc) + lt_cv_deplibs_check_method=pass_all + ;; + esac + ;; + +tpf*) + lt_cv_deplibs_check_method=pass_all + ;; +esac + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_deplibs_check_method" >&5 +$as_echo "$lt_cv_deplibs_check_method" >&6; } + +file_magic_glob= +want_nocaseglob=no +if test "$build" = "$host"; then + case $host_os in + mingw* | pw32*) + if ( shopt | grep nocaseglob ) >/dev/null 2>&1; then + want_nocaseglob=yes + else + file_magic_glob=`echo aAbBcCdDeEfFgGhHiIjJkKlLmMnNoOpPqQrRsStTuUvVwWxXyYzZ | $SED -e "s/\(..\)/s\/[\1]\/[\1]\/g;/g"` + fi + ;; + esac +fi + +file_magic_cmd=$lt_cv_file_magic_cmd +deplibs_check_method=$lt_cv_deplibs_check_method +test -z "$deplibs_check_method" && deplibs_check_method=unknown + + + + + + + + + + + + + + + + + + + + + + +if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}dlltool", so it can be a program name with args. +set dummy ${ac_tool_prefix}dlltool; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_DLLTOOL+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$DLLTOOL"; then + ac_cv_prog_DLLTOOL="$DLLTOOL" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_DLLTOOL="${ac_tool_prefix}dlltool" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +DLLTOOL=$ac_cv_prog_DLLTOOL +if test -n "$DLLTOOL"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $DLLTOOL" >&5 +$as_echo "$DLLTOOL" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_DLLTOOL"; then + ac_ct_DLLTOOL=$DLLTOOL + # Extract the first word of "dlltool", so it can be a program name with args. +set dummy dlltool; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_DLLTOOL+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_DLLTOOL"; then + ac_cv_prog_ac_ct_DLLTOOL="$ac_ct_DLLTOOL" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_DLLTOOL="dlltool" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_DLLTOOL=$ac_cv_prog_ac_ct_DLLTOOL +if test -n "$ac_ct_DLLTOOL"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_DLLTOOL" >&5 +$as_echo "$ac_ct_DLLTOOL" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_DLLTOOL" = x; then + DLLTOOL="false" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + DLLTOOL=$ac_ct_DLLTOOL + fi +else + DLLTOOL="$ac_cv_prog_DLLTOOL" +fi + +test -z "$DLLTOOL" && DLLTOOL=dlltool + + + + + + + + + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking how to associate runtime and link libraries" >&5 +$as_echo_n "checking how to associate runtime and link libraries... " >&6; } +if ${lt_cv_sharedlib_from_linklib_cmd+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_sharedlib_from_linklib_cmd='unknown' + +case $host_os in +cygwin* | mingw* | pw32* | cegcc*) + # two different shell functions defined in ltmain.sh + # decide which to use based on capabilities of $DLLTOOL + case `$DLLTOOL --help 2>&1` in + *--identify-strict*) + lt_cv_sharedlib_from_linklib_cmd=func_cygming_dll_for_implib + ;; + *) + lt_cv_sharedlib_from_linklib_cmd=func_cygming_dll_for_implib_fallback + ;; + esac + ;; +*) + # fallback: assume linklib IS sharedlib + lt_cv_sharedlib_from_linklib_cmd="$ECHO" + ;; +esac + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_sharedlib_from_linklib_cmd" >&5 +$as_echo "$lt_cv_sharedlib_from_linklib_cmd" >&6; } +sharedlib_from_linklib_cmd=$lt_cv_sharedlib_from_linklib_cmd +test -z "$sharedlib_from_linklib_cmd" && sharedlib_from_linklib_cmd=$ECHO + + + + + + + +if test -n "$ac_tool_prefix"; then + for ac_prog in ar + do + # Extract the first word of "$ac_tool_prefix$ac_prog", so it can be a program name with args. +set dummy $ac_tool_prefix$ac_prog; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_AR+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$AR"; then + ac_cv_prog_AR="$AR" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_AR="$ac_tool_prefix$ac_prog" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +AR=$ac_cv_prog_AR +if test -n "$AR"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $AR" >&5 +$as_echo "$AR" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + test -n "$AR" && break + done +fi +if test -z "$AR"; then + ac_ct_AR=$AR + for ac_prog in ar +do + # Extract the first word of "$ac_prog", so it can be a program name with args. +set dummy $ac_prog; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_AR+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_AR"; then + ac_cv_prog_ac_ct_AR="$ac_ct_AR" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_AR="$ac_prog" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_AR=$ac_cv_prog_ac_ct_AR +if test -n "$ac_ct_AR"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_AR" >&5 +$as_echo "$ac_ct_AR" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + test -n "$ac_ct_AR" && break +done + + if test "x$ac_ct_AR" = x; then + AR="false" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + AR=$ac_ct_AR + fi +fi + +: ${AR=ar} +: ${AR_FLAGS=cru} + + + + + + + + + + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for archiver @FILE support" >&5 +$as_echo_n "checking for archiver @FILE support... " >&6; } +if ${lt_cv_ar_at_file+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_ar_at_file=no + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + echo conftest.$ac_objext > conftest.lst + lt_ar_try='$AR $AR_FLAGS libconftest.a @conftest.lst >&5' + { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$lt_ar_try\""; } >&5 + (eval $lt_ar_try) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } + if test "$ac_status" -eq 0; then + # Ensure the archiver fails upon bogus file names. + rm -f conftest.$ac_objext libconftest.a + { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$lt_ar_try\""; } >&5 + (eval $lt_ar_try) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } + if test "$ac_status" -ne 0; then + lt_cv_ar_at_file=@ + fi + fi + rm -f conftest.* libconftest.a + +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_ar_at_file" >&5 +$as_echo "$lt_cv_ar_at_file" >&6; } + +if test "x$lt_cv_ar_at_file" = xno; then + archiver_list_spec= +else + archiver_list_spec=$lt_cv_ar_at_file +fi + + + + + + + +if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}strip", so it can be a program name with args. +set dummy ${ac_tool_prefix}strip; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_STRIP+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$STRIP"; then + ac_cv_prog_STRIP="$STRIP" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_STRIP="${ac_tool_prefix}strip" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +STRIP=$ac_cv_prog_STRIP +if test -n "$STRIP"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $STRIP" >&5 +$as_echo "$STRIP" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_STRIP"; then + ac_ct_STRIP=$STRIP + # Extract the first word of "strip", so it can be a program name with args. +set dummy strip; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_STRIP+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_STRIP"; then + ac_cv_prog_ac_ct_STRIP="$ac_ct_STRIP" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_STRIP="strip" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_STRIP=$ac_cv_prog_ac_ct_STRIP +if test -n "$ac_ct_STRIP"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_STRIP" >&5 +$as_echo "$ac_ct_STRIP" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_STRIP" = x; then + STRIP=":" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + STRIP=$ac_ct_STRIP + fi +else + STRIP="$ac_cv_prog_STRIP" +fi + +test -z "$STRIP" && STRIP=: + + + + + + +if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}ranlib", so it can be a program name with args. +set dummy ${ac_tool_prefix}ranlib; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_RANLIB+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$RANLIB"; then + ac_cv_prog_RANLIB="$RANLIB" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_RANLIB="${ac_tool_prefix}ranlib" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +RANLIB=$ac_cv_prog_RANLIB +if test -n "$RANLIB"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $RANLIB" >&5 +$as_echo "$RANLIB" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_RANLIB"; then + ac_ct_RANLIB=$RANLIB + # Extract the first word of "ranlib", so it can be a program name with args. +set dummy ranlib; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_RANLIB+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_RANLIB"; then + ac_cv_prog_ac_ct_RANLIB="$ac_ct_RANLIB" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_RANLIB="ranlib" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_RANLIB=$ac_cv_prog_ac_ct_RANLIB +if test -n "$ac_ct_RANLIB"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_RANLIB" >&5 +$as_echo "$ac_ct_RANLIB" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_RANLIB" = x; then + RANLIB=":" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + RANLIB=$ac_ct_RANLIB + fi +else + RANLIB="$ac_cv_prog_RANLIB" +fi + +test -z "$RANLIB" && RANLIB=: + + + + + + +# Determine commands to create old-style static archives. +old_archive_cmds='$AR $AR_FLAGS $oldlib$oldobjs' +old_postinstall_cmds='chmod 644 $oldlib' +old_postuninstall_cmds= + +if test -n "$RANLIB"; then + case $host_os in + openbsd*) + old_postinstall_cmds="$old_postinstall_cmds~\$RANLIB -t \$tool_oldlib" + ;; + *) + old_postinstall_cmds="$old_postinstall_cmds~\$RANLIB \$tool_oldlib" + ;; + esac + old_archive_cmds="$old_archive_cmds~\$RANLIB \$tool_oldlib" +fi + +case $host_os in + darwin*) + lock_old_archive_extraction=yes ;; + *) + lock_old_archive_extraction=no ;; +esac + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +# If no C compiler was specified, use CC. +LTCC=${LTCC-"$CC"} + +# If no C compiler flags were specified, use CFLAGS. +LTCFLAGS=${LTCFLAGS-"$CFLAGS"} + +# Allow CC to be a program name with arguments. +compiler=$CC + + +# Check for command to grab the raw symbol name followed by C symbol from nm. +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking command to parse $NM output from $compiler object" >&5 +$as_echo_n "checking command to parse $NM output from $compiler object... " >&6; } +if ${lt_cv_sys_global_symbol_pipe+:} false; then : + $as_echo_n "(cached) " >&6 +else + +# These are sane defaults that work on at least a few old systems. +# [They come from Ultrix. What could be older than Ultrix?!! ;)] + +# Character class describing NM global symbol codes. +symcode='[BCDEGRST]' + +# Regexp to match symbols that can be accessed directly from C. +sympat='\([_A-Za-z][_A-Za-z0-9]*\)' + +# Define system-specific variables. +case $host_os in +aix*) + symcode='[BCDT]' + ;; +cygwin* | mingw* | pw32* | cegcc*) + symcode='[ABCDGISTW]' + ;; +hpux*) + if test "$host_cpu" = ia64; then + symcode='[ABCDEGRST]' + fi + ;; +irix* | nonstopux*) + symcode='[BCDEGRST]' + ;; +osf*) + symcode='[BCDEGQRST]' + ;; +solaris*) + symcode='[BDRT]' + ;; +sco3.2v5*) + symcode='[DT]' + ;; +sysv4.2uw2*) + symcode='[DT]' + ;; +sysv5* | sco5v6* | unixware* | OpenUNIX*) + symcode='[ABDT]' + ;; +sysv4) + symcode='[DFNSTU]' + ;; +esac + +# If we're using GNU nm, then use its standard symbol codes. +case `$NM -V 2>&1` in +*GNU* | *'with BFD'*) + symcode='[ABCDGIRSTW]' ;; +esac + +# Transform an extracted symbol line into a proper C declaration. +# Some systems (esp. on ia64) link data and code symbols differently, +# so use this general approach. +lt_cv_sys_global_symbol_to_cdecl="sed -n -e 's/^T .* \(.*\)$/extern int \1();/p' -e 's/^$symcode* .* \(.*\)$/extern char \1;/p'" + +# Transform an extracted symbol line into symbol name and symbol address +lt_cv_sys_global_symbol_to_c_name_address="sed -n -e 's/^: \([^ ]*\)[ ]*$/ {\\\"\1\\\", (void *) 0},/p' -e 's/^$symcode* \([^ ]*\) \([^ ]*\)$/ {\"\2\", (void *) \&\2},/p'" +lt_cv_sys_global_symbol_to_c_name_address_lib_prefix="sed -n -e 's/^: \([^ ]*\)[ ]*$/ {\\\"\1\\\", (void *) 0},/p' -e 's/^$symcode* \([^ ]*\) \(lib[^ ]*\)$/ {\"\2\", (void *) \&\2},/p' -e 's/^$symcode* \([^ ]*\) \([^ ]*\)$/ {\"lib\2\", (void *) \&\2},/p'" + +# Handle CRLF in mingw tool chain +opt_cr= +case $build_os in +mingw*) + opt_cr=`$ECHO 'x\{0,1\}' | tr x '\015'` # option cr in regexp + ;; +esac + +# Try without a prefix underscore, then with it. +for ac_symprfx in "" "_"; do + + # Transform symcode, sympat, and symprfx into a raw symbol and a C symbol. + symxfrm="\\1 $ac_symprfx\\2 \\2" + + # Write the raw and C identifiers. + if test "$lt_cv_nm_interface" = "MS dumpbin"; then + # Fake it for dumpbin and say T for any non-static function + # and D for any global variable. + # Also find C++ and __fastcall symbols from MSVC++, + # which start with @ or ?. + lt_cv_sys_global_symbol_pipe="$AWK '"\ +" {last_section=section; section=\$ 3};"\ +" /^COFF SYMBOL TABLE/{for(i in hide) delete hide[i]};"\ +" /Section length .*#relocs.*(pick any)/{hide[last_section]=1};"\ +" \$ 0!~/External *\|/{next};"\ +" / 0+ UNDEF /{next}; / UNDEF \([^|]\)*()/{next};"\ +" {if(hide[section]) next};"\ +" {f=0}; \$ 0~/\(\).*\|/{f=1}; {printf f ? \"T \" : \"D \"};"\ +" {split(\$ 0, a, /\||\r/); split(a[2], s)};"\ +" s[1]~/^[@?]/{print s[1], s[1]; next};"\ +" s[1]~prfx {split(s[1],t,\"@\"); print t[1], substr(t[1],length(prfx))}"\ +" ' prfx=^$ac_symprfx" + else + lt_cv_sys_global_symbol_pipe="sed -n -e 's/^.*[ ]\($symcode$symcode*\)[ ][ ]*$ac_symprfx$sympat$opt_cr$/$symxfrm/p'" + fi + lt_cv_sys_global_symbol_pipe="$lt_cv_sys_global_symbol_pipe | sed '/ __gnu_lto/d'" + + # Check to see that the pipe works correctly. + pipe_works=no + + rm -f conftest* + cat > conftest.$ac_ext <<_LT_EOF +#ifdef __cplusplus +extern "C" { +#endif +char nm_test_var; +void nm_test_func(void); +void nm_test_func(void){} +#ifdef __cplusplus +} +#endif +int main(){nm_test_var='a';nm_test_func();return(0);} +_LT_EOF + + if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$ac_compile\""; } >&5 + (eval $ac_compile) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; then + # Now try to grab the symbols. + nlist=conftest.nm + if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$NM conftest.$ac_objext \| "$lt_cv_sys_global_symbol_pipe" \> $nlist\""; } >&5 + (eval $NM conftest.$ac_objext \| "$lt_cv_sys_global_symbol_pipe" \> $nlist) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } && test -s "$nlist"; then + # Try sorting and uniquifying the output. + if sort "$nlist" | uniq > "$nlist"T; then + mv -f "$nlist"T "$nlist" + else + rm -f "$nlist"T + fi + + # Make sure that we snagged all the symbols we need. + if $GREP ' nm_test_var$' "$nlist" >/dev/null; then + if $GREP ' nm_test_func$' "$nlist" >/dev/null; then + cat <<_LT_EOF > conftest.$ac_ext +/* Keep this code in sync between libtool.m4, ltmain, lt_system.h, and tests. */ +#if defined(_WIN32) || defined(__CYGWIN__) || defined(_WIN32_WCE) +/* DATA imports from DLLs on WIN32 con't be const, because runtime + relocations are performed -- see ld's documentation on pseudo-relocs. */ +# define LT_DLSYM_CONST +#elif defined(__osf__) +/* This system does not cope well with relocations in const data. */ +# define LT_DLSYM_CONST +#else +# define LT_DLSYM_CONST const +#endif + +#ifdef __cplusplus +extern "C" { +#endif + +_LT_EOF + # Now generate the symbol file. + eval "$lt_cv_sys_global_symbol_to_cdecl"' < "$nlist" | $GREP -v main >> conftest.$ac_ext' + + cat <<_LT_EOF >> conftest.$ac_ext + +/* The mapping between symbol names and symbols. */ +LT_DLSYM_CONST struct { + const char *name; + void *address; +} +lt__PROGRAM__LTX_preloaded_symbols[] = +{ + { "@PROGRAM@", (void *) 0 }, +_LT_EOF + $SED "s/^$symcode$symcode* \(.*\) \(.*\)$/ {\"\2\", (void *) \&\2},/" < "$nlist" | $GREP -v main >> conftest.$ac_ext + cat <<\_LT_EOF >> conftest.$ac_ext + {0, (void *) 0} +}; + +/* This works around a problem in FreeBSD linker */ +#ifdef FREEBSD_WORKAROUND +static const void *lt_preloaded_setup() { + return lt__PROGRAM__LTX_preloaded_symbols; +} +#endif + +#ifdef __cplusplus +} +#endif +_LT_EOF + # Now try linking the two files. + mv conftest.$ac_objext conftstm.$ac_objext + lt_globsym_save_LIBS=$LIBS + lt_globsym_save_CFLAGS=$CFLAGS + LIBS="conftstm.$ac_objext" + CFLAGS="$CFLAGS$lt_prog_compiler_no_builtin_flag" + if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$ac_link\""; } >&5 + (eval $ac_link) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } && test -s conftest${ac_exeext}; then + pipe_works=yes + fi + LIBS=$lt_globsym_save_LIBS + CFLAGS=$lt_globsym_save_CFLAGS + else + echo "cannot find nm_test_func in $nlist" >&5 + fi + else + echo "cannot find nm_test_var in $nlist" >&5 + fi + else + echo "cannot run $lt_cv_sys_global_symbol_pipe" >&5 + fi + else + echo "$progname: failed program was:" >&5 + cat conftest.$ac_ext >&5 + fi + rm -rf conftest* conftst* + + # Do not use the global_symbol_pipe unless it works. + if test "$pipe_works" = yes; then + break + else + lt_cv_sys_global_symbol_pipe= + fi +done + +fi + +if test -z "$lt_cv_sys_global_symbol_pipe"; then + lt_cv_sys_global_symbol_to_cdecl= +fi +if test -z "$lt_cv_sys_global_symbol_pipe$lt_cv_sys_global_symbol_to_cdecl"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: failed" >&5 +$as_echo "failed" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: ok" >&5 +$as_echo "ok" >&6; } +fi + +# Response file support. +if test "$lt_cv_nm_interface" = "MS dumpbin"; then + nm_file_list_spec='@' +elif $NM --help 2>/dev/null | grep '[@]FILE' >/dev/null; then + nm_file_list_spec='@' +fi + + + + + + + + + + + + + + + + + + + + + + + + + + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for sysroot" >&5 +$as_echo_n "checking for sysroot... " >&6; } + +# Check whether --with-sysroot was given. +if test "${with_sysroot+set}" = set; then : + withval=$with_sysroot; +else + with_sysroot=no +fi + + +lt_sysroot= +case ${with_sysroot} in #( + yes) + if test "$GCC" = yes; then + lt_sysroot=`$CC --print-sysroot 2>/dev/null` + fi + ;; #( + /*) + lt_sysroot=`echo "$with_sysroot" | sed -e "$sed_quote_subst"` + ;; #( + no|'') + ;; #( + *) + { $as_echo "$as_me:${as_lineno-$LINENO}: result: ${with_sysroot}" >&5 +$as_echo "${with_sysroot}" >&6; } + as_fn_error $? "The sysroot must be an absolute path." "$LINENO" 5 + ;; +esac + + { $as_echo "$as_me:${as_lineno-$LINENO}: result: ${lt_sysroot:-no}" >&5 +$as_echo "${lt_sysroot:-no}" >&6; } + + + + + +# Check whether --enable-libtool-lock was given. +if test "${enable_libtool_lock+set}" = set; then : + enableval=$enable_libtool_lock; +fi + +test "x$enable_libtool_lock" != xno && enable_libtool_lock=yes + +# Some flags need to be propagated to the compiler or linker for good +# libtool support. +case $host in +ia64-*-hpux*) + # Find out which ABI we are using. + echo 'int i;' > conftest.$ac_ext + if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$ac_compile\""; } >&5 + (eval $ac_compile) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; then + case `/usr/bin/file conftest.$ac_objext` in + *ELF-32*) + HPUX_IA64_MODE="32" + ;; + *ELF-64*) + HPUX_IA64_MODE="64" + ;; + esac + fi + rm -rf conftest* + ;; +*-*-irix6*) + # Find out which ABI we are using. + echo '#line '$LINENO' "configure"' > conftest.$ac_ext + if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$ac_compile\""; } >&5 + (eval $ac_compile) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; then + if test "$lt_cv_prog_gnu_ld" = yes; then + case `/usr/bin/file conftest.$ac_objext` in + *32-bit*) + LD="${LD-ld} -melf32bsmip" + ;; + *N32*) + LD="${LD-ld} -melf32bmipn32" + ;; + *64-bit*) + LD="${LD-ld} -melf64bmip" + ;; + esac + else + case `/usr/bin/file conftest.$ac_objext` in + *32-bit*) + LD="${LD-ld} -32" + ;; + *N32*) + LD="${LD-ld} -n32" + ;; + *64-bit*) + LD="${LD-ld} -64" + ;; + esac + fi + fi + rm -rf conftest* + ;; + +x86_64-*kfreebsd*-gnu|x86_64-*linux*|ppc*-*linux*|powerpc*-*linux*| \ +s390*-*linux*|s390*-*tpf*|sparc*-*linux*) + # Find out which ABI we are using. + echo 'int i;' > conftest.$ac_ext + if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$ac_compile\""; } >&5 + (eval $ac_compile) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; then + case `/usr/bin/file conftest.o` in + *32-bit*) + case $host in + x86_64-*kfreebsd*-gnu) + LD="${LD-ld} -m elf_i386_fbsd" + ;; + x86_64-*linux*) + LD="${LD-ld} -m elf_i386" + ;; + ppc64-*linux*|powerpc64-*linux*) + LD="${LD-ld} -m elf32ppclinux" + ;; + s390x-*linux*) + LD="${LD-ld} -m elf_s390" + ;; + sparc64-*linux*) + LD="${LD-ld} -m elf32_sparc" + ;; + esac + ;; + *64-bit*) + case $host in + x86_64-*kfreebsd*-gnu) + LD="${LD-ld} -m elf_x86_64_fbsd" + ;; + x86_64-*linux*) + LD="${LD-ld} -m elf_x86_64" + ;; + ppc*-*linux*|powerpc*-*linux*) + LD="${LD-ld} -m elf64ppc" + ;; + s390*-*linux*|s390*-*tpf*) + LD="${LD-ld} -m elf64_s390" + ;; + sparc*-*linux*) + LD="${LD-ld} -m elf64_sparc" + ;; + esac + ;; + esac + fi + rm -rf conftest* + ;; + +*-*-sco3.2v5*) + # On SCO OpenServer 5, we need -belf to get full-featured binaries. + SAVE_CFLAGS="$CFLAGS" + CFLAGS="$CFLAGS -belf" + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether the C compiler needs -belf" >&5 +$as_echo_n "checking whether the C compiler needs -belf... " >&6; } +if ${lt_cv_cc_needs_belf+:} false; then : + $as_echo_n "(cached) " >&6 +else + ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu + + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + lt_cv_cc_needs_belf=yes +else + lt_cv_cc_needs_belf=no +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext + ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_cc_needs_belf" >&5 +$as_echo "$lt_cv_cc_needs_belf" >&6; } + if test x"$lt_cv_cc_needs_belf" != x"yes"; then + # this is probably gcc 2.8.0, egcs 1.0 or newer; no need for -belf + CFLAGS="$SAVE_CFLAGS" + fi + ;; +*-*solaris*) + # Find out which ABI we are using. + echo 'int i;' > conftest.$ac_ext + if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$ac_compile\""; } >&5 + (eval $ac_compile) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; then + case `/usr/bin/file conftest.o` in + *64-bit*) + case $lt_cv_prog_gnu_ld in + yes*) + case $host in + i?86-*-solaris*) + LD="${LD-ld} -m elf_x86_64" + ;; + sparc*-*-solaris*) + LD="${LD-ld} -m elf64_sparc" + ;; + esac + # GNU ld 2.21 introduced _sol2 emulations. Use them if available. + if ${LD-ld} -V | grep _sol2 >/dev/null 2>&1; then + LD="${LD-ld}_sol2" + fi + ;; + *) + if ${LD-ld} -64 -r -o conftest2.o conftest.o >/dev/null 2>&1; then + LD="${LD-ld} -64" + fi + ;; + esac + ;; + esac + fi + rm -rf conftest* + ;; +esac + +need_locks="$enable_libtool_lock" + +if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}mt", so it can be a program name with args. +set dummy ${ac_tool_prefix}mt; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_MANIFEST_TOOL+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$MANIFEST_TOOL"; then + ac_cv_prog_MANIFEST_TOOL="$MANIFEST_TOOL" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_MANIFEST_TOOL="${ac_tool_prefix}mt" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +MANIFEST_TOOL=$ac_cv_prog_MANIFEST_TOOL +if test -n "$MANIFEST_TOOL"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $MANIFEST_TOOL" >&5 +$as_echo "$MANIFEST_TOOL" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_MANIFEST_TOOL"; then + ac_ct_MANIFEST_TOOL=$MANIFEST_TOOL + # Extract the first word of "mt", so it can be a program name with args. +set dummy mt; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_MANIFEST_TOOL+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_MANIFEST_TOOL"; then + ac_cv_prog_ac_ct_MANIFEST_TOOL="$ac_ct_MANIFEST_TOOL" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_MANIFEST_TOOL="mt" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_MANIFEST_TOOL=$ac_cv_prog_ac_ct_MANIFEST_TOOL +if test -n "$ac_ct_MANIFEST_TOOL"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_MANIFEST_TOOL" >&5 +$as_echo "$ac_ct_MANIFEST_TOOL" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_MANIFEST_TOOL" = x; then + MANIFEST_TOOL=":" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + MANIFEST_TOOL=$ac_ct_MANIFEST_TOOL + fi +else + MANIFEST_TOOL="$ac_cv_prog_MANIFEST_TOOL" +fi + +test -z "$MANIFEST_TOOL" && MANIFEST_TOOL=mt +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking if $MANIFEST_TOOL is a manifest tool" >&5 +$as_echo_n "checking if $MANIFEST_TOOL is a manifest tool... " >&6; } +if ${lt_cv_path_mainfest_tool+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_path_mainfest_tool=no + echo "$as_me:$LINENO: $MANIFEST_TOOL '-?'" >&5 + $MANIFEST_TOOL '-?' 2>conftest.err > conftest.out + cat conftest.err >&5 + if $GREP 'Manifest Tool' conftest.out > /dev/null; then + lt_cv_path_mainfest_tool=yes + fi + rm -f conftest* +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_path_mainfest_tool" >&5 +$as_echo "$lt_cv_path_mainfest_tool" >&6; } +if test "x$lt_cv_path_mainfest_tool" != xyes; then + MANIFEST_TOOL=: +fi + + + + + + + case $host_os in + rhapsody* | darwin*) + if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}dsymutil", so it can be a program name with args. +set dummy ${ac_tool_prefix}dsymutil; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_DSYMUTIL+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$DSYMUTIL"; then + ac_cv_prog_DSYMUTIL="$DSYMUTIL" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_DSYMUTIL="${ac_tool_prefix}dsymutil" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +DSYMUTIL=$ac_cv_prog_DSYMUTIL +if test -n "$DSYMUTIL"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $DSYMUTIL" >&5 +$as_echo "$DSYMUTIL" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_DSYMUTIL"; then + ac_ct_DSYMUTIL=$DSYMUTIL + # Extract the first word of "dsymutil", so it can be a program name with args. +set dummy dsymutil; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_DSYMUTIL+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_DSYMUTIL"; then + ac_cv_prog_ac_ct_DSYMUTIL="$ac_ct_DSYMUTIL" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_DSYMUTIL="dsymutil" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_DSYMUTIL=$ac_cv_prog_ac_ct_DSYMUTIL +if test -n "$ac_ct_DSYMUTIL"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_DSYMUTIL" >&5 +$as_echo "$ac_ct_DSYMUTIL" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_DSYMUTIL" = x; then + DSYMUTIL=":" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + DSYMUTIL=$ac_ct_DSYMUTIL + fi +else + DSYMUTIL="$ac_cv_prog_DSYMUTIL" +fi + + if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}nmedit", so it can be a program name with args. +set dummy ${ac_tool_prefix}nmedit; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_NMEDIT+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$NMEDIT"; then + ac_cv_prog_NMEDIT="$NMEDIT" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_NMEDIT="${ac_tool_prefix}nmedit" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +NMEDIT=$ac_cv_prog_NMEDIT +if test -n "$NMEDIT"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $NMEDIT" >&5 +$as_echo "$NMEDIT" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_NMEDIT"; then + ac_ct_NMEDIT=$NMEDIT + # Extract the first word of "nmedit", so it can be a program name with args. +set dummy nmedit; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_NMEDIT+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_NMEDIT"; then + ac_cv_prog_ac_ct_NMEDIT="$ac_ct_NMEDIT" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_NMEDIT="nmedit" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_NMEDIT=$ac_cv_prog_ac_ct_NMEDIT +if test -n "$ac_ct_NMEDIT"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_NMEDIT" >&5 +$as_echo "$ac_ct_NMEDIT" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_NMEDIT" = x; then + NMEDIT=":" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + NMEDIT=$ac_ct_NMEDIT + fi +else + NMEDIT="$ac_cv_prog_NMEDIT" +fi + + if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}lipo", so it can be a program name with args. +set dummy ${ac_tool_prefix}lipo; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_LIPO+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$LIPO"; then + ac_cv_prog_LIPO="$LIPO" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_LIPO="${ac_tool_prefix}lipo" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +LIPO=$ac_cv_prog_LIPO +if test -n "$LIPO"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $LIPO" >&5 +$as_echo "$LIPO" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_LIPO"; then + ac_ct_LIPO=$LIPO + # Extract the first word of "lipo", so it can be a program name with args. +set dummy lipo; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_LIPO+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_LIPO"; then + ac_cv_prog_ac_ct_LIPO="$ac_ct_LIPO" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_LIPO="lipo" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_LIPO=$ac_cv_prog_ac_ct_LIPO +if test -n "$ac_ct_LIPO"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_LIPO" >&5 +$as_echo "$ac_ct_LIPO" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_LIPO" = x; then + LIPO=":" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + LIPO=$ac_ct_LIPO + fi +else + LIPO="$ac_cv_prog_LIPO" +fi + + if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}otool", so it can be a program name with args. +set dummy ${ac_tool_prefix}otool; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_OTOOL+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$OTOOL"; then + ac_cv_prog_OTOOL="$OTOOL" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_OTOOL="${ac_tool_prefix}otool" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +OTOOL=$ac_cv_prog_OTOOL +if test -n "$OTOOL"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $OTOOL" >&5 +$as_echo "$OTOOL" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_OTOOL"; then + ac_ct_OTOOL=$OTOOL + # Extract the first word of "otool", so it can be a program name with args. +set dummy otool; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_OTOOL+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_OTOOL"; then + ac_cv_prog_ac_ct_OTOOL="$ac_ct_OTOOL" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_OTOOL="otool" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_OTOOL=$ac_cv_prog_ac_ct_OTOOL +if test -n "$ac_ct_OTOOL"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_OTOOL" >&5 +$as_echo "$ac_ct_OTOOL" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_OTOOL" = x; then + OTOOL=":" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + OTOOL=$ac_ct_OTOOL + fi +else + OTOOL="$ac_cv_prog_OTOOL" +fi + + if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}otool64", so it can be a program name with args. +set dummy ${ac_tool_prefix}otool64; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_OTOOL64+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$OTOOL64"; then + ac_cv_prog_OTOOL64="$OTOOL64" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_OTOOL64="${ac_tool_prefix}otool64" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +OTOOL64=$ac_cv_prog_OTOOL64 +if test -n "$OTOOL64"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $OTOOL64" >&5 +$as_echo "$OTOOL64" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_OTOOL64"; then + ac_ct_OTOOL64=$OTOOL64 + # Extract the first word of "otool64", so it can be a program name with args. +set dummy otool64; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_OTOOL64+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_OTOOL64"; then + ac_cv_prog_ac_ct_OTOOL64="$ac_ct_OTOOL64" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_OTOOL64="otool64" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_OTOOL64=$ac_cv_prog_ac_ct_OTOOL64 +if test -n "$ac_ct_OTOOL64"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_OTOOL64" >&5 +$as_echo "$ac_ct_OTOOL64" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_OTOOL64" = x; then + OTOOL64=":" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + OTOOL64=$ac_ct_OTOOL64 + fi +else + OTOOL64="$ac_cv_prog_OTOOL64" +fi + + + + + + + + + + + + + + + + + + + + + + + + + + + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for -single_module linker flag" >&5 +$as_echo_n "checking for -single_module linker flag... " >&6; } +if ${lt_cv_apple_cc_single_mod+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_apple_cc_single_mod=no + if test -z "${LT_MULTI_MODULE}"; then + # By default we will add the -single_module flag. You can override + # by either setting the environment variable LT_MULTI_MODULE + # non-empty at configure time, or by adding -multi_module to the + # link flags. + rm -rf libconftest.dylib* + echo "int foo(void){return 1;}" > conftest.c + echo "$LTCC $LTCFLAGS $LDFLAGS -o libconftest.dylib \ +-dynamiclib -Wl,-single_module conftest.c" >&5 + $LTCC $LTCFLAGS $LDFLAGS -o libconftest.dylib \ + -dynamiclib -Wl,-single_module conftest.c 2>conftest.err + _lt_result=$? + # If there is a non-empty error log, and "single_module" + # appears in it, assume the flag caused a linker warning + if test -s conftest.err && $GREP single_module conftest.err; then + cat conftest.err >&5 + # Otherwise, if the output was created with a 0 exit code from + # the compiler, it worked. + elif test -f libconftest.dylib && test $_lt_result -eq 0; then + lt_cv_apple_cc_single_mod=yes + else + cat conftest.err >&5 + fi + rm -rf libconftest.dylib* + rm -f conftest.* + fi +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_apple_cc_single_mod" >&5 +$as_echo "$lt_cv_apple_cc_single_mod" >&6; } + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for -exported_symbols_list linker flag" >&5 +$as_echo_n "checking for -exported_symbols_list linker flag... " >&6; } +if ${lt_cv_ld_exported_symbols_list+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_ld_exported_symbols_list=no + save_LDFLAGS=$LDFLAGS + echo "_main" > conftest.sym + LDFLAGS="$LDFLAGS -Wl,-exported_symbols_list,conftest.sym" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + lt_cv_ld_exported_symbols_list=yes +else + lt_cv_ld_exported_symbols_list=no +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext + LDFLAGS="$save_LDFLAGS" + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_ld_exported_symbols_list" >&5 +$as_echo "$lt_cv_ld_exported_symbols_list" >&6; } + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for -force_load linker flag" >&5 +$as_echo_n "checking for -force_load linker flag... " >&6; } +if ${lt_cv_ld_force_load+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_ld_force_load=no + cat > conftest.c << _LT_EOF +int forced_loaded() { return 2;} +_LT_EOF + echo "$LTCC $LTCFLAGS -c -o conftest.o conftest.c" >&5 + $LTCC $LTCFLAGS -c -o conftest.o conftest.c 2>&5 + echo "$AR cru libconftest.a conftest.o" >&5 + $AR cru libconftest.a conftest.o 2>&5 + echo "$RANLIB libconftest.a" >&5 + $RANLIB libconftest.a 2>&5 + cat > conftest.c << _LT_EOF +int main() { return 0;} +_LT_EOF + echo "$LTCC $LTCFLAGS $LDFLAGS -o conftest conftest.c -Wl,-force_load,./libconftest.a" >&5 + $LTCC $LTCFLAGS $LDFLAGS -o conftest conftest.c -Wl,-force_load,./libconftest.a 2>conftest.err + _lt_result=$? + if test -s conftest.err && $GREP force_load conftest.err; then + cat conftest.err >&5 + elif test -f conftest && test $_lt_result -eq 0 && $GREP forced_load conftest >/dev/null 2>&1 ; then + lt_cv_ld_force_load=yes + else + cat conftest.err >&5 + fi + rm -f conftest.err libconftest.a conftest conftest.c + rm -rf conftest.dSYM + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_ld_force_load" >&5 +$as_echo "$lt_cv_ld_force_load" >&6; } + case $host_os in + rhapsody* | darwin1.[012]) + _lt_dar_allow_undefined='${wl}-undefined ${wl}suppress' ;; + darwin1.*) + _lt_dar_allow_undefined='${wl}-flat_namespace ${wl}-undefined ${wl}suppress' ;; + darwin*) # darwin 5.x on + # if running on 10.5 or later, the deployment target defaults + # to the OS version, if on x86, and 10.4, the deployment + # target defaults to 10.4. Don't you love it? + case ${MACOSX_DEPLOYMENT_TARGET-10.0},$host in + 10.0,*86*-darwin8*|10.0,*-darwin[91]*) + _lt_dar_allow_undefined='${wl}-undefined ${wl}dynamic_lookup' ;; + 10.[012]*) + _lt_dar_allow_undefined='${wl}-flat_namespace ${wl}-undefined ${wl}suppress' ;; + 10.*) + _lt_dar_allow_undefined='${wl}-undefined ${wl}dynamic_lookup' ;; + esac + ;; + esac + if test "$lt_cv_apple_cc_single_mod" = "yes"; then + _lt_dar_single_mod='$single_module' + fi + if test "$lt_cv_ld_exported_symbols_list" = "yes"; then + _lt_dar_export_syms=' ${wl}-exported_symbols_list,$output_objdir/${libname}-symbols.expsym' + else + _lt_dar_export_syms='~$NMEDIT -s $output_objdir/${libname}-symbols.expsym ${lib}' + fi + if test "$DSYMUTIL" != ":" && test "$lt_cv_ld_force_load" = "no"; then + _lt_dsymutil='~$DSYMUTIL $lib || :' + else + _lt_dsymutil= + fi + ;; + esac + +for ac_header in dlfcn.h +do : + ac_fn_c_check_header_compile "$LINENO" "dlfcn.h" "ac_cv_header_dlfcn_h" "$ac_includes_default +" +if test "x$ac_cv_header_dlfcn_h" = xyes; then : + cat >>confdefs.h <<_ACEOF +#define HAVE_DLFCN_H 1 +_ACEOF + +fi + +done + + + + + +# Set options + + + + enable_dlopen=no + + + enable_win32_dll=no + + + # Check whether --enable-shared was given. +if test "${enable_shared+set}" = set; then : + enableval=$enable_shared; p=${PACKAGE-default} + case $enableval in + yes) enable_shared=yes ;; + no) enable_shared=no ;; + *) + enable_shared=no + # Look at the argument we got. We use all the common list separators. + lt_save_ifs="$IFS"; IFS="${IFS}$PATH_SEPARATOR," + for pkg in $enableval; do + IFS="$lt_save_ifs" + if test "X$pkg" = "X$p"; then + enable_shared=yes + fi + done + IFS="$lt_save_ifs" + ;; + esac +else + enable_shared=yes +fi + + + + + + + + + + # Check whether --enable-static was given. +if test "${enable_static+set}" = set; then : + enableval=$enable_static; p=${PACKAGE-default} + case $enableval in + yes) enable_static=yes ;; + no) enable_static=no ;; + *) + enable_static=no + # Look at the argument we got. We use all the common list separators. + lt_save_ifs="$IFS"; IFS="${IFS}$PATH_SEPARATOR," + for pkg in $enableval; do + IFS="$lt_save_ifs" + if test "X$pkg" = "X$p"; then + enable_static=yes + fi + done + IFS="$lt_save_ifs" + ;; + esac +else + enable_static=yes +fi + + + + + + + + + + +# Check whether --with-pic was given. +if test "${with_pic+set}" = set; then : + withval=$with_pic; lt_p=${PACKAGE-default} + case $withval in + yes|no) pic_mode=$withval ;; + *) + pic_mode=default + # Look at the argument we got. We use all the common list separators. + lt_save_ifs="$IFS"; IFS="${IFS}$PATH_SEPARATOR," + for lt_pkg in $withval; do + IFS="$lt_save_ifs" + if test "X$lt_pkg" = "X$lt_p"; then + pic_mode=yes + fi + done + IFS="$lt_save_ifs" + ;; + esac +else + pic_mode=default +fi + + +test -z "$pic_mode" && pic_mode=default + + + + + + + + # Check whether --enable-fast-install was given. +if test "${enable_fast_install+set}" = set; then : + enableval=$enable_fast_install; p=${PACKAGE-default} + case $enableval in + yes) enable_fast_install=yes ;; + no) enable_fast_install=no ;; + *) + enable_fast_install=no + # Look at the argument we got. We use all the common list separators. + lt_save_ifs="$IFS"; IFS="${IFS}$PATH_SEPARATOR," + for pkg in $enableval; do + IFS="$lt_save_ifs" + if test "X$pkg" = "X$p"; then + enable_fast_install=yes + fi + done + IFS="$lt_save_ifs" + ;; + esac +else + enable_fast_install=yes +fi + + + + + + + + + + + +# This can be used to rebuild libtool when needed +LIBTOOL_DEPS="$ltmain" + +# Always use our own libtool. +LIBTOOL='$(SHELL) $(top_builddir)/libtool' + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + +test -z "$LN_S" && LN_S="ln -s" + + + + + + + + + + + + + + +if test -n "${ZSH_VERSION+set}" ; then + setopt NO_GLOB_SUBST +fi + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for objdir" >&5 +$as_echo_n "checking for objdir... " >&6; } +if ${lt_cv_objdir+:} false; then : + $as_echo_n "(cached) " >&6 +else + rm -f .libs 2>/dev/null +mkdir .libs 2>/dev/null +if test -d .libs; then + lt_cv_objdir=.libs +else + # MS-DOS does not allow filenames that begin with a dot. + lt_cv_objdir=_libs +fi +rmdir .libs 2>/dev/null +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_objdir" >&5 +$as_echo "$lt_cv_objdir" >&6; } +objdir=$lt_cv_objdir + + + + + +cat >>confdefs.h <<_ACEOF +#define LT_OBJDIR "$lt_cv_objdir/" +_ACEOF + + + + +case $host_os in +aix3*) + # AIX sometimes has problems with the GCC collect2 program. For some + # reason, if we set the COLLECT_NAMES environment variable, the problems + # vanish in a puff of smoke. + if test "X${COLLECT_NAMES+set}" != Xset; then + COLLECT_NAMES= + export COLLECT_NAMES + fi + ;; +esac + +# Global variables: +ofile=libtool +can_build_shared=yes + +# All known linkers require a `.a' archive for static linking (except MSVC, +# which needs '.lib'). +libext=a + +with_gnu_ld="$lt_cv_prog_gnu_ld" + +old_CC="$CC" +old_CFLAGS="$CFLAGS" + +# Set sane defaults for various variables +test -z "$CC" && CC=cc +test -z "$LTCC" && LTCC=$CC +test -z "$LTCFLAGS" && LTCFLAGS=$CFLAGS +test -z "$LD" && LD=ld +test -z "$ac_objext" && ac_objext=o + +for cc_temp in $compiler""; do + case $cc_temp in + compile | *[\\/]compile | ccache | *[\\/]ccache ) ;; + distcc | *[\\/]distcc | purify | *[\\/]purify ) ;; + \-*) ;; + *) break;; + esac +done +cc_basename=`$ECHO "$cc_temp" | $SED "s%.*/%%; s%^$host_alias-%%"` + + +# Only perform the check for file, if the check method requires it +test -z "$MAGIC_CMD" && MAGIC_CMD=file +case $deplibs_check_method in +file_magic*) + if test "$file_magic_cmd" = '$MAGIC_CMD'; then + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for ${ac_tool_prefix}file" >&5 +$as_echo_n "checking for ${ac_tool_prefix}file... " >&6; } +if ${lt_cv_path_MAGIC_CMD+:} false; then : + $as_echo_n "(cached) " >&6 +else + case $MAGIC_CMD in +[\\/*] | ?:[\\/]*) + lt_cv_path_MAGIC_CMD="$MAGIC_CMD" # Let the user override the test with a path. + ;; +*) + lt_save_MAGIC_CMD="$MAGIC_CMD" + lt_save_ifs="$IFS"; IFS=$PATH_SEPARATOR + ac_dummy="/usr/bin$PATH_SEPARATOR$PATH" + for ac_dir in $ac_dummy; do + IFS="$lt_save_ifs" + test -z "$ac_dir" && ac_dir=. + if test -f $ac_dir/${ac_tool_prefix}file; then + lt_cv_path_MAGIC_CMD="$ac_dir/${ac_tool_prefix}file" + if test -n "$file_magic_test_file"; then + case $deplibs_check_method in + "file_magic "*) + file_magic_regex=`expr "$deplibs_check_method" : "file_magic \(.*\)"` + MAGIC_CMD="$lt_cv_path_MAGIC_CMD" + if eval $file_magic_cmd \$file_magic_test_file 2> /dev/null | + $EGREP "$file_magic_regex" > /dev/null; then + : + else + cat <<_LT_EOF 1>&2 + +*** Warning: the command libtool uses to detect shared libraries, +*** $file_magic_cmd, produces output that libtool cannot recognize. +*** The result is that libtool may fail to recognize shared libraries +*** as such. This will affect the creation of libtool libraries that +*** depend on shared libraries, but programs linked with such libtool +*** libraries will work regardless of this problem. Nevertheless, you +*** may want to report the problem to your system manager and/or to +*** bug-libtool@gnu.org + +_LT_EOF + fi ;; + esac + fi + break + fi + done + IFS="$lt_save_ifs" + MAGIC_CMD="$lt_save_MAGIC_CMD" + ;; +esac +fi + +MAGIC_CMD="$lt_cv_path_MAGIC_CMD" +if test -n "$MAGIC_CMD"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $MAGIC_CMD" >&5 +$as_echo "$MAGIC_CMD" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + + + +if test -z "$lt_cv_path_MAGIC_CMD"; then + if test -n "$ac_tool_prefix"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for file" >&5 +$as_echo_n "checking for file... " >&6; } +if ${lt_cv_path_MAGIC_CMD+:} false; then : + $as_echo_n "(cached) " >&6 +else + case $MAGIC_CMD in +[\\/*] | ?:[\\/]*) + lt_cv_path_MAGIC_CMD="$MAGIC_CMD" # Let the user override the test with a path. + ;; +*) + lt_save_MAGIC_CMD="$MAGIC_CMD" + lt_save_ifs="$IFS"; IFS=$PATH_SEPARATOR + ac_dummy="/usr/bin$PATH_SEPARATOR$PATH" + for ac_dir in $ac_dummy; do + IFS="$lt_save_ifs" + test -z "$ac_dir" && ac_dir=. + if test -f $ac_dir/file; then + lt_cv_path_MAGIC_CMD="$ac_dir/file" + if test -n "$file_magic_test_file"; then + case $deplibs_check_method in + "file_magic "*) + file_magic_regex=`expr "$deplibs_check_method" : "file_magic \(.*\)"` + MAGIC_CMD="$lt_cv_path_MAGIC_CMD" + if eval $file_magic_cmd \$file_magic_test_file 2> /dev/null | + $EGREP "$file_magic_regex" > /dev/null; then + : + else + cat <<_LT_EOF 1>&2 + +*** Warning: the command libtool uses to detect shared libraries, +*** $file_magic_cmd, produces output that libtool cannot recognize. +*** The result is that libtool may fail to recognize shared libraries +*** as such. This will affect the creation of libtool libraries that +*** depend on shared libraries, but programs linked with such libtool +*** libraries will work regardless of this problem. Nevertheless, you +*** may want to report the problem to your system manager and/or to +*** bug-libtool@gnu.org + +_LT_EOF + fi ;; + esac + fi + break + fi + done + IFS="$lt_save_ifs" + MAGIC_CMD="$lt_save_MAGIC_CMD" + ;; +esac +fi + +MAGIC_CMD="$lt_cv_path_MAGIC_CMD" +if test -n "$MAGIC_CMD"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $MAGIC_CMD" >&5 +$as_echo "$MAGIC_CMD" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + else + MAGIC_CMD=: + fi +fi + + fi + ;; +esac + +# Use C for the default configuration in the libtool script + +lt_save_CC="$CC" +ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu + + +# Source file extension for C test sources. +ac_ext=c + +# Object file extension for compiled C test sources. +objext=o +objext=$objext + +# Code to be used in simple compile tests +lt_simple_compile_test_code="int some_variable = 0;" + +# Code to be used in simple link tests +lt_simple_link_test_code='int main(){return(0);}' + + + + + + + +# If no C compiler was specified, use CC. +LTCC=${LTCC-"$CC"} + +# If no C compiler flags were specified, use CFLAGS. +LTCFLAGS=${LTCFLAGS-"$CFLAGS"} + +# Allow CC to be a program name with arguments. +compiler=$CC + +# Save the default compiler, since it gets overwritten when the other +# tags are being tested, and _LT_TAGVAR(compiler, []) is a NOP. +compiler_DEFAULT=$CC + +# save warnings/boilerplate of simple test code +ac_outfile=conftest.$ac_objext +echo "$lt_simple_compile_test_code" >conftest.$ac_ext +eval "$ac_compile" 2>&1 >/dev/null | $SED '/^$/d; /^ *+/d' >conftest.err +_lt_compiler_boilerplate=`cat conftest.err` +$RM conftest* + +ac_outfile=conftest.$ac_objext +echo "$lt_simple_link_test_code" >conftest.$ac_ext +eval "$ac_link" 2>&1 >/dev/null | $SED '/^$/d; /^ *+/d' >conftest.err +_lt_linker_boilerplate=`cat conftest.err` +$RM -r conftest* + + +if test -n "$compiler"; then + +lt_prog_compiler_no_builtin_flag= + +if test "$GCC" = yes; then + case $cc_basename in + nvcc*) + lt_prog_compiler_no_builtin_flag=' -Xcompiler -fno-builtin' ;; + *) + lt_prog_compiler_no_builtin_flag=' -fno-builtin' ;; + esac + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking if $compiler supports -fno-rtti -fno-exceptions" >&5 +$as_echo_n "checking if $compiler supports -fno-rtti -fno-exceptions... " >&6; } +if ${lt_cv_prog_compiler_rtti_exceptions+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_prog_compiler_rtti_exceptions=no + ac_outfile=conftest.$ac_objext + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + lt_compiler_flag="-fno-rtti -fno-exceptions" + # Insert the option either (1) after the last *FLAGS variable, or + # (2) before a word containing "conftest.", or (3) at the end. + # Note that $ac_compile itself does not contain backslashes and begins + # with a dollar sign (not a hyphen), so the echo should work correctly. + # The option is referenced via a variable to avoid confusing sed. + lt_compile=`echo "$ac_compile" | $SED \ + -e 's:.*FLAGS}\{0,1\} :&$lt_compiler_flag :; t' \ + -e 's: [^ ]*conftest\.: $lt_compiler_flag&:; t' \ + -e 's:$: $lt_compiler_flag:'` + (eval echo "\"\$as_me:$LINENO: $lt_compile\"" >&5) + (eval "$lt_compile" 2>conftest.err) + ac_status=$? + cat conftest.err >&5 + echo "$as_me:$LINENO: \$? = $ac_status" >&5 + if (exit $ac_status) && test -s "$ac_outfile"; then + # The compiler can only warn and ignore the option if not recognized + # So say no if there are warnings other than the usual output. + $ECHO "$_lt_compiler_boilerplate" | $SED '/^$/d' >conftest.exp + $SED '/^$/d; /^ *+/d' conftest.err >conftest.er2 + if test ! -s conftest.er2 || diff conftest.exp conftest.er2 >/dev/null; then + lt_cv_prog_compiler_rtti_exceptions=yes + fi + fi + $RM conftest* + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_prog_compiler_rtti_exceptions" >&5 +$as_echo "$lt_cv_prog_compiler_rtti_exceptions" >&6; } + +if test x"$lt_cv_prog_compiler_rtti_exceptions" = xyes; then + lt_prog_compiler_no_builtin_flag="$lt_prog_compiler_no_builtin_flag -fno-rtti -fno-exceptions" +else + : +fi + +fi + + + + + + + lt_prog_compiler_wl= +lt_prog_compiler_pic= +lt_prog_compiler_static= + + + if test "$GCC" = yes; then + lt_prog_compiler_wl='-Wl,' + lt_prog_compiler_static='-static' + + case $host_os in + aix*) + # All AIX code is PIC. + if test "$host_cpu" = ia64; then + # AIX 5 now supports IA64 processor + lt_prog_compiler_static='-Bstatic' + fi + ;; + + amigaos*) + case $host_cpu in + powerpc) + # see comment about AmigaOS4 .so support + lt_prog_compiler_pic='-fPIC' + ;; + m68k) + # FIXME: we need at least 68020 code to build shared libraries, but + # adding the `-m68020' flag to GCC prevents building anything better, + # like `-m68040'. + lt_prog_compiler_pic='-m68020 -resident32 -malways-restore-a4' + ;; + esac + ;; + + beos* | irix5* | irix6* | nonstopux* | osf3* | osf4* | osf5*) + # PIC is the default for these OSes. + ;; + + mingw* | cygwin* | pw32* | os2* | cegcc*) + # This hack is so that the source file can tell whether it is being + # built for inclusion in a dll (and should export symbols for example). + # Although the cygwin gcc ignores -fPIC, still need this for old-style + # (--disable-auto-import) libraries + lt_prog_compiler_pic='-DDLL_EXPORT' + ;; + + darwin* | rhapsody*) + # PIC is the default on this platform + # Common symbols not allowed in MH_DYLIB files + lt_prog_compiler_pic='-fno-common' + ;; + + haiku*) + # PIC is the default for Haiku. + # The "-static" flag exists, but is broken. + lt_prog_compiler_static= + ;; + + hpux*) + # PIC is the default for 64-bit PA HP-UX, but not for 32-bit + # PA HP-UX. On IA64 HP-UX, PIC is the default but the pic flag + # sets the default TLS model and affects inlining. + case $host_cpu in + hppa*64*) + # +Z the default + ;; + *) + lt_prog_compiler_pic='-fPIC' + ;; + esac + ;; + + interix[3-9]*) + # Interix 3.x gcc -fpic/-fPIC options generate broken code. + # Instead, we relocate shared libraries at runtime. + ;; + + msdosdjgpp*) + # Just because we use GCC doesn't mean we suddenly get shared libraries + # on systems that don't support them. + lt_prog_compiler_can_build_shared=no + enable_shared=no + ;; + + *nto* | *qnx*) + # QNX uses GNU C++, but need to define -shared option too, otherwise + # it will coredump. + lt_prog_compiler_pic='-fPIC -shared' + ;; + + sysv4*MP*) + if test -d /usr/nec; then + lt_prog_compiler_pic=-Kconform_pic + fi + ;; + + *) + lt_prog_compiler_pic='-fPIC' + ;; + esac + + case $cc_basename in + nvcc*) # Cuda Compiler Driver 2.2 + lt_prog_compiler_wl='-Xlinker ' + if test -n "$lt_prog_compiler_pic"; then + lt_prog_compiler_pic="-Xcompiler $lt_prog_compiler_pic" + fi + ;; + esac + else + # PORTME Check for flag to pass linker flags through the system compiler. + case $host_os in + aix*) + lt_prog_compiler_wl='-Wl,' + if test "$host_cpu" = ia64; then + # AIX 5 now supports IA64 processor + lt_prog_compiler_static='-Bstatic' + else + lt_prog_compiler_static='-bnso -bI:/lib/syscalls.exp' + fi + ;; + + mingw* | cygwin* | pw32* | os2* | cegcc*) + # This hack is so that the source file can tell whether it is being + # built for inclusion in a dll (and should export symbols for example). + lt_prog_compiler_pic='-DDLL_EXPORT' + ;; + + hpux9* | hpux10* | hpux11*) + lt_prog_compiler_wl='-Wl,' + # PIC is the default for IA64 HP-UX and 64-bit HP-UX, but + # not for PA HP-UX. + case $host_cpu in + hppa*64*|ia64*) + # +Z the default + ;; + *) + lt_prog_compiler_pic='+Z' + ;; + esac + # Is there a better lt_prog_compiler_static that works with the bundled CC? + lt_prog_compiler_static='${wl}-a ${wl}archive' + ;; + + irix5* | irix6* | nonstopux*) + lt_prog_compiler_wl='-Wl,' + # PIC (with -KPIC) is the default. + lt_prog_compiler_static='-non_shared' + ;; + + linux* | k*bsd*-gnu | kopensolaris*-gnu) + case $cc_basename in + # old Intel for x86_64 which still supported -KPIC. + ecc*) + lt_prog_compiler_wl='-Wl,' + lt_prog_compiler_pic='-KPIC' + lt_prog_compiler_static='-static' + ;; + # icc used to be incompatible with GCC. + # ICC 10 doesn't accept -KPIC any more. + icc* | ifort*) + lt_prog_compiler_wl='-Wl,' + lt_prog_compiler_pic='-fPIC' + lt_prog_compiler_static='-static' + ;; + # Lahey Fortran 8.1. + lf95*) + lt_prog_compiler_wl='-Wl,' + lt_prog_compiler_pic='--shared' + lt_prog_compiler_static='--static' + ;; + nagfor*) + # NAG Fortran compiler + lt_prog_compiler_wl='-Wl,-Wl,,' + lt_prog_compiler_pic='-PIC' + lt_prog_compiler_static='-Bstatic' + ;; + pgcc* | pgf77* | pgf90* | pgf95* | pgfortran*) + # Portland Group compilers (*not* the Pentium gcc compiler, + # which looks to be a dead project) + lt_prog_compiler_wl='-Wl,' + lt_prog_compiler_pic='-fpic' + lt_prog_compiler_static='-Bstatic' + ;; + ccc*) + lt_prog_compiler_wl='-Wl,' + # All Alpha code is PIC. + lt_prog_compiler_static='-non_shared' + ;; + xl* | bgxl* | bgf* | mpixl*) + # IBM XL C 8.0/Fortran 10.1, 11.1 on PPC and BlueGene + lt_prog_compiler_wl='-Wl,' + lt_prog_compiler_pic='-qpic' + lt_prog_compiler_static='-qstaticlink' + ;; + *) + case `$CC -V 2>&1 | sed 5q` in + *Sun\ Ceres\ Fortran* | *Sun*Fortran*\ [1-7].* | *Sun*Fortran*\ 8.[0-3]*) + # Sun Fortran 8.3 passes all unrecognized flags to the linker + lt_prog_compiler_pic='-KPIC' + lt_prog_compiler_static='-Bstatic' + lt_prog_compiler_wl='' + ;; + *Sun\ F* | *Sun*Fortran*) + lt_prog_compiler_pic='-KPIC' + lt_prog_compiler_static='-Bstatic' + lt_prog_compiler_wl='-Qoption ld ' + ;; + *Sun\ C*) + # Sun C 5.9 + lt_prog_compiler_pic='-KPIC' + lt_prog_compiler_static='-Bstatic' + lt_prog_compiler_wl='-Wl,' + ;; + *Intel*\ [CF]*Compiler*) + lt_prog_compiler_wl='-Wl,' + lt_prog_compiler_pic='-fPIC' + lt_prog_compiler_static='-static' + ;; + *Portland\ Group*) + lt_prog_compiler_wl='-Wl,' + lt_prog_compiler_pic='-fpic' + lt_prog_compiler_static='-Bstatic' + ;; + esac + ;; + esac + ;; + + newsos6) + lt_prog_compiler_pic='-KPIC' + lt_prog_compiler_static='-Bstatic' + ;; + + *nto* | *qnx*) + # QNX uses GNU C++, but need to define -shared option too, otherwise + # it will coredump. + lt_prog_compiler_pic='-fPIC -shared' + ;; + + osf3* | osf4* | osf5*) + lt_prog_compiler_wl='-Wl,' + # All OSF/1 code is PIC. + lt_prog_compiler_static='-non_shared' + ;; + + rdos*) + lt_prog_compiler_static='-non_shared' + ;; + + solaris*) + lt_prog_compiler_pic='-KPIC' + lt_prog_compiler_static='-Bstatic' + case $cc_basename in + f77* | f90* | f95* | sunf77* | sunf90* | sunf95*) + lt_prog_compiler_wl='-Qoption ld ';; + *) + lt_prog_compiler_wl='-Wl,';; + esac + ;; + + sunos4*) + lt_prog_compiler_wl='-Qoption ld ' + lt_prog_compiler_pic='-PIC' + lt_prog_compiler_static='-Bstatic' + ;; + + sysv4 | sysv4.2uw2* | sysv4.3*) + lt_prog_compiler_wl='-Wl,' + lt_prog_compiler_pic='-KPIC' + lt_prog_compiler_static='-Bstatic' + ;; + + sysv4*MP*) + if test -d /usr/nec ;then + lt_prog_compiler_pic='-Kconform_pic' + lt_prog_compiler_static='-Bstatic' + fi + ;; + + sysv5* | unixware* | sco3.2v5* | sco5v6* | OpenUNIX*) + lt_prog_compiler_wl='-Wl,' + lt_prog_compiler_pic='-KPIC' + lt_prog_compiler_static='-Bstatic' + ;; + + unicos*) + lt_prog_compiler_wl='-Wl,' + lt_prog_compiler_can_build_shared=no + ;; + + uts4*) + lt_prog_compiler_pic='-pic' + lt_prog_compiler_static='-Bstatic' + ;; + + *) + lt_prog_compiler_can_build_shared=no + ;; + esac + fi + +case $host_os in + # For platforms which do not support PIC, -DPIC is meaningless: + *djgpp*) + lt_prog_compiler_pic= + ;; + *) + lt_prog_compiler_pic="$lt_prog_compiler_pic -DPIC" + ;; +esac + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $compiler option to produce PIC" >&5 +$as_echo_n "checking for $compiler option to produce PIC... " >&6; } +if ${lt_cv_prog_compiler_pic+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_prog_compiler_pic=$lt_prog_compiler_pic +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_prog_compiler_pic" >&5 +$as_echo "$lt_cv_prog_compiler_pic" >&6; } +lt_prog_compiler_pic=$lt_cv_prog_compiler_pic + +# +# Check to make sure the PIC flag actually works. +# +if test -n "$lt_prog_compiler_pic"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: checking if $compiler PIC flag $lt_prog_compiler_pic works" >&5 +$as_echo_n "checking if $compiler PIC flag $lt_prog_compiler_pic works... " >&6; } +if ${lt_cv_prog_compiler_pic_works+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_prog_compiler_pic_works=no + ac_outfile=conftest.$ac_objext + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + lt_compiler_flag="$lt_prog_compiler_pic -DPIC" + # Insert the option either (1) after the last *FLAGS variable, or + # (2) before a word containing "conftest.", or (3) at the end. + # Note that $ac_compile itself does not contain backslashes and begins + # with a dollar sign (not a hyphen), so the echo should work correctly. + # The option is referenced via a variable to avoid confusing sed. + lt_compile=`echo "$ac_compile" | $SED \ + -e 's:.*FLAGS}\{0,1\} :&$lt_compiler_flag :; t' \ + -e 's: [^ ]*conftest\.: $lt_compiler_flag&:; t' \ + -e 's:$: $lt_compiler_flag:'` + (eval echo "\"\$as_me:$LINENO: $lt_compile\"" >&5) + (eval "$lt_compile" 2>conftest.err) + ac_status=$? + cat conftest.err >&5 + echo "$as_me:$LINENO: \$? = $ac_status" >&5 + if (exit $ac_status) && test -s "$ac_outfile"; then + # The compiler can only warn and ignore the option if not recognized + # So say no if there are warnings other than the usual output. + $ECHO "$_lt_compiler_boilerplate" | $SED '/^$/d' >conftest.exp + $SED '/^$/d; /^ *+/d' conftest.err >conftest.er2 + if test ! -s conftest.er2 || diff conftest.exp conftest.er2 >/dev/null; then + lt_cv_prog_compiler_pic_works=yes + fi + fi + $RM conftest* + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_prog_compiler_pic_works" >&5 +$as_echo "$lt_cv_prog_compiler_pic_works" >&6; } + +if test x"$lt_cv_prog_compiler_pic_works" = xyes; then + case $lt_prog_compiler_pic in + "" | " "*) ;; + *) lt_prog_compiler_pic=" $lt_prog_compiler_pic" ;; + esac +else + lt_prog_compiler_pic= + lt_prog_compiler_can_build_shared=no +fi + +fi + + + + + + + + + + + +# +# Check to make sure the static flag actually works. +# +wl=$lt_prog_compiler_wl eval lt_tmp_static_flag=\"$lt_prog_compiler_static\" +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking if $compiler static flag $lt_tmp_static_flag works" >&5 +$as_echo_n "checking if $compiler static flag $lt_tmp_static_flag works... " >&6; } +if ${lt_cv_prog_compiler_static_works+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_prog_compiler_static_works=no + save_LDFLAGS="$LDFLAGS" + LDFLAGS="$LDFLAGS $lt_tmp_static_flag" + echo "$lt_simple_link_test_code" > conftest.$ac_ext + if (eval $ac_link 2>conftest.err) && test -s conftest$ac_exeext; then + # The linker can only warn and ignore the option if not recognized + # So say no if there are warnings + if test -s conftest.err; then + # Append any errors to the config.log. + cat conftest.err 1>&5 + $ECHO "$_lt_linker_boilerplate" | $SED '/^$/d' > conftest.exp + $SED '/^$/d; /^ *+/d' conftest.err >conftest.er2 + if diff conftest.exp conftest.er2 >/dev/null; then + lt_cv_prog_compiler_static_works=yes + fi + else + lt_cv_prog_compiler_static_works=yes + fi + fi + $RM -r conftest* + LDFLAGS="$save_LDFLAGS" + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_prog_compiler_static_works" >&5 +$as_echo "$lt_cv_prog_compiler_static_works" >&6; } + +if test x"$lt_cv_prog_compiler_static_works" = xyes; then + : +else + lt_prog_compiler_static= +fi + + + + + + + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking if $compiler supports -c -o file.$ac_objext" >&5 +$as_echo_n "checking if $compiler supports -c -o file.$ac_objext... " >&6; } +if ${lt_cv_prog_compiler_c_o+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_prog_compiler_c_o=no + $RM -r conftest 2>/dev/null + mkdir conftest + cd conftest + mkdir out + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + + lt_compiler_flag="-o out/conftest2.$ac_objext" + # Insert the option either (1) after the last *FLAGS variable, or + # (2) before a word containing "conftest.", or (3) at the end. + # Note that $ac_compile itself does not contain backslashes and begins + # with a dollar sign (not a hyphen), so the echo should work correctly. + lt_compile=`echo "$ac_compile" | $SED \ + -e 's:.*FLAGS}\{0,1\} :&$lt_compiler_flag :; t' \ + -e 's: [^ ]*conftest\.: $lt_compiler_flag&:; t' \ + -e 's:$: $lt_compiler_flag:'` + (eval echo "\"\$as_me:$LINENO: $lt_compile\"" >&5) + (eval "$lt_compile" 2>out/conftest.err) + ac_status=$? + cat out/conftest.err >&5 + echo "$as_me:$LINENO: \$? = $ac_status" >&5 + if (exit $ac_status) && test -s out/conftest2.$ac_objext + then + # The compiler can only warn and ignore the option if not recognized + # So say no if there are warnings + $ECHO "$_lt_compiler_boilerplate" | $SED '/^$/d' > out/conftest.exp + $SED '/^$/d; /^ *+/d' out/conftest.err >out/conftest.er2 + if test ! -s out/conftest.er2 || diff out/conftest.exp out/conftest.er2 >/dev/null; then + lt_cv_prog_compiler_c_o=yes + fi + fi + chmod u+w . 2>&5 + $RM conftest* + # SGI C++ compiler will create directory out/ii_files/ for + # template instantiation + test -d out/ii_files && $RM out/ii_files/* && rmdir out/ii_files + $RM out/* && rmdir out + cd .. + $RM -r conftest + $RM conftest* + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_prog_compiler_c_o" >&5 +$as_echo "$lt_cv_prog_compiler_c_o" >&6; } + + + + + + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking if $compiler supports -c -o file.$ac_objext" >&5 +$as_echo_n "checking if $compiler supports -c -o file.$ac_objext... " >&6; } +if ${lt_cv_prog_compiler_c_o+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_prog_compiler_c_o=no + $RM -r conftest 2>/dev/null + mkdir conftest + cd conftest + mkdir out + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + + lt_compiler_flag="-o out/conftest2.$ac_objext" + # Insert the option either (1) after the last *FLAGS variable, or + # (2) before a word containing "conftest.", or (3) at the end. + # Note that $ac_compile itself does not contain backslashes and begins + # with a dollar sign (not a hyphen), so the echo should work correctly. + lt_compile=`echo "$ac_compile" | $SED \ + -e 's:.*FLAGS}\{0,1\} :&$lt_compiler_flag :; t' \ + -e 's: [^ ]*conftest\.: $lt_compiler_flag&:; t' \ + -e 's:$: $lt_compiler_flag:'` + (eval echo "\"\$as_me:$LINENO: $lt_compile\"" >&5) + (eval "$lt_compile" 2>out/conftest.err) + ac_status=$? + cat out/conftest.err >&5 + echo "$as_me:$LINENO: \$? = $ac_status" >&5 + if (exit $ac_status) && test -s out/conftest2.$ac_objext + then + # The compiler can only warn and ignore the option if not recognized + # So say no if there are warnings + $ECHO "$_lt_compiler_boilerplate" | $SED '/^$/d' > out/conftest.exp + $SED '/^$/d; /^ *+/d' out/conftest.err >out/conftest.er2 + if test ! -s out/conftest.er2 || diff out/conftest.exp out/conftest.er2 >/dev/null; then + lt_cv_prog_compiler_c_o=yes + fi + fi + chmod u+w . 2>&5 + $RM conftest* + # SGI C++ compiler will create directory out/ii_files/ for + # template instantiation + test -d out/ii_files && $RM out/ii_files/* && rmdir out/ii_files + $RM out/* && rmdir out + cd .. + $RM -r conftest + $RM conftest* + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_prog_compiler_c_o" >&5 +$as_echo "$lt_cv_prog_compiler_c_o" >&6; } + + + + +hard_links="nottested" +if test "$lt_cv_prog_compiler_c_o" = no && test "$need_locks" != no; then + # do not overwrite the value of need_locks provided by the user + { $as_echo "$as_me:${as_lineno-$LINENO}: checking if we can lock with hard links" >&5 +$as_echo_n "checking if we can lock with hard links... " >&6; } + hard_links=yes + $RM conftest* + ln conftest.a conftest.b 2>/dev/null && hard_links=no + touch conftest.a + ln conftest.a conftest.b 2>&5 || hard_links=no + ln conftest.a conftest.b 2>/dev/null && hard_links=no + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $hard_links" >&5 +$as_echo "$hard_links" >&6; } + if test "$hard_links" = no; then + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: \`$CC' does not support \`-c -o', so \`make -j' may be unsafe" >&5 +$as_echo "$as_me: WARNING: \`$CC' does not support \`-c -o', so \`make -j' may be unsafe" >&2;} + need_locks=warn + fi +else + need_locks=no +fi + + + + + + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether the $compiler linker ($LD) supports shared libraries" >&5 +$as_echo_n "checking whether the $compiler linker ($LD) supports shared libraries... " >&6; } + + runpath_var= + allow_undefined_flag= + always_export_symbols=no + archive_cmds= + archive_expsym_cmds= + compiler_needs_object=no + enable_shared_with_static_runtimes=no + export_dynamic_flag_spec= + export_symbols_cmds='$NM $libobjs $convenience | $global_symbol_pipe | $SED '\''s/.* //'\'' | sort | uniq > $export_symbols' + hardcode_automatic=no + hardcode_direct=no + hardcode_direct_absolute=no + hardcode_libdir_flag_spec= + hardcode_libdir_separator= + hardcode_minus_L=no + hardcode_shlibpath_var=unsupported + inherit_rpath=no + link_all_deplibs=unknown + module_cmds= + module_expsym_cmds= + old_archive_from_new_cmds= + old_archive_from_expsyms_cmds= + thread_safe_flag_spec= + whole_archive_flag_spec= + # include_expsyms should be a list of space-separated symbols to be *always* + # included in the symbol list + include_expsyms= + # exclude_expsyms can be an extended regexp of symbols to exclude + # it will be wrapped by ` (' and `)$', so one must not match beginning or + # end of line. Example: `a|bc|.*d.*' will exclude the symbols `a' and `bc', + # as well as any symbol that contains `d'. + exclude_expsyms='_GLOBAL_OFFSET_TABLE_|_GLOBAL__F[ID]_.*' + # Although _GLOBAL_OFFSET_TABLE_ is a valid symbol C name, most a.out + # platforms (ab)use it in PIC code, but their linkers get confused if + # the symbol is explicitly referenced. Since portable code cannot + # rely on this symbol name, it's probably fine to never include it in + # preloaded symbol tables. + # Exclude shared library initialization/finalization symbols. + extract_expsyms_cmds= + + case $host_os in + cygwin* | mingw* | pw32* | cegcc*) + # FIXME: the MSVC++ port hasn't been tested in a loooong time + # When not using gcc, we currently assume that we are using + # Microsoft Visual C++. + if test "$GCC" != yes; then + with_gnu_ld=no + fi + ;; + interix*) + # we just hope/assume this is gcc and not c89 (= MSVC++) + with_gnu_ld=yes + ;; + openbsd*) + with_gnu_ld=no + ;; + esac + + ld_shlibs=yes + + # On some targets, GNU ld is compatible enough with the native linker + # that we're better off using the native interface for both. + lt_use_gnu_ld_interface=no + if test "$with_gnu_ld" = yes; then + case $host_os in + aix*) + # The AIX port of GNU ld has always aspired to compatibility + # with the native linker. However, as the warning in the GNU ld + # block says, versions before 2.19.5* couldn't really create working + # shared libraries, regardless of the interface used. + case `$LD -v 2>&1` in + *\ \(GNU\ Binutils\)\ 2.19.5*) ;; + *\ \(GNU\ Binutils\)\ 2.[2-9]*) ;; + *\ \(GNU\ Binutils\)\ [3-9]*) ;; + *) + lt_use_gnu_ld_interface=yes + ;; + esac + ;; + *) + lt_use_gnu_ld_interface=yes + ;; + esac + fi + + if test "$lt_use_gnu_ld_interface" = yes; then + # If archive_cmds runs LD, not CC, wlarc should be empty + wlarc='${wl}' + + # Set some defaults for GNU ld with shared library support. These + # are reset later if shared libraries are not supported. Putting them + # here allows them to be overridden if necessary. + runpath_var=LD_RUN_PATH + hardcode_libdir_flag_spec='${wl}-rpath ${wl}$libdir' + export_dynamic_flag_spec='${wl}--export-dynamic' + # ancient GNU ld didn't support --whole-archive et. al. + if $LD --help 2>&1 | $GREP 'no-whole-archive' > /dev/null; then + whole_archive_flag_spec="$wlarc"'--whole-archive$convenience '"$wlarc"'--no-whole-archive' + else + whole_archive_flag_spec= + fi + supports_anon_versioning=no + case `$LD -v 2>&1` in + *GNU\ gold*) supports_anon_versioning=yes ;; + *\ [01].* | *\ 2.[0-9].* | *\ 2.10.*) ;; # catch versions < 2.11 + *\ 2.11.93.0.2\ *) supports_anon_versioning=yes ;; # RH7.3 ... + *\ 2.11.92.0.12\ *) supports_anon_versioning=yes ;; # Mandrake 8.2 ... + *\ 2.11.*) ;; # other 2.11 versions + *) supports_anon_versioning=yes ;; + esac + + # See if GNU ld supports shared libraries. + case $host_os in + aix[3-9]*) + # On AIX/PPC, the GNU linker is very broken + if test "$host_cpu" != ia64; then + ld_shlibs=no + cat <<_LT_EOF 1>&2 + +*** Warning: the GNU linker, at least up to release 2.19, is reported +*** to be unable to reliably create shared libraries on AIX. +*** Therefore, libtool is disabling shared libraries support. If you +*** really care for shared libraries, you may want to install binutils +*** 2.20 or above, or modify your PATH so that a non-GNU linker is found. +*** You will then need to restart the configuration process. + +_LT_EOF + fi + ;; + + amigaos*) + case $host_cpu in + powerpc) + # see comment about AmigaOS4 .so support + archive_cmds='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + archive_expsym_cmds='' + ;; + m68k) + archive_cmds='$RM $output_objdir/a2ixlibrary.data~$ECHO "#define NAME $libname" > $output_objdir/a2ixlibrary.data~$ECHO "#define LIBRARY_ID 1" >> $output_objdir/a2ixlibrary.data~$ECHO "#define VERSION $major" >> $output_objdir/a2ixlibrary.data~$ECHO "#define REVISION $revision" >> $output_objdir/a2ixlibrary.data~$AR $AR_FLAGS $lib $libobjs~$RANLIB $lib~(cd $output_objdir && a2ixlibrary -32)' + hardcode_libdir_flag_spec='-L$libdir' + hardcode_minus_L=yes + ;; + esac + ;; + + beos*) + if $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + allow_undefined_flag=unsupported + # Joseph Beckenbach says some releases of gcc + # support --undefined. This deserves some investigation. FIXME + archive_cmds='$CC -nostart $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + else + ld_shlibs=no + fi + ;; + + cygwin* | mingw* | pw32* | cegcc*) + # _LT_TAGVAR(hardcode_libdir_flag_spec, ) is actually meaningless, + # as there is no search path for DLLs. + hardcode_libdir_flag_spec='-L$libdir' + export_dynamic_flag_spec='${wl}--export-all-symbols' + allow_undefined_flag=unsupported + always_export_symbols=no + enable_shared_with_static_runtimes=yes + export_symbols_cmds='$NM $libobjs $convenience | $global_symbol_pipe | $SED -e '\''/^[BCDGRS][ ]/s/.*[ ]\([^ ]*\)/\1 DATA/;s/^.*[ ]__nm__\([^ ]*\)[ ][^ ]*/\1 DATA/;/^I[ ]/d;/^[AITW][ ]/s/.* //'\'' | sort | uniq > $export_symbols' + exclude_expsyms='[_]+GLOBAL_OFFSET_TABLE_|[_]+GLOBAL__[FID]_.*|[_]+head_[A-Za-z0-9_]+_dll|[A-Za-z0-9_]+_dll_iname' + + if $LD --help 2>&1 | $GREP 'auto-import' > /dev/null; then + archive_cmds='$CC -shared $libobjs $deplibs $compiler_flags -o $output_objdir/$soname ${wl}--enable-auto-image-base -Xlinker --out-implib -Xlinker $lib' + # If the export-symbols file already is a .def file (1st line + # is EXPORTS), use it as is; otherwise, prepend... + archive_expsym_cmds='if test "x`$SED 1q $export_symbols`" = xEXPORTS; then + cp $export_symbols $output_objdir/$soname.def; + else + echo EXPORTS > $output_objdir/$soname.def; + cat $export_symbols >> $output_objdir/$soname.def; + fi~ + $CC -shared $output_objdir/$soname.def $libobjs $deplibs $compiler_flags -o $output_objdir/$soname ${wl}--enable-auto-image-base -Xlinker --out-implib -Xlinker $lib' + else + ld_shlibs=no + fi + ;; + + haiku*) + archive_cmds='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + link_all_deplibs=yes + ;; + + interix[3-9]*) + hardcode_direct=no + hardcode_shlibpath_var=no + hardcode_libdir_flag_spec='${wl}-rpath,$libdir' + export_dynamic_flag_spec='${wl}-E' + # Hack: On Interix 3.x, we cannot compile PIC because of a broken gcc. + # Instead, shared libraries are loaded at an image base (0x10000000 by + # default) and relocated if they conflict, which is a slow very memory + # consuming and fragmenting process. To avoid this, we pick a random, + # 256 KiB-aligned image base between 0x50000000 and 0x6FFC0000 at link + # time. Moving up from 0x10000000 also allows more sbrk(2) space. + archive_cmds='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-h,$soname ${wl}--image-base,`expr ${RANDOM-$$} % 4096 / 2 \* 262144 + 1342177280` -o $lib' + archive_expsym_cmds='sed "s,^,_," $export_symbols >$output_objdir/$soname.expsym~$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-h,$soname ${wl}--retain-symbols-file,$output_objdir/$soname.expsym ${wl}--image-base,`expr ${RANDOM-$$} % 4096 / 2 \* 262144 + 1342177280` -o $lib' + ;; + + gnu* | linux* | tpf* | k*bsd*-gnu | kopensolaris*-gnu) + tmp_diet=no + if test "$host_os" = linux-dietlibc; then + case $cc_basename in + diet\ *) tmp_diet=yes;; # linux-dietlibc with static linking (!diet-dyn) + esac + fi + if $LD --help 2>&1 | $EGREP ': supported targets:.* elf' > /dev/null \ + && test "$tmp_diet" = no + then + tmp_addflag=' $pic_flag' + tmp_sharedflag='-shared' + case $cc_basename,$host_cpu in + pgcc*) # Portland Group C compiler + whole_archive_flag_spec='${wl}--whole-archive`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + tmp_addflag=' $pic_flag' + ;; + pgf77* | pgf90* | pgf95* | pgfortran*) + # Portland Group f77 and f90 compilers + whole_archive_flag_spec='${wl}--whole-archive`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + tmp_addflag=' $pic_flag -Mnomain' ;; + ecc*,ia64* | icc*,ia64*) # Intel C compiler on ia64 + tmp_addflag=' -i_dynamic' ;; + efc*,ia64* | ifort*,ia64*) # Intel Fortran compiler on ia64 + tmp_addflag=' -i_dynamic -nofor_main' ;; + ifc* | ifort*) # Intel Fortran compiler + tmp_addflag=' -nofor_main' ;; + lf95*) # Lahey Fortran 8.1 + whole_archive_flag_spec= + tmp_sharedflag='--shared' ;; + xl[cC]* | bgxl[cC]* | mpixl[cC]*) # IBM XL C 8.0 on PPC (deal with xlf below) + tmp_sharedflag='-qmkshrobj' + tmp_addflag= ;; + nvcc*) # Cuda Compiler Driver 2.2 + whole_archive_flag_spec='${wl}--whole-archive`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + compiler_needs_object=yes + ;; + esac + case `$CC -V 2>&1 | sed 5q` in + *Sun\ C*) # Sun C 5.9 + whole_archive_flag_spec='${wl}--whole-archive`new_convenience=; for conv in $convenience\"\"; do test -z \"$conv\" || new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + compiler_needs_object=yes + tmp_sharedflag='-G' ;; + *Sun\ F*) # Sun Fortran 8.3 + tmp_sharedflag='-G' ;; + esac + archive_cmds='$CC '"$tmp_sharedflag""$tmp_addflag"' $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + + if test "x$supports_anon_versioning" = xyes; then + archive_expsym_cmds='echo "{ global:" > $output_objdir/$libname.ver~ + cat $export_symbols | sed -e "s/\(.*\)/\1;/" >> $output_objdir/$libname.ver~ + echo "local: *; };" >> $output_objdir/$libname.ver~ + $CC '"$tmp_sharedflag""$tmp_addflag"' $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-version-script ${wl}$output_objdir/$libname.ver -o $lib' + fi + + case $cc_basename in + xlf* | bgf* | bgxlf* | mpixlf*) + # IBM XL Fortran 10.1 on PPC cannot create shared libs itself + whole_archive_flag_spec='--whole-archive$convenience --no-whole-archive' + hardcode_libdir_flag_spec='${wl}-rpath ${wl}$libdir' + archive_cmds='$LD -shared $libobjs $deplibs $linker_flags -soname $soname -o $lib' + if test "x$supports_anon_versioning" = xyes; then + archive_expsym_cmds='echo "{ global:" > $output_objdir/$libname.ver~ + cat $export_symbols | sed -e "s/\(.*\)/\1;/" >> $output_objdir/$libname.ver~ + echo "local: *; };" >> $output_objdir/$libname.ver~ + $LD -shared $libobjs $deplibs $linker_flags -soname $soname -version-script $output_objdir/$libname.ver -o $lib' + fi + ;; + esac + else + ld_shlibs=no + fi + ;; + + netbsd*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ >/dev/null; then + archive_cmds='$LD -Bshareable $libobjs $deplibs $linker_flags -o $lib' + wlarc= + else + archive_cmds='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + archive_expsym_cmds='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + fi + ;; + + solaris*) + if $LD -v 2>&1 | $GREP 'BFD 2\.8' > /dev/null; then + ld_shlibs=no + cat <<_LT_EOF 1>&2 + +*** Warning: The releases 2.8.* of the GNU linker cannot reliably +*** create shared libraries on Solaris systems. Therefore, libtool +*** is disabling shared libraries support. We urge you to upgrade GNU +*** binutils to release 2.9.1 or newer. Another option is to modify +*** your PATH or compiler configuration so that the native linker is +*** used, and then restart. + +_LT_EOF + elif $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + archive_cmds='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + archive_expsym_cmds='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + else + ld_shlibs=no + fi + ;; + + sysv5* | sco3.2v5* | sco5v6* | unixware* | OpenUNIX*) + case `$LD -v 2>&1` in + *\ [01].* | *\ 2.[0-9].* | *\ 2.1[0-5].*) + ld_shlibs=no + cat <<_LT_EOF 1>&2 + +*** Warning: Releases of the GNU linker prior to 2.16.91.0.3 can not +*** reliably create shared libraries on SCO systems. Therefore, libtool +*** is disabling shared libraries support. We urge you to upgrade GNU +*** binutils to release 2.16.91.0.3 or newer. Another option is to modify +*** your PATH or compiler configuration so that the native linker is +*** used, and then restart. + +_LT_EOF + ;; + *) + # For security reasons, it is highly recommended that you always + # use absolute paths for naming shared libraries, and exclude the + # DT_RUNPATH tag from executables and libraries. But doing so + # requires that you compile everything twice, which is a pain. + if $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + hardcode_libdir_flag_spec='${wl}-rpath ${wl}$libdir' + archive_cmds='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + archive_expsym_cmds='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + else + ld_shlibs=no + fi + ;; + esac + ;; + + sunos4*) + archive_cmds='$LD -assert pure-text -Bshareable -o $lib $libobjs $deplibs $linker_flags' + wlarc= + hardcode_direct=yes + hardcode_shlibpath_var=no + ;; + + *) + if $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + archive_cmds='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + archive_expsym_cmds='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + else + ld_shlibs=no + fi + ;; + esac + + if test "$ld_shlibs" = no; then + runpath_var= + hardcode_libdir_flag_spec= + export_dynamic_flag_spec= + whole_archive_flag_spec= + fi + else + # PORTME fill in a description of your system's linker (not GNU ld) + case $host_os in + aix3*) + allow_undefined_flag=unsupported + always_export_symbols=yes + archive_expsym_cmds='$LD -o $output_objdir/$soname $libobjs $deplibs $linker_flags -bE:$export_symbols -T512 -H512 -bM:SRE~$AR $AR_FLAGS $lib $output_objdir/$soname' + # Note: this linker hardcodes the directories in LIBPATH if there + # are no directories specified by -L. + hardcode_minus_L=yes + if test "$GCC" = yes && test -z "$lt_prog_compiler_static"; then + # Neither direct hardcoding nor static linking is supported with a + # broken collect2. + hardcode_direct=unsupported + fi + ;; + + aix[4-9]*) + if test "$host_cpu" = ia64; then + # On IA64, the linker does run time linking by default, so we don't + # have to do anything special. + aix_use_runtimelinking=no + exp_sym_flag='-Bexport' + no_entry_flag="" + else + # If we're using GNU nm, then we don't want the "-C" option. + # -C means demangle to AIX nm, but means don't demangle with GNU nm + # Also, AIX nm treats weak defined symbols like other global + # defined symbols, whereas GNU nm marks them as "W". + if $NM -V 2>&1 | $GREP 'GNU' > /dev/null; then + export_symbols_cmds='$NM -Bpg $libobjs $convenience | awk '\''{ if (((\$ 2 == "T") || (\$ 2 == "D") || (\$ 2 == "B") || (\$ 2 == "W")) && (substr(\$ 3,1,1) != ".")) { print \$ 3 } }'\'' | sort -u > $export_symbols' + else + export_symbols_cmds='$NM -BCpg $libobjs $convenience | awk '\''{ if (((\$ 2 == "T") || (\$ 2 == "D") || (\$ 2 == "B")) && (substr(\$ 3,1,1) != ".")) { print \$ 3 } }'\'' | sort -u > $export_symbols' + fi + aix_use_runtimelinking=no + + # Test if we are trying to use run time linking or normal + # AIX style linking. If -brtl is somewhere in LDFLAGS, we + # need to do runtime linking. + case $host_os in aix4.[23]|aix4.[23].*|aix[5-9]*) + for ld_flag in $LDFLAGS; do + if (test $ld_flag = "-brtl" || test $ld_flag = "-Wl,-brtl"); then + aix_use_runtimelinking=yes + break + fi + done + ;; + esac + + exp_sym_flag='-bexport' + no_entry_flag='-bnoentry' + fi + + # When large executables or shared objects are built, AIX ld can + # have problems creating the table of contents. If linking a library + # or program results in "error TOC overflow" add -mminimal-toc to + # CXXFLAGS/CFLAGS for g++/gcc. In the cases where that is not + # enough to fix the problem, add -Wl,-bbigtoc to LDFLAGS. + + archive_cmds='' + hardcode_direct=yes + hardcode_direct_absolute=yes + hardcode_libdir_separator=':' + link_all_deplibs=yes + file_list_spec='${wl}-f,' + + if test "$GCC" = yes; then + case $host_os in aix4.[012]|aix4.[012].*) + # We only want to do this on AIX 4.2 and lower, the check + # below for broken collect2 doesn't work under 4.3+ + collect2name=`${CC} -print-prog-name=collect2` + if test -f "$collect2name" && + strings "$collect2name" | $GREP resolve_lib_name >/dev/null + then + # We have reworked collect2 + : + else + # We have old collect2 + hardcode_direct=unsupported + # It fails to find uninstalled libraries when the uninstalled + # path is not listed in the libpath. Setting hardcode_minus_L + # to unsupported forces relinking + hardcode_minus_L=yes + hardcode_libdir_flag_spec='-L$libdir' + hardcode_libdir_separator= + fi + ;; + esac + shared_flag='-shared' + if test "$aix_use_runtimelinking" = yes; then + shared_flag="$shared_flag "'${wl}-G' + fi + else + # not using gcc + if test "$host_cpu" = ia64; then + # VisualAge C++, Version 5.5 for AIX 5L for IA-64, Beta 3 Release + # chokes on -Wl,-G. The following line is correct: + shared_flag='-G' + else + if test "$aix_use_runtimelinking" = yes; then + shared_flag='${wl}-G' + else + shared_flag='${wl}-bM:SRE' + fi + fi + fi + + export_dynamic_flag_spec='${wl}-bexpall' + # It seems that -bexpall does not export symbols beginning with + # underscore (_), so it is better to generate a list of symbols to export. + always_export_symbols=yes + if test "$aix_use_runtimelinking" = yes; then + # Warning - without using the other runtime loading flags (-brtl), + # -berok will link without error, but may produce a broken library. + allow_undefined_flag='-berok' + # Determine the default libpath from the value encoded in an + # empty executable. + if test "${lt_cv_aix_libpath+set}" = set; then + aix_libpath=$lt_cv_aix_libpath +else + if ${lt_cv_aix_libpath_+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + + lt_aix_libpath_sed=' + /Import File Strings/,/^$/ { + /^0/ { + s/^0 *\([^ ]*\) *$/\1/ + p + } + }' + lt_cv_aix_libpath_=`dump -H conftest$ac_exeext 2>/dev/null | $SED -n -e "$lt_aix_libpath_sed"` + # Check for a 64-bit object if we didn't find anything. + if test -z "$lt_cv_aix_libpath_"; then + lt_cv_aix_libpath_=`dump -HX64 conftest$ac_exeext 2>/dev/null | $SED -n -e "$lt_aix_libpath_sed"` + fi +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext + if test -z "$lt_cv_aix_libpath_"; then + lt_cv_aix_libpath_="/usr/lib:/lib" + fi + +fi + + aix_libpath=$lt_cv_aix_libpath_ +fi + + hardcode_libdir_flag_spec='${wl}-blibpath:$libdir:'"$aix_libpath" + archive_expsym_cmds='$CC -o $output_objdir/$soname $libobjs $deplibs '"\${wl}$no_entry_flag"' $compiler_flags `if test "x${allow_undefined_flag}" != "x"; then func_echo_all "${wl}${allow_undefined_flag}"; else :; fi` '"\${wl}$exp_sym_flag:\$export_symbols $shared_flag" + else + if test "$host_cpu" = ia64; then + hardcode_libdir_flag_spec='${wl}-R $libdir:/usr/lib:/lib' + allow_undefined_flag="-z nodefs" + archive_expsym_cmds="\$CC $shared_flag"' -o $output_objdir/$soname $libobjs $deplibs '"\${wl}$no_entry_flag"' $compiler_flags ${wl}${allow_undefined_flag} '"\${wl}$exp_sym_flag:\$export_symbols" + else + # Determine the default libpath from the value encoded in an + # empty executable. + if test "${lt_cv_aix_libpath+set}" = set; then + aix_libpath=$lt_cv_aix_libpath +else + if ${lt_cv_aix_libpath_+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + + lt_aix_libpath_sed=' + /Import File Strings/,/^$/ { + /^0/ { + s/^0 *\([^ ]*\) *$/\1/ + p + } + }' + lt_cv_aix_libpath_=`dump -H conftest$ac_exeext 2>/dev/null | $SED -n -e "$lt_aix_libpath_sed"` + # Check for a 64-bit object if we didn't find anything. + if test -z "$lt_cv_aix_libpath_"; then + lt_cv_aix_libpath_=`dump -HX64 conftest$ac_exeext 2>/dev/null | $SED -n -e "$lt_aix_libpath_sed"` + fi +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext + if test -z "$lt_cv_aix_libpath_"; then + lt_cv_aix_libpath_="/usr/lib:/lib" + fi + +fi + + aix_libpath=$lt_cv_aix_libpath_ +fi + + hardcode_libdir_flag_spec='${wl}-blibpath:$libdir:'"$aix_libpath" + # Warning - without using the other run time loading flags, + # -berok will link without error, but may produce a broken library. + no_undefined_flag=' ${wl}-bernotok' + allow_undefined_flag=' ${wl}-berok' + if test "$with_gnu_ld" = yes; then + # We only use this code for GNU lds that support --whole-archive. + whole_archive_flag_spec='${wl}--whole-archive$convenience ${wl}--no-whole-archive' + else + # Exported symbols can be pulled into shared objects from archives + whole_archive_flag_spec='$convenience' + fi + archive_cmds_need_lc=yes + # This is similar to how AIX traditionally builds its shared libraries. + archive_expsym_cmds="\$CC $shared_flag"' -o $output_objdir/$soname $libobjs $deplibs ${wl}-bnoentry $compiler_flags ${wl}-bE:$export_symbols${allow_undefined_flag}~$AR $AR_FLAGS $output_objdir/$libname$release.a $output_objdir/$soname' + fi + fi + ;; + + amigaos*) + case $host_cpu in + powerpc) + # see comment about AmigaOS4 .so support + archive_cmds='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + archive_expsym_cmds='' + ;; + m68k) + archive_cmds='$RM $output_objdir/a2ixlibrary.data~$ECHO "#define NAME $libname" > $output_objdir/a2ixlibrary.data~$ECHO "#define LIBRARY_ID 1" >> $output_objdir/a2ixlibrary.data~$ECHO "#define VERSION $major" >> $output_objdir/a2ixlibrary.data~$ECHO "#define REVISION $revision" >> $output_objdir/a2ixlibrary.data~$AR $AR_FLAGS $lib $libobjs~$RANLIB $lib~(cd $output_objdir && a2ixlibrary -32)' + hardcode_libdir_flag_spec='-L$libdir' + hardcode_minus_L=yes + ;; + esac + ;; + + bsdi[45]*) + export_dynamic_flag_spec=-rdynamic + ;; + + cygwin* | mingw* | pw32* | cegcc*) + # When not using gcc, we currently assume that we are using + # Microsoft Visual C++. + # hardcode_libdir_flag_spec is actually meaningless, as there is + # no search path for DLLs. + case $cc_basename in + cl*) + # Native MSVC + hardcode_libdir_flag_spec=' ' + allow_undefined_flag=unsupported + always_export_symbols=yes + file_list_spec='@' + # Tell ltmain to make .lib files, not .a files. + libext=lib + # Tell ltmain to make .dll files, not .so files. + shrext_cmds=".dll" + # FIXME: Setting linknames here is a bad hack. + archive_cmds='$CC -o $output_objdir/$soname $libobjs $compiler_flags $deplibs -Wl,-dll~linknames=' + archive_expsym_cmds='if test "x`$SED 1q $export_symbols`" = xEXPORTS; then + sed -n -e 's/\\\\\\\(.*\\\\\\\)/-link\\\ -EXPORT:\\\\\\\1/' -e '1\\\!p' < $export_symbols > $output_objdir/$soname.exp; + else + sed -e 's/\\\\\\\(.*\\\\\\\)/-link\\\ -EXPORT:\\\\\\\1/' < $export_symbols > $output_objdir/$soname.exp; + fi~ + $CC -o $tool_output_objdir$soname $libobjs $compiler_flags $deplibs "@$tool_output_objdir$soname.exp" -Wl,-DLL,-IMPLIB:"$tool_output_objdir$libname.dll.lib"~ + linknames=' + # The linker will not automatically build a static lib if we build a DLL. + # _LT_TAGVAR(old_archive_from_new_cmds, )='true' + enable_shared_with_static_runtimes=yes + exclude_expsyms='_NULL_IMPORT_DESCRIPTOR|_IMPORT_DESCRIPTOR_.*' + export_symbols_cmds='$NM $libobjs $convenience | $global_symbol_pipe | $SED -e '\''/^[BCDGRS][ ]/s/.*[ ]\([^ ]*\)/\1,DATA/'\'' | $SED -e '\''/^[AITW][ ]/s/.*[ ]//'\'' | sort | uniq > $export_symbols' + # Don't use ranlib + old_postinstall_cmds='chmod 644 $oldlib' + postlink_cmds='lt_outputfile="@OUTPUT@"~ + lt_tool_outputfile="@TOOL_OUTPUT@"~ + case $lt_outputfile in + *.exe|*.EXE) ;; + *) + lt_outputfile="$lt_outputfile.exe" + lt_tool_outputfile="$lt_tool_outputfile.exe" + ;; + esac~ + if test "$MANIFEST_TOOL" != ":" && test -f "$lt_outputfile.manifest"; then + $MANIFEST_TOOL -manifest "$lt_tool_outputfile.manifest" -outputresource:"$lt_tool_outputfile" || exit 1; + $RM "$lt_outputfile.manifest"; + fi' + ;; + *) + # Assume MSVC wrapper + hardcode_libdir_flag_spec=' ' + allow_undefined_flag=unsupported + # Tell ltmain to make .lib files, not .a files. + libext=lib + # Tell ltmain to make .dll files, not .so files. + shrext_cmds=".dll" + # FIXME: Setting linknames here is a bad hack. + archive_cmds='$CC -o $lib $libobjs $compiler_flags `func_echo_all "$deplibs" | $SED '\''s/ -lc$//'\''` -link -dll~linknames=' + # The linker will automatically build a .lib file if we build a DLL. + old_archive_from_new_cmds='true' + # FIXME: Should let the user specify the lib program. + old_archive_cmds='lib -OUT:$oldlib$oldobjs$old_deplibs' + enable_shared_with_static_runtimes=yes + ;; + esac + ;; + + darwin* | rhapsody*) + + + archive_cmds_need_lc=no + hardcode_direct=no + hardcode_automatic=yes + hardcode_shlibpath_var=unsupported + if test "$lt_cv_ld_force_load" = "yes"; then + whole_archive_flag_spec='`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience ${wl}-force_load,$conv\"; done; func_echo_all \"$new_convenience\"`' + + else + whole_archive_flag_spec='' + fi + link_all_deplibs=yes + allow_undefined_flag="$_lt_dar_allow_undefined" + case $cc_basename in + ifort*) _lt_dar_can_shared=yes ;; + *) _lt_dar_can_shared=$GCC ;; + esac + if test "$_lt_dar_can_shared" = "yes"; then + output_verbose_link_cmd=func_echo_all + archive_cmds="\$CC -dynamiclib \$allow_undefined_flag -o \$lib \$libobjs \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring $_lt_dar_single_mod${_lt_dsymutil}" + module_cmds="\$CC \$allow_undefined_flag -o \$lib -bundle \$libobjs \$deplibs \$compiler_flags${_lt_dsymutil}" + archive_expsym_cmds="sed 's,^,_,' < \$export_symbols > \$output_objdir/\${libname}-symbols.expsym~\$CC -dynamiclib \$allow_undefined_flag -o \$lib \$libobjs \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring ${_lt_dar_single_mod}${_lt_dar_export_syms}${_lt_dsymutil}" + module_expsym_cmds="sed -e 's,^,_,' < \$export_symbols > \$output_objdir/\${libname}-symbols.expsym~\$CC \$allow_undefined_flag -o \$lib -bundle \$libobjs \$deplibs \$compiler_flags${_lt_dar_export_syms}${_lt_dsymutil}" + + else + ld_shlibs=no + fi + + ;; + + dgux*) + archive_cmds='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + hardcode_libdir_flag_spec='-L$libdir' + hardcode_shlibpath_var=no + ;; + + # FreeBSD 2.2.[012] allows us to include c++rt0.o to get C++ constructor + # support. Future versions do this automatically, but an explicit c++rt0.o + # does not break anything, and helps significantly (at the cost of a little + # extra space). + freebsd2.2*) + archive_cmds='$LD -Bshareable -o $lib $libobjs $deplibs $linker_flags /usr/lib/c++rt0.o' + hardcode_libdir_flag_spec='-R$libdir' + hardcode_direct=yes + hardcode_shlibpath_var=no + ;; + + # Unfortunately, older versions of FreeBSD 2 do not have this feature. + freebsd2.*) + archive_cmds='$LD -Bshareable -o $lib $libobjs $deplibs $linker_flags' + hardcode_direct=yes + hardcode_minus_L=yes + hardcode_shlibpath_var=no + ;; + + # FreeBSD 3 and greater uses gcc -shared to do shared libraries. + freebsd* | dragonfly*) + archive_cmds='$CC -shared $pic_flag -o $lib $libobjs $deplibs $compiler_flags' + hardcode_libdir_flag_spec='-R$libdir' + hardcode_direct=yes + hardcode_shlibpath_var=no + ;; + + hpux9*) + if test "$GCC" = yes; then + archive_cmds='$RM $output_objdir/$soname~$CC -shared $pic_flag ${wl}+b ${wl}$install_libdir -o $output_objdir/$soname $libobjs $deplibs $compiler_flags~test $output_objdir/$soname = $lib || mv $output_objdir/$soname $lib' + else + archive_cmds='$RM $output_objdir/$soname~$LD -b +b $install_libdir -o $output_objdir/$soname $libobjs $deplibs $linker_flags~test $output_objdir/$soname = $lib || mv $output_objdir/$soname $lib' + fi + hardcode_libdir_flag_spec='${wl}+b ${wl}$libdir' + hardcode_libdir_separator=: + hardcode_direct=yes + + # hardcode_minus_L: Not really in the search PATH, + # but as the default location of the library. + hardcode_minus_L=yes + export_dynamic_flag_spec='${wl}-E' + ;; + + hpux10*) + if test "$GCC" = yes && test "$with_gnu_ld" = no; then + archive_cmds='$CC -shared $pic_flag ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $libobjs $deplibs $compiler_flags' + else + archive_cmds='$LD -b +h $soname +b $install_libdir -o $lib $libobjs $deplibs $linker_flags' + fi + if test "$with_gnu_ld" = no; then + hardcode_libdir_flag_spec='${wl}+b ${wl}$libdir' + hardcode_libdir_separator=: + hardcode_direct=yes + hardcode_direct_absolute=yes + export_dynamic_flag_spec='${wl}-E' + # hardcode_minus_L: Not really in the search PATH, + # but as the default location of the library. + hardcode_minus_L=yes + fi + ;; + + hpux11*) + if test "$GCC" = yes && test "$with_gnu_ld" = no; then + case $host_cpu in + hppa*64*) + archive_cmds='$CC -shared ${wl}+h ${wl}$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + ia64*) + archive_cmds='$CC -shared $pic_flag ${wl}+h ${wl}$soname ${wl}+nodefaultrpath -o $lib $libobjs $deplibs $compiler_flags' + ;; + *) + archive_cmds='$CC -shared $pic_flag ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $libobjs $deplibs $compiler_flags' + ;; + esac + else + case $host_cpu in + hppa*64*) + archive_cmds='$CC -b ${wl}+h ${wl}$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + ia64*) + archive_cmds='$CC -b ${wl}+h ${wl}$soname ${wl}+nodefaultrpath -o $lib $libobjs $deplibs $compiler_flags' + ;; + *) + + # Older versions of the 11.00 compiler do not understand -b yet + # (HP92453-01 A.11.01.20 doesn't, HP92453-01 B.11.X.35175-35176.GP does) + { $as_echo "$as_me:${as_lineno-$LINENO}: checking if $CC understands -b" >&5 +$as_echo_n "checking if $CC understands -b... " >&6; } +if ${lt_cv_prog_compiler__b+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_prog_compiler__b=no + save_LDFLAGS="$LDFLAGS" + LDFLAGS="$LDFLAGS -b" + echo "$lt_simple_link_test_code" > conftest.$ac_ext + if (eval $ac_link 2>conftest.err) && test -s conftest$ac_exeext; then + # The linker can only warn and ignore the option if not recognized + # So say no if there are warnings + if test -s conftest.err; then + # Append any errors to the config.log. + cat conftest.err 1>&5 + $ECHO "$_lt_linker_boilerplate" | $SED '/^$/d' > conftest.exp + $SED '/^$/d; /^ *+/d' conftest.err >conftest.er2 + if diff conftest.exp conftest.er2 >/dev/null; then + lt_cv_prog_compiler__b=yes + fi + else + lt_cv_prog_compiler__b=yes + fi + fi + $RM -r conftest* + LDFLAGS="$save_LDFLAGS" + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_prog_compiler__b" >&5 +$as_echo "$lt_cv_prog_compiler__b" >&6; } + +if test x"$lt_cv_prog_compiler__b" = xyes; then + archive_cmds='$CC -b ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $libobjs $deplibs $compiler_flags' +else + archive_cmds='$LD -b +h $soname +b $install_libdir -o $lib $libobjs $deplibs $linker_flags' +fi + + ;; + esac + fi + if test "$with_gnu_ld" = no; then + hardcode_libdir_flag_spec='${wl}+b ${wl}$libdir' + hardcode_libdir_separator=: + + case $host_cpu in + hppa*64*|ia64*) + hardcode_direct=no + hardcode_shlibpath_var=no + ;; + *) + hardcode_direct=yes + hardcode_direct_absolute=yes + export_dynamic_flag_spec='${wl}-E' + + # hardcode_minus_L: Not really in the search PATH, + # but as the default location of the library. + hardcode_minus_L=yes + ;; + esac + fi + ;; + + irix5* | irix6* | nonstopux*) + if test "$GCC" = yes; then + archive_cmds='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + # Try to use the -exported_symbol ld option, if it does not + # work, assume that -exports_file does not work either and + # implicitly export all symbols. + # This should be the same for all languages, so no per-tag cache variable. + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether the $host_os linker accepts -exported_symbol" >&5 +$as_echo_n "checking whether the $host_os linker accepts -exported_symbol... " >&6; } +if ${lt_cv_irix_exported_symbol+:} false; then : + $as_echo_n "(cached) " >&6 +else + save_LDFLAGS="$LDFLAGS" + LDFLAGS="$LDFLAGS -shared ${wl}-exported_symbol ${wl}foo ${wl}-update_registry ${wl}/dev/null" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +int foo (void) { return 0; } +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + lt_cv_irix_exported_symbol=yes +else + lt_cv_irix_exported_symbol=no +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext + LDFLAGS="$save_LDFLAGS" +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_irix_exported_symbol" >&5 +$as_echo "$lt_cv_irix_exported_symbol" >&6; } + if test "$lt_cv_irix_exported_symbol" = yes; then + archive_expsym_cmds='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations ${wl}-exports_file ${wl}$export_symbols -o $lib' + fi + else + archive_cmds='$CC -shared $libobjs $deplibs $compiler_flags -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + archive_expsym_cmds='$CC -shared $libobjs $deplibs $compiler_flags -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -exports_file $export_symbols -o $lib' + fi + archive_cmds_need_lc='no' + hardcode_libdir_flag_spec='${wl}-rpath ${wl}$libdir' + hardcode_libdir_separator=: + inherit_rpath=yes + link_all_deplibs=yes + ;; + + netbsd*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ >/dev/null; then + archive_cmds='$LD -Bshareable -o $lib $libobjs $deplibs $linker_flags' # a.out + else + archive_cmds='$LD -shared -o $lib $libobjs $deplibs $linker_flags' # ELF + fi + hardcode_libdir_flag_spec='-R$libdir' + hardcode_direct=yes + hardcode_shlibpath_var=no + ;; + + newsos6) + archive_cmds='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + hardcode_direct=yes + hardcode_libdir_flag_spec='${wl}-rpath ${wl}$libdir' + hardcode_libdir_separator=: + hardcode_shlibpath_var=no + ;; + + *nto* | *qnx*) + ;; + + openbsd*) + if test -f /usr/libexec/ld.so; then + hardcode_direct=yes + hardcode_shlibpath_var=no + hardcode_direct_absolute=yes + if test -z "`echo __ELF__ | $CC -E - | $GREP __ELF__`" || test "$host_os-$host_cpu" = "openbsd2.8-powerpc"; then + archive_cmds='$CC -shared $pic_flag -o $lib $libobjs $deplibs $compiler_flags' + archive_expsym_cmds='$CC -shared $pic_flag -o $lib $libobjs $deplibs $compiler_flags ${wl}-retain-symbols-file,$export_symbols' + hardcode_libdir_flag_spec='${wl}-rpath,$libdir' + export_dynamic_flag_spec='${wl}-E' + else + case $host_os in + openbsd[01].* | openbsd2.[0-7] | openbsd2.[0-7].*) + archive_cmds='$LD -Bshareable -o $lib $libobjs $deplibs $linker_flags' + hardcode_libdir_flag_spec='-R$libdir' + ;; + *) + archive_cmds='$CC -shared $pic_flag -o $lib $libobjs $deplibs $compiler_flags' + hardcode_libdir_flag_spec='${wl}-rpath,$libdir' + ;; + esac + fi + else + ld_shlibs=no + fi + ;; + + os2*) + hardcode_libdir_flag_spec='-L$libdir' + hardcode_minus_L=yes + allow_undefined_flag=unsupported + archive_cmds='$ECHO "LIBRARY $libname INITINSTANCE" > $output_objdir/$libname.def~$ECHO "DESCRIPTION \"$libname\"" >> $output_objdir/$libname.def~echo DATA >> $output_objdir/$libname.def~echo " SINGLE NONSHARED" >> $output_objdir/$libname.def~echo EXPORTS >> $output_objdir/$libname.def~emxexp $libobjs >> $output_objdir/$libname.def~$CC -Zdll -Zcrtdll -o $lib $libobjs $deplibs $compiler_flags $output_objdir/$libname.def' + old_archive_from_new_cmds='emximp -o $output_objdir/$libname.a $output_objdir/$libname.def' + ;; + + osf3*) + if test "$GCC" = yes; then + allow_undefined_flag=' ${wl}-expect_unresolved ${wl}\*' + archive_cmds='$CC -shared${allow_undefined_flag} $libobjs $deplibs $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + else + allow_undefined_flag=' -expect_unresolved \*' + archive_cmds='$CC -shared${allow_undefined_flag} $libobjs $deplibs $compiler_flags -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + fi + archive_cmds_need_lc='no' + hardcode_libdir_flag_spec='${wl}-rpath ${wl}$libdir' + hardcode_libdir_separator=: + ;; + + osf4* | osf5*) # as osf3* with the addition of -msym flag + if test "$GCC" = yes; then + allow_undefined_flag=' ${wl}-expect_unresolved ${wl}\*' + archive_cmds='$CC -shared${allow_undefined_flag} $pic_flag $libobjs $deplibs $compiler_flags ${wl}-msym ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + hardcode_libdir_flag_spec='${wl}-rpath ${wl}$libdir' + else + allow_undefined_flag=' -expect_unresolved \*' + archive_cmds='$CC -shared${allow_undefined_flag} $libobjs $deplibs $compiler_flags -msym -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + archive_expsym_cmds='for i in `cat $export_symbols`; do printf "%s %s\\n" -exported_symbol "\$i" >> $lib.exp; done; printf "%s\\n" "-hidden">> $lib.exp~ + $CC -shared${allow_undefined_flag} ${wl}-input ${wl}$lib.exp $compiler_flags $libobjs $deplibs -soname $soname `test -n "$verstring" && $ECHO "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib~$RM $lib.exp' + + # Both c and cxx compiler support -rpath directly + hardcode_libdir_flag_spec='-rpath $libdir' + fi + archive_cmds_need_lc='no' + hardcode_libdir_separator=: + ;; + + solaris*) + no_undefined_flag=' -z defs' + if test "$GCC" = yes; then + wlarc='${wl}' + archive_cmds='$CC -shared $pic_flag ${wl}-z ${wl}text ${wl}-h ${wl}$soname -o $lib $libobjs $deplibs $compiler_flags' + archive_expsym_cmds='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -shared $pic_flag ${wl}-z ${wl}text ${wl}-M ${wl}$lib.exp ${wl}-h ${wl}$soname -o $lib $libobjs $deplibs $compiler_flags~$RM $lib.exp' + else + case `$CC -V 2>&1` in + *"Compilers 5.0"*) + wlarc='' + archive_cmds='$LD -G${allow_undefined_flag} -h $soname -o $lib $libobjs $deplibs $linker_flags' + archive_expsym_cmds='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $LD -G${allow_undefined_flag} -M $lib.exp -h $soname -o $lib $libobjs $deplibs $linker_flags~$RM $lib.exp' + ;; + *) + wlarc='${wl}' + archive_cmds='$CC -G${allow_undefined_flag} -h $soname -o $lib $libobjs $deplibs $compiler_flags' + archive_expsym_cmds='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -G${allow_undefined_flag} -M $lib.exp -h $soname -o $lib $libobjs $deplibs $compiler_flags~$RM $lib.exp' + ;; + esac + fi + hardcode_libdir_flag_spec='-R$libdir' + hardcode_shlibpath_var=no + case $host_os in + solaris2.[0-5] | solaris2.[0-5].*) ;; + *) + # The compiler driver will combine and reorder linker options, + # but understands `-z linker_flag'. GCC discards it without `$wl', + # but is careful enough not to reorder. + # Supported since Solaris 2.6 (maybe 2.5.1?) + if test "$GCC" = yes; then + whole_archive_flag_spec='${wl}-z ${wl}allextract$convenience ${wl}-z ${wl}defaultextract' + else + whole_archive_flag_spec='-z allextract$convenience -z defaultextract' + fi + ;; + esac + link_all_deplibs=yes + ;; + + sunos4*) + if test "x$host_vendor" = xsequent; then + # Use $CC to link under sequent, because it throws in some extra .o + # files that make .init and .fini sections work. + archive_cmds='$CC -G ${wl}-h $soname -o $lib $libobjs $deplibs $compiler_flags' + else + archive_cmds='$LD -assert pure-text -Bstatic -o $lib $libobjs $deplibs $linker_flags' + fi + hardcode_libdir_flag_spec='-L$libdir' + hardcode_direct=yes + hardcode_minus_L=yes + hardcode_shlibpath_var=no + ;; + + sysv4) + case $host_vendor in + sni) + archive_cmds='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + hardcode_direct=yes # is this really true??? + ;; + siemens) + ## LD is ld it makes a PLAMLIB + ## CC just makes a GrossModule. + archive_cmds='$LD -G -o $lib $libobjs $deplibs $linker_flags' + reload_cmds='$CC -r -o $output$reload_objs' + hardcode_direct=no + ;; + motorola) + archive_cmds='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + hardcode_direct=no #Motorola manual says yes, but my tests say they lie + ;; + esac + runpath_var='LD_RUN_PATH' + hardcode_shlibpath_var=no + ;; + + sysv4.3*) + archive_cmds='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + hardcode_shlibpath_var=no + export_dynamic_flag_spec='-Bexport' + ;; + + sysv4*MP*) + if test -d /usr/nec; then + archive_cmds='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + hardcode_shlibpath_var=no + runpath_var=LD_RUN_PATH + hardcode_runpath_var=yes + ld_shlibs=yes + fi + ;; + + sysv4*uw2* | sysv5OpenUNIX* | sysv5UnixWare7.[01].[10]* | unixware7* | sco3.2v5.0.[024]*) + no_undefined_flag='${wl}-z,text' + archive_cmds_need_lc=no + hardcode_shlibpath_var=no + runpath_var='LD_RUN_PATH' + + if test "$GCC" = yes; then + archive_cmds='$CC -shared ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + archive_expsym_cmds='$CC -shared ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + else + archive_cmds='$CC -G ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + archive_expsym_cmds='$CC -G ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + fi + ;; + + sysv5* | sco3.2v5* | sco5v6*) + # Note: We can NOT use -z defs as we might desire, because we do not + # link with -lc, and that would cause any symbols used from libc to + # always be unresolved, which means just about no library would + # ever link correctly. If we're not using GNU ld we use -z text + # though, which does catch some bad symbols but isn't as heavy-handed + # as -z defs. + no_undefined_flag='${wl}-z,text' + allow_undefined_flag='${wl}-z,nodefs' + archive_cmds_need_lc=no + hardcode_shlibpath_var=no + hardcode_libdir_flag_spec='${wl}-R,$libdir' + hardcode_libdir_separator=':' + link_all_deplibs=yes + export_dynamic_flag_spec='${wl}-Bexport' + runpath_var='LD_RUN_PATH' + + if test "$GCC" = yes; then + archive_cmds='$CC -shared ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + archive_expsym_cmds='$CC -shared ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + else + archive_cmds='$CC -G ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + archive_expsym_cmds='$CC -G ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + fi + ;; + + uts4*) + archive_cmds='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + hardcode_libdir_flag_spec='-L$libdir' + hardcode_shlibpath_var=no + ;; + + *) + ld_shlibs=no + ;; + esac + + if test x$host_vendor = xsni; then + case $host in + sysv4 | sysv4.2uw2* | sysv4.3* | sysv5*) + export_dynamic_flag_spec='${wl}-Blargedynsym' + ;; + esac + fi + fi + +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ld_shlibs" >&5 +$as_echo "$ld_shlibs" >&6; } +test "$ld_shlibs" = no && can_build_shared=no + +with_gnu_ld=$with_gnu_ld + + + + + + + + + + + + + + + +# +# Do we need to explicitly link libc? +# +case "x$archive_cmds_need_lc" in +x|xyes) + # Assume -lc should be added + archive_cmds_need_lc=yes + + if test "$enable_shared" = yes && test "$GCC" = yes; then + case $archive_cmds in + *'~'*) + # FIXME: we may have to deal with multi-command sequences. + ;; + '$CC '*) + # Test whether the compiler implicitly links with -lc since on some + # systems, -lgcc has to come before -lc. If gcc already passes -lc + # to ld, don't add -lc before -lgcc. + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether -lc should be explicitly linked in" >&5 +$as_echo_n "checking whether -lc should be explicitly linked in... " >&6; } +if ${lt_cv_archive_cmds_need_lc+:} false; then : + $as_echo_n "(cached) " >&6 +else + $RM conftest* + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + + if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$ac_compile\""; } >&5 + (eval $ac_compile) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } 2>conftest.err; then + soname=conftest + lib=conftest + libobjs=conftest.$ac_objext + deplibs= + wl=$lt_prog_compiler_wl + pic_flag=$lt_prog_compiler_pic + compiler_flags=-v + linker_flags=-v + verstring= + output_objdir=. + libname=conftest + lt_save_allow_undefined_flag=$allow_undefined_flag + allow_undefined_flag= + if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$archive_cmds 2\>\&1 \| $GREP \" -lc \" \>/dev/null 2\>\&1\""; } >&5 + (eval $archive_cmds 2\>\&1 \| $GREP \" -lc \" \>/dev/null 2\>\&1) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } + then + lt_cv_archive_cmds_need_lc=no + else + lt_cv_archive_cmds_need_lc=yes + fi + allow_undefined_flag=$lt_save_allow_undefined_flag + else + cat conftest.err 1>&5 + fi + $RM conftest* + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_archive_cmds_need_lc" >&5 +$as_echo "$lt_cv_archive_cmds_need_lc" >&6; } + archive_cmds_need_lc=$lt_cv_archive_cmds_need_lc + ;; + esac + fi + ;; +esac + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking dynamic linker characteristics" >&5 +$as_echo_n "checking dynamic linker characteristics... " >&6; } + +if test "$GCC" = yes; then + case $host_os in + darwin*) lt_awk_arg="/^libraries:/,/LR/" ;; + *) lt_awk_arg="/^libraries:/" ;; + esac + case $host_os in + mingw* | cegcc*) lt_sed_strip_eq="s,=\([A-Za-z]:\),\1,g" ;; + *) lt_sed_strip_eq="s,=/,/,g" ;; + esac + lt_search_path_spec=`$CC -print-search-dirs | awk $lt_awk_arg | $SED -e "s/^libraries://" -e $lt_sed_strip_eq` + case $lt_search_path_spec in + *\;*) + # if the path contains ";" then we assume it to be the separator + # otherwise default to the standard path separator (i.e. ":") - it is + # assumed that no part of a normal pathname contains ";" but that should + # okay in the real world where ";" in dirpaths is itself problematic. + lt_search_path_spec=`$ECHO "$lt_search_path_spec" | $SED 's/;/ /g'` + ;; + *) + lt_search_path_spec=`$ECHO "$lt_search_path_spec" | $SED "s/$PATH_SEPARATOR/ /g"` + ;; + esac + # Ok, now we have the path, separated by spaces, we can step through it + # and add multilib dir if necessary. + lt_tmp_lt_search_path_spec= + lt_multi_os_dir=`$CC $CPPFLAGS $CFLAGS $LDFLAGS -print-multi-os-directory 2>/dev/null` + for lt_sys_path in $lt_search_path_spec; do + if test -d "$lt_sys_path/$lt_multi_os_dir"; then + lt_tmp_lt_search_path_spec="$lt_tmp_lt_search_path_spec $lt_sys_path/$lt_multi_os_dir" + else + test -d "$lt_sys_path" && \ + lt_tmp_lt_search_path_spec="$lt_tmp_lt_search_path_spec $lt_sys_path" + fi + done + lt_search_path_spec=`$ECHO "$lt_tmp_lt_search_path_spec" | awk ' +BEGIN {RS=" "; FS="/|\n";} { + lt_foo=""; + lt_count=0; + for (lt_i = NF; lt_i > 0; lt_i--) { + if ($lt_i != "" && $lt_i != ".") { + if ($lt_i == "..") { + lt_count++; + } else { + if (lt_count == 0) { + lt_foo="/" $lt_i lt_foo; + } else { + lt_count--; + } + } + } + } + if (lt_foo != "") { lt_freq[lt_foo]++; } + if (lt_freq[lt_foo] == 1) { print lt_foo; } +}'` + # AWK program above erroneously prepends '/' to C:/dos/paths + # for these hosts. + case $host_os in + mingw* | cegcc*) lt_search_path_spec=`$ECHO "$lt_search_path_spec" |\ + $SED 's,/\([A-Za-z]:\),\1,g'` ;; + esac + sys_lib_search_path_spec=`$ECHO "$lt_search_path_spec" | $lt_NL2SP` +else + sys_lib_search_path_spec="/lib /usr/lib /usr/local/lib" +fi +library_names_spec= +libname_spec='lib$name' +soname_spec= +shrext_cmds=".so" +postinstall_cmds= +postuninstall_cmds= +finish_cmds= +finish_eval= +shlibpath_var= +shlibpath_overrides_runpath=unknown +version_type=none +dynamic_linker="$host_os ld.so" +sys_lib_dlsearch_path_spec="/lib /usr/lib" +need_lib_prefix=unknown +hardcode_into_libs=no + +# when you set need_version to no, make sure it does not cause -set_version +# flags to be left without arguments +need_version=unknown + +case $host_os in +aix3*) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix $libname.a' + shlibpath_var=LIBPATH + + # AIX 3 has no versioning support, so we append a major version to the name. + soname_spec='${libname}${release}${shared_ext}$major' + ;; + +aix[4-9]*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + hardcode_into_libs=yes + if test "$host_cpu" = ia64; then + # AIX 5 supports IA64 + library_names_spec='${libname}${release}${shared_ext}$major ${libname}${release}${shared_ext}$versuffix $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + else + # With GCC up to 2.95.x, collect2 would create an import file + # for dependence libraries. The import file would start with + # the line `#! .'. This would cause the generated library to + # depend on `.', always an invalid library. This was fixed in + # development snapshots of GCC prior to 3.0. + case $host_os in + aix4 | aix4.[01] | aix4.[01].*) + if { echo '#if __GNUC__ > 2 || (__GNUC__ == 2 && __GNUC_MINOR__ >= 97)' + echo ' yes ' + echo '#endif'; } | ${CC} -E - | $GREP yes > /dev/null; then + : + else + can_build_shared=no + fi + ;; + esac + # AIX (on Power*) has no versioning support, so currently we can not hardcode correct + # soname into executable. Probably we can add versioning support to + # collect2, so additional links can be useful in future. + if test "$aix_use_runtimelinking" = yes; then + # If using run time linking (on AIX 4.2 or later) use lib.so + # instead of lib.a to let people know that these are not + # typical AIX shared libraries. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + else + # We preserve .a as extension for shared libraries through AIX4.2 + # and later when we are not doing run time linking. + library_names_spec='${libname}${release}.a $libname.a' + soname_spec='${libname}${release}${shared_ext}$major' + fi + shlibpath_var=LIBPATH + fi + ;; + +amigaos*) + case $host_cpu in + powerpc) + # Since July 2007 AmigaOS4 officially supports .so libraries. + # When compiling the executable, add -use-dynld -Lsobjs: to the compileline. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + ;; + m68k) + library_names_spec='$libname.ixlibrary $libname.a' + # Create ${libname}_ixlibrary.a entries in /sys/libs. + finish_eval='for lib in `ls $libdir/*.ixlibrary 2>/dev/null`; do libname=`func_echo_all "$lib" | $SED '\''s%^.*/\([^/]*\)\.ixlibrary$%\1%'\''`; test $RM /sys/libs/${libname}_ixlibrary.a; $show "cd /sys/libs && $LN_S $lib ${libname}_ixlibrary.a"; cd /sys/libs && $LN_S $lib ${libname}_ixlibrary.a || exit 1; done' + ;; + esac + ;; + +beos*) + library_names_spec='${libname}${shared_ext}' + dynamic_linker="$host_os ld.so" + shlibpath_var=LIBRARY_PATH + ;; + +bsdi[45]*) + version_type=linux # correct to gnu/linux during the next big refactor + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + finish_cmds='PATH="\$PATH:/sbin" ldconfig $libdir' + shlibpath_var=LD_LIBRARY_PATH + sys_lib_search_path_spec="/shlib /usr/lib /usr/X11/lib /usr/contrib/lib /lib /usr/local/lib" + sys_lib_dlsearch_path_spec="/shlib /usr/lib /usr/local/lib" + # the default ld.so.conf also contains /usr/contrib/lib and + # /usr/X11R6/lib (/usr/X11 is a link to /usr/X11R6), but let us allow + # libtool to hard-code these into programs + ;; + +cygwin* | mingw* | pw32* | cegcc*) + version_type=windows + shrext_cmds=".dll" + need_version=no + need_lib_prefix=no + + case $GCC,$cc_basename in + yes,*) + # gcc + library_names_spec='$libname.dll.a' + # DLL is installed to $(libdir)/../bin by postinstall_cmds + postinstall_cmds='base_file=`basename \${file}`~ + dlpath=`$SHELL 2>&1 -c '\''. $dir/'\''\${base_file}'\''i; echo \$dlname'\''`~ + dldir=$destdir/`dirname \$dlpath`~ + test -d \$dldir || mkdir -p \$dldir~ + $install_prog $dir/$dlname \$dldir/$dlname~ + chmod a+x \$dldir/$dlname~ + if test -n '\''$stripme'\'' && test -n '\''$striplib'\''; then + eval '\''$striplib \$dldir/$dlname'\'' || exit \$?; + fi' + postuninstall_cmds='dldll=`$SHELL 2>&1 -c '\''. $file; echo \$dlname'\''`~ + dlpath=$dir/\$dldll~ + $RM \$dlpath' + shlibpath_overrides_runpath=yes + + case $host_os in + cygwin*) + # Cygwin DLLs use 'cyg' prefix rather than 'lib' + soname_spec='`echo ${libname} | sed -e 's/^lib/cyg/'``echo ${release} | $SED -e 's/[.]/-/g'`${versuffix}${shared_ext}' + + sys_lib_search_path_spec="$sys_lib_search_path_spec /usr/lib/w32api" + ;; + mingw* | cegcc*) + # MinGW DLLs use traditional 'lib' prefix + soname_spec='${libname}`echo ${release} | $SED -e 's/[.]/-/g'`${versuffix}${shared_ext}' + ;; + pw32*) + # pw32 DLLs use 'pw' prefix rather than 'lib' + library_names_spec='`echo ${libname} | sed -e 's/^lib/pw/'``echo ${release} | $SED -e 's/[.]/-/g'`${versuffix}${shared_ext}' + ;; + esac + dynamic_linker='Win32 ld.exe' + ;; + + *,cl*) + # Native MSVC + libname_spec='$name' + soname_spec='${libname}`echo ${release} | $SED -e 's/[.]/-/g'`${versuffix}${shared_ext}' + library_names_spec='${libname}.dll.lib' + + case $build_os in + mingw*) + sys_lib_search_path_spec= + lt_save_ifs=$IFS + IFS=';' + for lt_path in $LIB + do + IFS=$lt_save_ifs + # Let DOS variable expansion print the short 8.3 style file name. + lt_path=`cd "$lt_path" 2>/dev/null && cmd //C "for %i in (".") do @echo %~si"` + sys_lib_search_path_spec="$sys_lib_search_path_spec $lt_path" + done + IFS=$lt_save_ifs + # Convert to MSYS style. + sys_lib_search_path_spec=`$ECHO "$sys_lib_search_path_spec" | sed -e 's|\\\\|/|g' -e 's| \\([a-zA-Z]\\):| /\\1|g' -e 's|^ ||'` + ;; + cygwin*) + # Convert to unix form, then to dos form, then back to unix form + # but this time dos style (no spaces!) so that the unix form looks + # like /cygdrive/c/PROGRA~1:/cygdr... + sys_lib_search_path_spec=`cygpath --path --unix "$LIB"` + sys_lib_search_path_spec=`cygpath --path --dos "$sys_lib_search_path_spec" 2>/dev/null` + sys_lib_search_path_spec=`cygpath --path --unix "$sys_lib_search_path_spec" | $SED -e "s/$PATH_SEPARATOR/ /g"` + ;; + *) + sys_lib_search_path_spec="$LIB" + if $ECHO "$sys_lib_search_path_spec" | $GREP ';[c-zC-Z]:/' >/dev/null; then + # It is most probably a Windows format PATH. + sys_lib_search_path_spec=`$ECHO "$sys_lib_search_path_spec" | $SED -e 's/;/ /g'` + else + sys_lib_search_path_spec=`$ECHO "$sys_lib_search_path_spec" | $SED -e "s/$PATH_SEPARATOR/ /g"` + fi + # FIXME: find the short name or the path components, as spaces are + # common. (e.g. "Program Files" -> "PROGRA~1") + ;; + esac + + # DLL is installed to $(libdir)/../bin by postinstall_cmds + postinstall_cmds='base_file=`basename \${file}`~ + dlpath=`$SHELL 2>&1 -c '\''. $dir/'\''\${base_file}'\''i; echo \$dlname'\''`~ + dldir=$destdir/`dirname \$dlpath`~ + test -d \$dldir || mkdir -p \$dldir~ + $install_prog $dir/$dlname \$dldir/$dlname' + postuninstall_cmds='dldll=`$SHELL 2>&1 -c '\''. $file; echo \$dlname'\''`~ + dlpath=$dir/\$dldll~ + $RM \$dlpath' + shlibpath_overrides_runpath=yes + dynamic_linker='Win32 link.exe' + ;; + + *) + # Assume MSVC wrapper + library_names_spec='${libname}`echo ${release} | $SED -e 's/[.]/-/g'`${versuffix}${shared_ext} $libname.lib' + dynamic_linker='Win32 ld.exe' + ;; + esac + # FIXME: first we should search . and the directory the executable is in + shlibpath_var=PATH + ;; + +darwin* | rhapsody*) + dynamic_linker="$host_os dyld" + version_type=darwin + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${major}$shared_ext ${libname}$shared_ext' + soname_spec='${libname}${release}${major}$shared_ext' + shlibpath_overrides_runpath=yes + shlibpath_var=DYLD_LIBRARY_PATH + shrext_cmds='`test .$module = .yes && echo .so || echo .dylib`' + + sys_lib_search_path_spec="$sys_lib_search_path_spec /usr/local/lib" + sys_lib_dlsearch_path_spec='/usr/local/lib /lib /usr/lib' + ;; + +dgux*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname$shared_ext' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + ;; + +freebsd* | dragonfly*) + # DragonFly does not have aout. When/if they implement a new + # versioning mechanism, adjust this. + if test -x /usr/bin/objformat; then + objformat=`/usr/bin/objformat` + else + case $host_os in + freebsd[23].*) objformat=aout ;; + *) objformat=elf ;; + esac + fi + version_type=freebsd-$objformat + case $version_type in + freebsd-elf*) + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext} $libname${shared_ext}' + need_version=no + need_lib_prefix=no + ;; + freebsd-*) + library_names_spec='${libname}${release}${shared_ext}$versuffix $libname${shared_ext}$versuffix' + need_version=yes + ;; + esac + shlibpath_var=LD_LIBRARY_PATH + case $host_os in + freebsd2.*) + shlibpath_overrides_runpath=yes + ;; + freebsd3.[01]* | freebsdelf3.[01]*) + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + ;; + freebsd3.[2-9]* | freebsdelf3.[2-9]* | \ + freebsd4.[0-5] | freebsdelf4.[0-5] | freebsd4.1.1 | freebsdelf4.1.1) + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + *) # from 4.6 on, and DragonFly + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + ;; + esac + ;; + +gnu*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}${major} ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + +haiku*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + dynamic_linker="$host_os runtime_loader" + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}${major} ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LIBRARY_PATH + shlibpath_overrides_runpath=yes + sys_lib_dlsearch_path_spec='/boot/home/config/lib /boot/common/lib /boot/system/lib' + hardcode_into_libs=yes + ;; + +hpux9* | hpux10* | hpux11*) + # Give a soname corresponding to the major version so that dld.sl refuses to + # link against other versions. + version_type=sunos + need_lib_prefix=no + need_version=no + case $host_cpu in + ia64*) + shrext_cmds='.so' + hardcode_into_libs=yes + dynamic_linker="$host_os dld.so" + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes # Unless +noenvvar is specified. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + if test "X$HPUX_IA64_MODE" = X32; then + sys_lib_search_path_spec="/usr/lib/hpux32 /usr/local/lib/hpux32 /usr/local/lib" + else + sys_lib_search_path_spec="/usr/lib/hpux64 /usr/local/lib/hpux64" + fi + sys_lib_dlsearch_path_spec=$sys_lib_search_path_spec + ;; + hppa*64*) + shrext_cmds='.sl' + hardcode_into_libs=yes + dynamic_linker="$host_os dld.sl" + shlibpath_var=LD_LIBRARY_PATH # How should we handle SHLIB_PATH + shlibpath_overrides_runpath=yes # Unless +noenvvar is specified. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + sys_lib_search_path_spec="/usr/lib/pa20_64 /usr/ccs/lib/pa20_64" + sys_lib_dlsearch_path_spec=$sys_lib_search_path_spec + ;; + *) + shrext_cmds='.sl' + dynamic_linker="$host_os dld.sl" + shlibpath_var=SHLIB_PATH + shlibpath_overrides_runpath=no # +s is required to enable SHLIB_PATH + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + ;; + esac + # HP-UX runs *really* slowly unless shared libraries are mode 555, ... + postinstall_cmds='chmod 555 $lib' + # or fails outright, so override atomically: + install_override_mode=555 + ;; + +interix[3-9]*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + dynamic_linker='Interix 3.x ld.so.1 (PE, like ELF)' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + +irix5* | irix6* | nonstopux*) + case $host_os in + nonstopux*) version_type=nonstopux ;; + *) + if test "$lt_cv_prog_gnu_ld" = yes; then + version_type=linux # correct to gnu/linux during the next big refactor + else + version_type=irix + fi ;; + esac + need_lib_prefix=no + need_version=no + soname_spec='${libname}${release}${shared_ext}$major' + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major ${libname}${release}${shared_ext} $libname${shared_ext}' + case $host_os in + irix5* | nonstopux*) + libsuff= shlibsuff= + ;; + *) + case $LD in # libtool.m4 will add one of these switches to LD + *-32|*"-32 "|*-melf32bsmip|*"-melf32bsmip ") + libsuff= shlibsuff= libmagic=32-bit;; + *-n32|*"-n32 "|*-melf32bmipn32|*"-melf32bmipn32 ") + libsuff=32 shlibsuff=N32 libmagic=N32;; + *-64|*"-64 "|*-melf64bmip|*"-melf64bmip ") + libsuff=64 shlibsuff=64 libmagic=64-bit;; + *) libsuff= shlibsuff= libmagic=never-match;; + esac + ;; + esac + shlibpath_var=LD_LIBRARY${shlibsuff}_PATH + shlibpath_overrides_runpath=no + sys_lib_search_path_spec="/usr/lib${libsuff} /lib${libsuff} /usr/local/lib${libsuff}" + sys_lib_dlsearch_path_spec="/usr/lib${libsuff} /lib${libsuff}" + hardcode_into_libs=yes + ;; + +# No shared lib support for Linux oldld, aout, or coff. +linux*oldld* | linux*aout* | linux*coff*) + dynamic_linker=no + ;; + +# This must be glibc/ELF. +linux* | k*bsd*-gnu | kopensolaris*-gnu) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + finish_cmds='PATH="\$PATH:/sbin" ldconfig -n $libdir' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + + # Some binutils ld are patched to set DT_RUNPATH + if ${lt_cv_shlibpath_overrides_runpath+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_shlibpath_overrides_runpath=no + save_LDFLAGS=$LDFLAGS + save_libdir=$libdir + eval "libdir=/foo; wl=\"$lt_prog_compiler_wl\"; \ + LDFLAGS=\"\$LDFLAGS $hardcode_libdir_flag_spec\"" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + if ($OBJDUMP -p conftest$ac_exeext) 2>/dev/null | grep "RUNPATH.*$libdir" >/dev/null; then : + lt_cv_shlibpath_overrides_runpath=yes +fi +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext + LDFLAGS=$save_LDFLAGS + libdir=$save_libdir + +fi + + shlibpath_overrides_runpath=$lt_cv_shlibpath_overrides_runpath + + # This implies no fast_install, which is unacceptable. + # Some rework will be needed to allow for fast_install + # before this can be enabled. + hardcode_into_libs=yes + + # Append ld.so.conf contents to the search path + if test -f /etc/ld.so.conf; then + lt_ld_extra=`awk '/^include / { system(sprintf("cd /etc; cat %s 2>/dev/null", \$2)); skip = 1; } { if (!skip) print \$0; skip = 0; }' < /etc/ld.so.conf | $SED -e 's/#.*//;/^[ ]*hwcap[ ]/d;s/[:, ]/ /g;s/=[^=]*$//;s/=[^= ]* / /g;s/"//g;/^$/d' | tr '\n' ' '` + sys_lib_dlsearch_path_spec="/lib /usr/lib $lt_ld_extra" + fi + + # We used to test for /lib/ld.so.1 and disable shared libraries on + # powerpc, because MkLinux only supported shared libraries with the + # GNU dynamic linker. Since this was broken with cross compilers, + # most powerpc-linux boxes support dynamic linking these days and + # people can always --disable-shared, the test was removed, and we + # assume the GNU/Linux dynamic linker is in use. + dynamic_linker='GNU/Linux ld.so' + ;; + +netbsd*) + version_type=sunos + need_lib_prefix=no + need_version=no + if echo __ELF__ | $CC -E - | $GREP __ELF__ >/dev/null; then + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${shared_ext}$versuffix' + finish_cmds='PATH="\$PATH:/sbin" ldconfig -m $libdir' + dynamic_linker='NetBSD (a.out) ld.so' + else + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + dynamic_linker='NetBSD ld.elf_so' + fi + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + ;; + +newsos6) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + ;; + +*nto* | *qnx*) + version_type=qnx + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + dynamic_linker='ldqnx.so' + ;; + +openbsd*) + version_type=sunos + sys_lib_dlsearch_path_spec="/usr/lib" + need_lib_prefix=no + # Some older versions of OpenBSD (3.3 at least) *do* need versioned libs. + case $host_os in + openbsd3.3 | openbsd3.3.*) need_version=yes ;; + *) need_version=no ;; + esac + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${shared_ext}$versuffix' + finish_cmds='PATH="\$PATH:/sbin" ldconfig -m $libdir' + shlibpath_var=LD_LIBRARY_PATH + if test -z "`echo __ELF__ | $CC -E - | $GREP __ELF__`" || test "$host_os-$host_cpu" = "openbsd2.8-powerpc"; then + case $host_os in + openbsd2.[89] | openbsd2.[89].*) + shlibpath_overrides_runpath=no + ;; + *) + shlibpath_overrides_runpath=yes + ;; + esac + else + shlibpath_overrides_runpath=yes + fi + ;; + +os2*) + libname_spec='$name' + shrext_cmds=".dll" + need_lib_prefix=no + library_names_spec='$libname${shared_ext} $libname.a' + dynamic_linker='OS/2 ld.exe' + shlibpath_var=LIBPATH + ;; + +osf3* | osf4* | osf5*) + version_type=osf + need_lib_prefix=no + need_version=no + soname_spec='${libname}${release}${shared_ext}$major' + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + sys_lib_search_path_spec="/usr/shlib /usr/ccs/lib /usr/lib/cmplrs/cc /usr/lib /usr/local/lib /var/shlib" + sys_lib_dlsearch_path_spec="$sys_lib_search_path_spec" + ;; + +rdos*) + dynamic_linker=no + ;; + +solaris*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + # ldd complains unless libraries are executable + postinstall_cmds='chmod +x $lib' + ;; + +sunos4*) + version_type=sunos + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${shared_ext}$versuffix' + finish_cmds='PATH="\$PATH:/usr/etc" ldconfig $libdir' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + if test "$with_gnu_ld" = yes; then + need_lib_prefix=no + fi + need_version=yes + ;; + +sysv4 | sysv4.3*) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + case $host_vendor in + sni) + shlibpath_overrides_runpath=no + need_lib_prefix=no + runpath_var=LD_RUN_PATH + ;; + siemens) + need_lib_prefix=no + ;; + motorola) + need_lib_prefix=no + need_version=no + shlibpath_overrides_runpath=no + sys_lib_search_path_spec='/lib /usr/lib /usr/ccs/lib' + ;; + esac + ;; + +sysv4*MP*) + if test -d /usr/nec ;then + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='$libname${shared_ext}.$versuffix $libname${shared_ext}.$major $libname${shared_ext}' + soname_spec='$libname${shared_ext}.$major' + shlibpath_var=LD_LIBRARY_PATH + fi + ;; + +sysv5* | sco3.2v5* | sco5v6* | unixware* | OpenUNIX* | sysv4*uw2*) + version_type=freebsd-elf + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext} $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + if test "$with_gnu_ld" = yes; then + sys_lib_search_path_spec='/usr/local/lib /usr/gnu/lib /usr/ccs/lib /usr/lib /lib' + else + sys_lib_search_path_spec='/usr/ccs/lib /usr/lib' + case $host_os in + sco3.2v5*) + sys_lib_search_path_spec="$sys_lib_search_path_spec /lib" + ;; + esac + fi + sys_lib_dlsearch_path_spec='/usr/lib' + ;; + +tpf*) + # TPF is a cross-target only. Preferred cross-host = GNU/Linux. + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + +uts4*) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + ;; + +*) + dynamic_linker=no + ;; +esac +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $dynamic_linker" >&5 +$as_echo "$dynamic_linker" >&6; } +test "$dynamic_linker" = no && can_build_shared=no + +variables_saved_for_relink="PATH $shlibpath_var $runpath_var" +if test "$GCC" = yes; then + variables_saved_for_relink="$variables_saved_for_relink GCC_EXEC_PREFIX COMPILER_PATH LIBRARY_PATH" +fi + +if test "${lt_cv_sys_lib_search_path_spec+set}" = set; then + sys_lib_search_path_spec="$lt_cv_sys_lib_search_path_spec" +fi +if test "${lt_cv_sys_lib_dlsearch_path_spec+set}" = set; then + sys_lib_dlsearch_path_spec="$lt_cv_sys_lib_dlsearch_path_spec" +fi + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking how to hardcode library paths into programs" >&5 +$as_echo_n "checking how to hardcode library paths into programs... " >&6; } +hardcode_action= +if test -n "$hardcode_libdir_flag_spec" || + test -n "$runpath_var" || + test "X$hardcode_automatic" = "Xyes" ; then + + # We can hardcode non-existent directories. + if test "$hardcode_direct" != no && + # If the only mechanism to avoid hardcoding is shlibpath_var, we + # have to relink, otherwise we might link with an installed library + # when we should be linking with a yet-to-be-installed one + ## test "$_LT_TAGVAR(hardcode_shlibpath_var, )" != no && + test "$hardcode_minus_L" != no; then + # Linking always hardcodes the temporary library directory. + hardcode_action=relink + else + # We can link without hardcoding, and we can hardcode nonexisting dirs. + hardcode_action=immediate + fi +else + # We cannot hardcode anything, or else we can only hardcode existing + # directories. + hardcode_action=unsupported +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $hardcode_action" >&5 +$as_echo "$hardcode_action" >&6; } + +if test "$hardcode_action" = relink || + test "$inherit_rpath" = yes; then + # Fast installation is not supported + enable_fast_install=no +elif test "$shlibpath_overrides_runpath" = yes || + test "$enable_shared" = no; then + # Fast installation is not necessary + enable_fast_install=needless +fi + + + + + + + if test "x$enable_dlopen" != xyes; then + enable_dlopen=unknown + enable_dlopen_self=unknown + enable_dlopen_self_static=unknown +else + lt_cv_dlopen=no + lt_cv_dlopen_libs= + + case $host_os in + beos*) + lt_cv_dlopen="load_add_on" + lt_cv_dlopen_libs= + lt_cv_dlopen_self=yes + ;; + + mingw* | pw32* | cegcc*) + lt_cv_dlopen="LoadLibrary" + lt_cv_dlopen_libs= + ;; + + cygwin*) + lt_cv_dlopen="dlopen" + lt_cv_dlopen_libs= + ;; + + darwin*) + # if libdl is installed we need to link against it + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for dlopen in -ldl" >&5 +$as_echo_n "checking for dlopen in -ldl... " >&6; } +if ${ac_cv_lib_dl_dlopen+:} false; then : + $as_echo_n "(cached) " >&6 +else + ac_check_lib_save_LIBS=$LIBS +LIBS="-ldl $LIBS" +cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +/* Override any GCC internal prototype to avoid an error. + Use char because int might match the return type of a GCC + builtin and then its argument prototype would still apply. */ +#ifdef __cplusplus +extern "C" +#endif +char dlopen (); +int +main () +{ +return dlopen (); + ; + return 0; +} +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + ac_cv_lib_dl_dlopen=yes +else + ac_cv_lib_dl_dlopen=no +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext +LIBS=$ac_check_lib_save_LIBS +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_lib_dl_dlopen" >&5 +$as_echo "$ac_cv_lib_dl_dlopen" >&6; } +if test "x$ac_cv_lib_dl_dlopen" = xyes; then : + lt_cv_dlopen="dlopen" lt_cv_dlopen_libs="-ldl" +else + + lt_cv_dlopen="dyld" + lt_cv_dlopen_libs= + lt_cv_dlopen_self=yes + +fi + + ;; + + *) + ac_fn_c_check_func "$LINENO" "shl_load" "ac_cv_func_shl_load" +if test "x$ac_cv_func_shl_load" = xyes; then : + lt_cv_dlopen="shl_load" +else + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for shl_load in -ldld" >&5 +$as_echo_n "checking for shl_load in -ldld... " >&6; } +if ${ac_cv_lib_dld_shl_load+:} false; then : + $as_echo_n "(cached) " >&6 +else + ac_check_lib_save_LIBS=$LIBS +LIBS="-ldld $LIBS" +cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +/* Override any GCC internal prototype to avoid an error. + Use char because int might match the return type of a GCC + builtin and then its argument prototype would still apply. */ +#ifdef __cplusplus +extern "C" +#endif +char shl_load (); +int +main () +{ +return shl_load (); + ; + return 0; +} +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + ac_cv_lib_dld_shl_load=yes +else + ac_cv_lib_dld_shl_load=no +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext +LIBS=$ac_check_lib_save_LIBS +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_lib_dld_shl_load" >&5 +$as_echo "$ac_cv_lib_dld_shl_load" >&6; } +if test "x$ac_cv_lib_dld_shl_load" = xyes; then : + lt_cv_dlopen="shl_load" lt_cv_dlopen_libs="-ldld" +else + ac_fn_c_check_func "$LINENO" "dlopen" "ac_cv_func_dlopen" +if test "x$ac_cv_func_dlopen" = xyes; then : + lt_cv_dlopen="dlopen" +else + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for dlopen in -ldl" >&5 +$as_echo_n "checking for dlopen in -ldl... " >&6; } +if ${ac_cv_lib_dl_dlopen+:} false; then : + $as_echo_n "(cached) " >&6 +else + ac_check_lib_save_LIBS=$LIBS +LIBS="-ldl $LIBS" +cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +/* Override any GCC internal prototype to avoid an error. + Use char because int might match the return type of a GCC + builtin and then its argument prototype would still apply. */ +#ifdef __cplusplus +extern "C" +#endif +char dlopen (); +int +main () +{ +return dlopen (); + ; + return 0; +} +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + ac_cv_lib_dl_dlopen=yes +else + ac_cv_lib_dl_dlopen=no +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext +LIBS=$ac_check_lib_save_LIBS +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_lib_dl_dlopen" >&5 +$as_echo "$ac_cv_lib_dl_dlopen" >&6; } +if test "x$ac_cv_lib_dl_dlopen" = xyes; then : + lt_cv_dlopen="dlopen" lt_cv_dlopen_libs="-ldl" +else + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for dlopen in -lsvld" >&5 +$as_echo_n "checking for dlopen in -lsvld... " >&6; } +if ${ac_cv_lib_svld_dlopen+:} false; then : + $as_echo_n "(cached) " >&6 +else + ac_check_lib_save_LIBS=$LIBS +LIBS="-lsvld $LIBS" +cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +/* Override any GCC internal prototype to avoid an error. + Use char because int might match the return type of a GCC + builtin and then its argument prototype would still apply. */ +#ifdef __cplusplus +extern "C" +#endif +char dlopen (); +int +main () +{ +return dlopen (); + ; + return 0; +} +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + ac_cv_lib_svld_dlopen=yes +else + ac_cv_lib_svld_dlopen=no +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext +LIBS=$ac_check_lib_save_LIBS +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_lib_svld_dlopen" >&5 +$as_echo "$ac_cv_lib_svld_dlopen" >&6; } +if test "x$ac_cv_lib_svld_dlopen" = xyes; then : + lt_cv_dlopen="dlopen" lt_cv_dlopen_libs="-lsvld" +else + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for dld_link in -ldld" >&5 +$as_echo_n "checking for dld_link in -ldld... " >&6; } +if ${ac_cv_lib_dld_dld_link+:} false; then : + $as_echo_n "(cached) " >&6 +else + ac_check_lib_save_LIBS=$LIBS +LIBS="-ldld $LIBS" +cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +/* Override any GCC internal prototype to avoid an error. + Use char because int might match the return type of a GCC + builtin and then its argument prototype would still apply. */ +#ifdef __cplusplus +extern "C" +#endif +char dld_link (); +int +main () +{ +return dld_link (); + ; + return 0; +} +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + ac_cv_lib_dld_dld_link=yes +else + ac_cv_lib_dld_dld_link=no +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext +LIBS=$ac_check_lib_save_LIBS +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_lib_dld_dld_link" >&5 +$as_echo "$ac_cv_lib_dld_dld_link" >&6; } +if test "x$ac_cv_lib_dld_dld_link" = xyes; then : + lt_cv_dlopen="dld_link" lt_cv_dlopen_libs="-ldld" +fi + + +fi + + +fi + + +fi + + +fi + + +fi + + ;; + esac + + if test "x$lt_cv_dlopen" != xno; then + enable_dlopen=yes + else + enable_dlopen=no + fi + + case $lt_cv_dlopen in + dlopen) + save_CPPFLAGS="$CPPFLAGS" + test "x$ac_cv_header_dlfcn_h" = xyes && CPPFLAGS="$CPPFLAGS -DHAVE_DLFCN_H" + + save_LDFLAGS="$LDFLAGS" + wl=$lt_prog_compiler_wl eval LDFLAGS=\"\$LDFLAGS $export_dynamic_flag_spec\" + + save_LIBS="$LIBS" + LIBS="$lt_cv_dlopen_libs $LIBS" + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether a program can dlopen itself" >&5 +$as_echo_n "checking whether a program can dlopen itself... " >&6; } +if ${lt_cv_dlopen_self+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test "$cross_compiling" = yes; then : + lt_cv_dlopen_self=cross +else + lt_dlunknown=0; lt_dlno_uscore=1; lt_dlneed_uscore=2 + lt_status=$lt_dlunknown + cat > conftest.$ac_ext <<_LT_EOF +#line $LINENO "configure" +#include "confdefs.h" + +#if HAVE_DLFCN_H +#include +#endif + +#include + +#ifdef RTLD_GLOBAL +# define LT_DLGLOBAL RTLD_GLOBAL +#else +# ifdef DL_GLOBAL +# define LT_DLGLOBAL DL_GLOBAL +# else +# define LT_DLGLOBAL 0 +# endif +#endif + +/* We may have to define LT_DLLAZY_OR_NOW in the command line if we + find out it does not work in some platform. */ +#ifndef LT_DLLAZY_OR_NOW +# ifdef RTLD_LAZY +# define LT_DLLAZY_OR_NOW RTLD_LAZY +# else +# ifdef DL_LAZY +# define LT_DLLAZY_OR_NOW DL_LAZY +# else +# ifdef RTLD_NOW +# define LT_DLLAZY_OR_NOW RTLD_NOW +# else +# ifdef DL_NOW +# define LT_DLLAZY_OR_NOW DL_NOW +# else +# define LT_DLLAZY_OR_NOW 0 +# endif +# endif +# endif +# endif +#endif + +/* When -fvisbility=hidden is used, assume the code has been annotated + correspondingly for the symbols needed. */ +#if defined(__GNUC__) && (((__GNUC__ == 3) && (__GNUC_MINOR__ >= 3)) || (__GNUC__ > 3)) +int fnord () __attribute__((visibility("default"))); +#endif + +int fnord () { return 42; } +int main () +{ + void *self = dlopen (0, LT_DLGLOBAL|LT_DLLAZY_OR_NOW); + int status = $lt_dlunknown; + + if (self) + { + if (dlsym (self,"fnord")) status = $lt_dlno_uscore; + else + { + if (dlsym( self,"_fnord")) status = $lt_dlneed_uscore; + else puts (dlerror ()); + } + /* dlclose (self); */ + } + else + puts (dlerror ()); + + return status; +} +_LT_EOF + if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$ac_link\""; } >&5 + (eval $ac_link) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } && test -s conftest${ac_exeext} 2>/dev/null; then + (./conftest; exit; ) >&5 2>/dev/null + lt_status=$? + case x$lt_status in + x$lt_dlno_uscore) lt_cv_dlopen_self=yes ;; + x$lt_dlneed_uscore) lt_cv_dlopen_self=yes ;; + x$lt_dlunknown|x*) lt_cv_dlopen_self=no ;; + esac + else : + # compilation failed + lt_cv_dlopen_self=no + fi +fi +rm -fr conftest* + + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_dlopen_self" >&5 +$as_echo "$lt_cv_dlopen_self" >&6; } + + if test "x$lt_cv_dlopen_self" = xyes; then + wl=$lt_prog_compiler_wl eval LDFLAGS=\"\$LDFLAGS $lt_prog_compiler_static\" + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether a statically linked program can dlopen itself" >&5 +$as_echo_n "checking whether a statically linked program can dlopen itself... " >&6; } +if ${lt_cv_dlopen_self_static+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test "$cross_compiling" = yes; then : + lt_cv_dlopen_self_static=cross +else + lt_dlunknown=0; lt_dlno_uscore=1; lt_dlneed_uscore=2 + lt_status=$lt_dlunknown + cat > conftest.$ac_ext <<_LT_EOF +#line $LINENO "configure" +#include "confdefs.h" + +#if HAVE_DLFCN_H +#include +#endif + +#include + +#ifdef RTLD_GLOBAL +# define LT_DLGLOBAL RTLD_GLOBAL +#else +# ifdef DL_GLOBAL +# define LT_DLGLOBAL DL_GLOBAL +# else +# define LT_DLGLOBAL 0 +# endif +#endif + +/* We may have to define LT_DLLAZY_OR_NOW in the command line if we + find out it does not work in some platform. */ +#ifndef LT_DLLAZY_OR_NOW +# ifdef RTLD_LAZY +# define LT_DLLAZY_OR_NOW RTLD_LAZY +# else +# ifdef DL_LAZY +# define LT_DLLAZY_OR_NOW DL_LAZY +# else +# ifdef RTLD_NOW +# define LT_DLLAZY_OR_NOW RTLD_NOW +# else +# ifdef DL_NOW +# define LT_DLLAZY_OR_NOW DL_NOW +# else +# define LT_DLLAZY_OR_NOW 0 +# endif +# endif +# endif +# endif +#endif + +/* When -fvisbility=hidden is used, assume the code has been annotated + correspondingly for the symbols needed. */ +#if defined(__GNUC__) && (((__GNUC__ == 3) && (__GNUC_MINOR__ >= 3)) || (__GNUC__ > 3)) +int fnord () __attribute__((visibility("default"))); +#endif + +int fnord () { return 42; } +int main () +{ + void *self = dlopen (0, LT_DLGLOBAL|LT_DLLAZY_OR_NOW); + int status = $lt_dlunknown; + + if (self) + { + if (dlsym (self,"fnord")) status = $lt_dlno_uscore; + else + { + if (dlsym( self,"_fnord")) status = $lt_dlneed_uscore; + else puts (dlerror ()); + } + /* dlclose (self); */ + } + else + puts (dlerror ()); + + return status; +} +_LT_EOF + if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$ac_link\""; } >&5 + (eval $ac_link) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } && test -s conftest${ac_exeext} 2>/dev/null; then + (./conftest; exit; ) >&5 2>/dev/null + lt_status=$? + case x$lt_status in + x$lt_dlno_uscore) lt_cv_dlopen_self_static=yes ;; + x$lt_dlneed_uscore) lt_cv_dlopen_self_static=yes ;; + x$lt_dlunknown|x*) lt_cv_dlopen_self_static=no ;; + esac + else : + # compilation failed + lt_cv_dlopen_self_static=no + fi +fi +rm -fr conftest* + + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_dlopen_self_static" >&5 +$as_echo "$lt_cv_dlopen_self_static" >&6; } + fi + + CPPFLAGS="$save_CPPFLAGS" + LDFLAGS="$save_LDFLAGS" + LIBS="$save_LIBS" + ;; + esac + + case $lt_cv_dlopen_self in + yes|no) enable_dlopen_self=$lt_cv_dlopen_self ;; + *) enable_dlopen_self=unknown ;; + esac + + case $lt_cv_dlopen_self_static in + yes|no) enable_dlopen_self_static=$lt_cv_dlopen_self_static ;; + *) enable_dlopen_self_static=unknown ;; + esac +fi + + + + + + + + + + + + + + + + + +striplib= +old_striplib= +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether stripping libraries is possible" >&5 +$as_echo_n "checking whether stripping libraries is possible... " >&6; } +if test -n "$STRIP" && $STRIP -V 2>&1 | $GREP "GNU strip" >/dev/null; then + test -z "$old_striplib" && old_striplib="$STRIP --strip-debug" + test -z "$striplib" && striplib="$STRIP --strip-unneeded" + { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 +$as_echo "yes" >&6; } +else +# FIXME - insert some real tests, host_os isn't really good enough + case $host_os in + darwin*) + if test -n "$STRIP" ; then + striplib="$STRIP -x" + old_striplib="$STRIP -S" + { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 +$as_echo "yes" >&6; } + else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } + fi + ;; + *) + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } + ;; + esac +fi + + + + + + + + + + + + + # Report which library types will actually be built + { $as_echo "$as_me:${as_lineno-$LINENO}: checking if libtool supports shared libraries" >&5 +$as_echo_n "checking if libtool supports shared libraries... " >&6; } + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $can_build_shared" >&5 +$as_echo "$can_build_shared" >&6; } + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether to build shared libraries" >&5 +$as_echo_n "checking whether to build shared libraries... " >&6; } + test "$can_build_shared" = "no" && enable_shared=no + + # On AIX, shared libraries and static libraries use the same namespace, and + # are all built from PIC. + case $host_os in + aix3*) + test "$enable_shared" = yes && enable_static=no + if test -n "$RANLIB"; then + archive_cmds="$archive_cmds~\$RANLIB \$lib" + postinstall_cmds='$RANLIB $lib' + fi + ;; + + aix[4-9]*) + if test "$host_cpu" != ia64 && test "$aix_use_runtimelinking" = no ; then + test "$enable_shared" = yes && enable_static=no + fi + ;; + esac + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $enable_shared" >&5 +$as_echo "$enable_shared" >&6; } + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether to build static libraries" >&5 +$as_echo_n "checking whether to build static libraries... " >&6; } + # Make sure either enable_shared or enable_static is yes. + test "$enable_shared" = yes || enable_static=yes + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $enable_static" >&5 +$as_echo "$enable_static" >&6; } + + + + +fi +ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu + +CC="$lt_save_CC" + + + + + + + + + + + + + + + + ac_config_commands="$ac_config_commands libtool" + + + + +# Only expand once: + + + +ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu +if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}gcc", so it can be a program name with args. +set dummy ${ac_tool_prefix}gcc; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_CC+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$CC"; then + ac_cv_prog_CC="$CC" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_CC="${ac_tool_prefix}gcc" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +CC=$ac_cv_prog_CC +if test -n "$CC"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 +$as_echo "$CC" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_CC"; then + ac_ct_CC=$CC + # Extract the first word of "gcc", so it can be a program name with args. +set dummy gcc; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_CC+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_CC"; then + ac_cv_prog_ac_ct_CC="$ac_ct_CC" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_CC="gcc" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_CC=$ac_cv_prog_ac_ct_CC +if test -n "$ac_ct_CC"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_CC" >&5 +$as_echo "$ac_ct_CC" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_CC" = x; then + CC="" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + CC=$ac_ct_CC + fi +else + CC="$ac_cv_prog_CC" +fi + +if test -z "$CC"; then + if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}cc", so it can be a program name with args. +set dummy ${ac_tool_prefix}cc; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_CC+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$CC"; then + ac_cv_prog_CC="$CC" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_CC="${ac_tool_prefix}cc" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +CC=$ac_cv_prog_CC +if test -n "$CC"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 +$as_echo "$CC" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + fi +fi +if test -z "$CC"; then + # Extract the first word of "cc", so it can be a program name with args. +set dummy cc; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_CC+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$CC"; then + ac_cv_prog_CC="$CC" # Let the user override the test. +else + ac_prog_rejected=no +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + if test "$as_dir/$ac_word$ac_exec_ext" = "/usr/ucb/cc"; then + ac_prog_rejected=yes + continue + fi + ac_cv_prog_CC="cc" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +if test $ac_prog_rejected = yes; then + # We found a bogon in the path, so make sure we never use it. + set dummy $ac_cv_prog_CC + shift + if test $# != 0; then + # We chose a different compiler from the bogus one. + # However, it has the same basename, so the bogon will be chosen + # first if we set CC to just the basename; use the full file name. + shift + ac_cv_prog_CC="$as_dir/$ac_word${1+' '}$@" + fi +fi +fi +fi +CC=$ac_cv_prog_CC +if test -n "$CC"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 +$as_echo "$CC" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$CC"; then + if test -n "$ac_tool_prefix"; then + for ac_prog in cl.exe + do + # Extract the first word of "$ac_tool_prefix$ac_prog", so it can be a program name with args. +set dummy $ac_tool_prefix$ac_prog; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_CC+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$CC"; then + ac_cv_prog_CC="$CC" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_CC="$ac_tool_prefix$ac_prog" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +CC=$ac_cv_prog_CC +if test -n "$CC"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CC" >&5 +$as_echo "$CC" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + test -n "$CC" && break + done +fi +if test -z "$CC"; then + ac_ct_CC=$CC + for ac_prog in cl.exe +do + # Extract the first word of "$ac_prog", so it can be a program name with args. +set dummy $ac_prog; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_CC+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_CC"; then + ac_cv_prog_ac_ct_CC="$ac_ct_CC" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_CC="$ac_prog" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_CC=$ac_cv_prog_ac_ct_CC +if test -n "$ac_ct_CC"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_CC" >&5 +$as_echo "$ac_ct_CC" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + test -n "$ac_ct_CC" && break +done + + if test "x$ac_ct_CC" = x; then + CC="" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + CC=$ac_ct_CC + fi +fi + +fi + + +test -z "$CC" && { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 +$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} +as_fn_error $? "no acceptable C compiler found in \$PATH +See \`config.log' for more details" "$LINENO" 5; } + +# Provide some information about the compiler. +$as_echo "$as_me:${as_lineno-$LINENO}: checking for C compiler version" >&5 +set X $ac_compile +ac_compiler=$2 +for ac_option in --version -v -V -qversion; do + { { ac_try="$ac_compiler $ac_option >&5" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_compiler $ac_option >&5") 2>conftest.err + ac_status=$? + if test -s conftest.err; then + sed '10a\ +... rest of stderr output deleted ... + 10q' conftest.err >conftest.er1 + cat conftest.er1 >&5 + fi + rm -f conftest.er1 conftest.err + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } +done + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are using the GNU C compiler" >&5 +$as_echo_n "checking whether we are using the GNU C compiler... " >&6; } +if ${ac_cv_c_compiler_gnu+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ +#ifndef __GNUC__ + choke me +#endif + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + ac_compiler_gnu=yes +else + ac_compiler_gnu=no +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext +ac_cv_c_compiler_gnu=$ac_compiler_gnu + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_c_compiler_gnu" >&5 +$as_echo "$ac_cv_c_compiler_gnu" >&6; } +if test $ac_compiler_gnu = yes; then + GCC=yes +else + GCC= +fi +ac_test_CFLAGS=${CFLAGS+set} +ac_save_CFLAGS=$CFLAGS +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $CC accepts -g" >&5 +$as_echo_n "checking whether $CC accepts -g... " >&6; } +if ${ac_cv_prog_cc_g+:} false; then : + $as_echo_n "(cached) " >&6 +else + ac_save_c_werror_flag=$ac_c_werror_flag + ac_c_werror_flag=yes + ac_cv_prog_cc_g=no + CFLAGS="-g" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + ac_cv_prog_cc_g=yes +else + CFLAGS="" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + +else + ac_c_werror_flag=$ac_save_c_werror_flag + CFLAGS="-g" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + ac_cv_prog_cc_g=yes +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext + ac_c_werror_flag=$ac_save_c_werror_flag +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_cc_g" >&5 +$as_echo "$ac_cv_prog_cc_g" >&6; } +if test "$ac_test_CFLAGS" = set; then + CFLAGS=$ac_save_CFLAGS +elif test $ac_cv_prog_cc_g = yes; then + if test "$GCC" = yes; then + CFLAGS="-g -O2" + else + CFLAGS="-g" + fi +else + if test "$GCC" = yes; then + CFLAGS="-O2" + else + CFLAGS= + fi +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $CC option to accept ISO C89" >&5 +$as_echo_n "checking for $CC option to accept ISO C89... " >&6; } +if ${ac_cv_prog_cc_c89+:} false; then : + $as_echo_n "(cached) " >&6 +else + ac_cv_prog_cc_c89=no +ac_save_CC=$CC +cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include +#include +#include +#include +/* Most of the following tests are stolen from RCS 5.7's src/conf.sh. */ +struct buf { int x; }; +FILE * (*rcsopen) (struct buf *, struct stat *, int); +static char *e (p, i) + char **p; + int i; +{ + return p[i]; +} +static char *f (char * (*g) (char **, int), char **p, ...) +{ + char *s; + va_list v; + va_start (v,p); + s = g (p, va_arg (v,int)); + va_end (v); + return s; +} + +/* OSF 4.0 Compaq cc is some sort of almost-ANSI by default. It has + function prototypes and stuff, but not '\xHH' hex character constants. + These don't provoke an error unfortunately, instead are silently treated + as 'x'. The following induces an error, until -std is added to get + proper ANSI mode. Curiously '\x00'!='x' always comes out true, for an + array size at least. It's necessary to write '\x00'==0 to get something + that's true only with -std. */ +int osf4_cc_array ['\x00' == 0 ? 1 : -1]; + +/* IBM C 6 for AIX is almost-ANSI by default, but it replaces macro parameters + inside strings and character constants. */ +#define FOO(x) 'x' +int xlc6_cc_array[FOO(a) == 'x' ? 1 : -1]; + +int test (int i, double x); +struct s1 {int (*f) (int a);}; +struct s2 {int (*f) (double a);}; +int pairnames (int, char **, FILE *(*)(struct buf *, struct stat *, int), int, int); +int argc; +char **argv; +int +main () +{ +return f (e, argv, 0) != argv[0] || f (e, argv, 1) != argv[1]; + ; + return 0; +} +_ACEOF +for ac_arg in '' -qlanglvl=extc89 -qlanglvl=ansi -std \ + -Ae "-Aa -D_HPUX_SOURCE" "-Xc -D__EXTENSIONS__" +do + CC="$ac_save_CC $ac_arg" + if ac_fn_c_try_compile "$LINENO"; then : + ac_cv_prog_cc_c89=$ac_arg +fi +rm -f core conftest.err conftest.$ac_objext + test "x$ac_cv_prog_cc_c89" != "xno" && break +done +rm -f conftest.$ac_ext +CC=$ac_save_CC + +fi +# AC_CACHE_VAL +case "x$ac_cv_prog_cc_c89" in + x) + { $as_echo "$as_me:${as_lineno-$LINENO}: result: none needed" >&5 +$as_echo "none needed" >&6; } ;; + xno) + { $as_echo "$as_me:${as_lineno-$LINENO}: result: unsupported" >&5 +$as_echo "unsupported" >&6; } ;; + *) + CC="$CC $ac_cv_prog_cc_c89" + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_cc_c89" >&5 +$as_echo "$ac_cv_prog_cc_c89" >&6; } ;; +esac +if test "x$ac_cv_prog_cc_c89" != xno; then : + +fi + +ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu + +depcc="$CC" am_compiler_list= + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking dependency style of $depcc" >&5 +$as_echo_n "checking dependency style of $depcc... " >&6; } +if ${am_cv_CC_dependencies_compiler_type+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -z "$AMDEP_TRUE" && test -f "$am_depcomp"; then + # We make a subdir and do the tests there. Otherwise we can end up + # making bogus files that we don't know about and never remove. For + # instance it was reported that on HP-UX the gcc test will end up + # making a dummy file named `D' -- because `-MD' means `put the output + # in D'. + mkdir conftest.dir + # Copy depcomp to subdir because otherwise we won't find it if we're + # using a relative directory. + cp "$am_depcomp" conftest.dir + cd conftest.dir + # We will build objects and dependencies in a subdirectory because + # it helps to detect inapplicable dependency modes. For instance + # both Tru64's cc and ICC support -MD to output dependencies as a + # side effect of compilation, but ICC will put the dependencies in + # the current directory while Tru64 will put them in the object + # directory. + mkdir sub + + am_cv_CC_dependencies_compiler_type=none + if test "$am_compiler_list" = ""; then + am_compiler_list=`sed -n 's/^#*\([a-zA-Z0-9]*\))$/\1/p' < ./depcomp` + fi + am__universal=false + case " $depcc " in #( + *\ -arch\ *\ -arch\ *) am__universal=true ;; + esac + + for depmode in $am_compiler_list; do + # Setup a source with many dependencies, because some compilers + # like to wrap large dependency lists on column 80 (with \), and + # we should not choose a depcomp mode which is confused by this. + # + # We need to recreate these files for each test, as the compiler may + # overwrite some of them when testing with obscure command lines. + # This happens at least with the AIX C compiler. + : > sub/conftest.c + for i in 1 2 3 4 5 6; do + echo '#include "conftst'$i'.h"' >> sub/conftest.c + # Using `: > sub/conftst$i.h' creates only sub/conftst1.h with + # Solaris 8's {/usr,}/bin/sh. + touch sub/conftst$i.h + done + echo "${am__include} ${am__quote}sub/conftest.Po${am__quote}" > confmf + + # We check with `-c' and `-o' for the sake of the "dashmstdout" + # mode. It turns out that the SunPro C++ compiler does not properly + # handle `-M -o', and we need to detect this. Also, some Intel + # versions had trouble with output in subdirs + am__obj=sub/conftest.${OBJEXT-o} + am__minus_obj="-o $am__obj" + case $depmode in + gcc) + # This depmode causes a compiler race in universal mode. + test "$am__universal" = false || continue + ;; + nosideeffect) + # after this tag, mechanisms are not by side-effect, so they'll + # only be used when explicitly requested + if test "x$enable_dependency_tracking" = xyes; then + continue + else + break + fi + ;; + msvisualcpp | msvcmsys) + # This compiler won't grok `-c -o', but also, the minuso test has + # not run yet. These depmodes are late enough in the game, and + # so weak that their functioning should not be impacted. + am__obj=conftest.${OBJEXT-o} + am__minus_obj= + ;; + none) break ;; + esac + if depmode=$depmode \ + source=sub/conftest.c object=$am__obj \ + depfile=sub/conftest.Po tmpdepfile=sub/conftest.TPo \ + $SHELL ./depcomp $depcc -c $am__minus_obj sub/conftest.c \ + >/dev/null 2>conftest.err && + grep sub/conftst1.h sub/conftest.Po > /dev/null 2>&1 && + grep sub/conftst6.h sub/conftest.Po > /dev/null 2>&1 && + grep $am__obj sub/conftest.Po > /dev/null 2>&1 && + ${MAKE-make} -s -f confmf > /dev/null 2>&1; then + # icc doesn't choke on unknown options, it will just issue warnings + # or remarks (even with -Werror). So we grep stderr for any message + # that says an option was ignored or not supported. + # When given -MP, icc 7.0 and 7.1 complain thusly: + # icc: Command line warning: ignoring option '-M'; no argument required + # The diagnosis changed in icc 8.0: + # icc: Command line remark: option '-MP' not supported + if (grep 'ignoring option' conftest.err || + grep 'not supported' conftest.err) >/dev/null 2>&1; then :; else + am_cv_CC_dependencies_compiler_type=$depmode + break + fi + fi + done + + cd .. + rm -rf conftest.dir +else + am_cv_CC_dependencies_compiler_type=none +fi + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $am_cv_CC_dependencies_compiler_type" >&5 +$as_echo "$am_cv_CC_dependencies_compiler_type" >&6; } +CCDEPMODE=depmode=$am_cv_CC_dependencies_compiler_type + + if + test "x$enable_dependency_tracking" != xno \ + && test "$am_cv_CC_dependencies_compiler_type" = gcc3; then + am__fastdepCC_TRUE= + am__fastdepCC_FALSE='#' +else + am__fastdepCC_TRUE='#' + am__fastdepCC_FALSE= +fi + + +if test "x$CC" != xcc; then + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $CC and cc understand -c and -o together" >&5 +$as_echo_n "checking whether $CC and cc understand -c and -o together... " >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether cc understands -c and -o together" >&5 +$as_echo_n "checking whether cc understands -c and -o together... " >&6; } +fi +set dummy $CC; ac_cc=`$as_echo "$2" | + sed 's/[^a-zA-Z0-9_]/_/g;s/^[0-9]/_/'` +if eval \${ac_cv_prog_cc_${ac_cc}_c_o+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +# Make sure it works both with $CC and with simple cc. +# We do the test twice because some compilers refuse to overwrite an +# existing .o file with -o, though they will create one. +ac_try='$CC -c conftest.$ac_ext -o conftest2.$ac_objext >&5' +rm -f conftest2.* +if { { case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_try") 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } && + test -f conftest2.$ac_objext && { { case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_try") 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; +then + eval ac_cv_prog_cc_${ac_cc}_c_o=yes + if test "x$CC" != xcc; then + # Test first that cc exists at all. + if { ac_try='cc -c conftest.$ac_ext >&5' + { { case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_try") 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; }; then + ac_try='cc -c conftest.$ac_ext -o conftest2.$ac_objext >&5' + rm -f conftest2.* + if { { case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_try") 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } && + test -f conftest2.$ac_objext && { { case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_try") 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; + then + # cc works too. + : + else + # cc exists but doesn't like -o. + eval ac_cv_prog_cc_${ac_cc}_c_o=no + fi + fi + fi +else + eval ac_cv_prog_cc_${ac_cc}_c_o=no +fi +rm -f core conftest* + +fi +if eval test \$ac_cv_prog_cc_${ac_cc}_c_o = yes; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: yes" >&5 +$as_echo "yes" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } + +$as_echo "#define NO_MINUS_C_MINUS_O 1" >>confdefs.h + +fi + +# FIXME: we rely on the cache variable name because +# there is no other way. +set dummy $CC +am_cc=`echo $2 | sed 's/[^a-zA-Z0-9_]/_/g;s/^[0-9]/_/'` +eval am_t=\$ac_cv_prog_cc_${am_cc}_c_o +if test "$am_t" != yes; then + # Losing compiler, so override with the script. + # FIXME: It is wrong to rewrite CC. + # But if we don't then we get into trouble of one sort or another. + # A longer-term fix would be to have automake use am__CC in this case, + # and then we could set am__CC="\$(top_srcdir)/compile \$(CC)" + CC="$am_aux_dir/compile $CC" +fi + + +ac_ext=cpp +ac_cpp='$CXXCPP $CPPFLAGS' +ac_compile='$CXX -c $CXXFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CXX -o conftest$ac_exeext $CXXFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_cxx_compiler_gnu +if test -z "$CXX"; then + if test -n "$CCC"; then + CXX=$CCC + else + if test -n "$ac_tool_prefix"; then + for ac_prog in g++ c++ gpp aCC CC cxx cc++ cl.exe FCC KCC RCC xlC_r xlC + do + # Extract the first word of "$ac_tool_prefix$ac_prog", so it can be a program name with args. +set dummy $ac_tool_prefix$ac_prog; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_CXX+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$CXX"; then + ac_cv_prog_CXX="$CXX" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_CXX="$ac_tool_prefix$ac_prog" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +CXX=$ac_cv_prog_CXX +if test -n "$CXX"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $CXX" >&5 +$as_echo "$CXX" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + test -n "$CXX" && break + done +fi +if test -z "$CXX"; then + ac_ct_CXX=$CXX + for ac_prog in g++ c++ gpp aCC CC cxx cc++ cl.exe FCC KCC RCC xlC_r xlC +do + # Extract the first word of "$ac_prog", so it can be a program name with args. +set dummy $ac_prog; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_CXX+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_CXX"; then + ac_cv_prog_ac_ct_CXX="$ac_ct_CXX" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_CXX="$ac_prog" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_CXX=$ac_cv_prog_ac_ct_CXX +if test -n "$ac_ct_CXX"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_CXX" >&5 +$as_echo "$ac_ct_CXX" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + test -n "$ac_ct_CXX" && break +done + + if test "x$ac_ct_CXX" = x; then + CXX="g++" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + CXX=$ac_ct_CXX + fi +fi + + fi +fi +# Provide some information about the compiler. +$as_echo "$as_me:${as_lineno-$LINENO}: checking for C++ compiler version" >&5 +set X $ac_compile +ac_compiler=$2 +for ac_option in --version -v -V -qversion; do + { { ac_try="$ac_compiler $ac_option >&5" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$ac_compiler $ac_option >&5") 2>conftest.err + ac_status=$? + if test -s conftest.err; then + sed '10a\ +... rest of stderr output deleted ... + 10q' conftest.err >conftest.er1 + cat conftest.er1 >&5 + fi + rm -f conftest.er1 conftest.err + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } +done + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether we are using the GNU C++ compiler" >&5 +$as_echo_n "checking whether we are using the GNU C++ compiler... " >&6; } +if ${ac_cv_cxx_compiler_gnu+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ +#ifndef __GNUC__ + choke me +#endif + + ; + return 0; +} +_ACEOF +if ac_fn_cxx_try_compile "$LINENO"; then : + ac_compiler_gnu=yes +else + ac_compiler_gnu=no +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext +ac_cv_cxx_compiler_gnu=$ac_compiler_gnu + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_cxx_compiler_gnu" >&5 +$as_echo "$ac_cv_cxx_compiler_gnu" >&6; } +if test $ac_compiler_gnu = yes; then + GXX=yes +else + GXX= +fi +ac_test_CXXFLAGS=${CXXFLAGS+set} +ac_save_CXXFLAGS=$CXXFLAGS +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether $CXX accepts -g" >&5 +$as_echo_n "checking whether $CXX accepts -g... " >&6; } +if ${ac_cv_prog_cxx_g+:} false; then : + $as_echo_n "(cached) " >&6 +else + ac_save_cxx_werror_flag=$ac_cxx_werror_flag + ac_cxx_werror_flag=yes + ac_cv_prog_cxx_g=no + CXXFLAGS="-g" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_cxx_try_compile "$LINENO"; then : + ac_cv_prog_cxx_g=yes +else + CXXFLAGS="" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_cxx_try_compile "$LINENO"; then : + +else + ac_cxx_werror_flag=$ac_save_cxx_werror_flag + CXXFLAGS="-g" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_cxx_try_compile "$LINENO"; then : + ac_cv_prog_cxx_g=yes +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext + ac_cxx_werror_flag=$ac_save_cxx_werror_flag +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_cxx_g" >&5 +$as_echo "$ac_cv_prog_cxx_g" >&6; } +if test "$ac_test_CXXFLAGS" = set; then + CXXFLAGS=$ac_save_CXXFLAGS +elif test $ac_cv_prog_cxx_g = yes; then + if test "$GXX" = yes; then + CXXFLAGS="-g -O2" + else + CXXFLAGS="-g" + fi +else + if test "$GXX" = yes; then + CXXFLAGS="-O2" + else + CXXFLAGS= + fi +fi +ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu + +depcc="$CXX" am_compiler_list= + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking dependency style of $depcc" >&5 +$as_echo_n "checking dependency style of $depcc... " >&6; } +if ${am_cv_CXX_dependencies_compiler_type+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -z "$AMDEP_TRUE" && test -f "$am_depcomp"; then + # We make a subdir and do the tests there. Otherwise we can end up + # making bogus files that we don't know about and never remove. For + # instance it was reported that on HP-UX the gcc test will end up + # making a dummy file named `D' -- because `-MD' means `put the output + # in D'. + mkdir conftest.dir + # Copy depcomp to subdir because otherwise we won't find it if we're + # using a relative directory. + cp "$am_depcomp" conftest.dir + cd conftest.dir + # We will build objects and dependencies in a subdirectory because + # it helps to detect inapplicable dependency modes. For instance + # both Tru64's cc and ICC support -MD to output dependencies as a + # side effect of compilation, but ICC will put the dependencies in + # the current directory while Tru64 will put them in the object + # directory. + mkdir sub + + am_cv_CXX_dependencies_compiler_type=none + if test "$am_compiler_list" = ""; then + am_compiler_list=`sed -n 's/^#*\([a-zA-Z0-9]*\))$/\1/p' < ./depcomp` + fi + am__universal=false + case " $depcc " in #( + *\ -arch\ *\ -arch\ *) am__universal=true ;; + esac + + for depmode in $am_compiler_list; do + # Setup a source with many dependencies, because some compilers + # like to wrap large dependency lists on column 80 (with \), and + # we should not choose a depcomp mode which is confused by this. + # + # We need to recreate these files for each test, as the compiler may + # overwrite some of them when testing with obscure command lines. + # This happens at least with the AIX C compiler. + : > sub/conftest.c + for i in 1 2 3 4 5 6; do + echo '#include "conftst'$i'.h"' >> sub/conftest.c + # Using `: > sub/conftst$i.h' creates only sub/conftst1.h with + # Solaris 8's {/usr,}/bin/sh. + touch sub/conftst$i.h + done + echo "${am__include} ${am__quote}sub/conftest.Po${am__quote}" > confmf + + # We check with `-c' and `-o' for the sake of the "dashmstdout" + # mode. It turns out that the SunPro C++ compiler does not properly + # handle `-M -o', and we need to detect this. Also, some Intel + # versions had trouble with output in subdirs + am__obj=sub/conftest.${OBJEXT-o} + am__minus_obj="-o $am__obj" + case $depmode in + gcc) + # This depmode causes a compiler race in universal mode. + test "$am__universal" = false || continue + ;; + nosideeffect) + # after this tag, mechanisms are not by side-effect, so they'll + # only be used when explicitly requested + if test "x$enable_dependency_tracking" = xyes; then + continue + else + break + fi + ;; + msvisualcpp | msvcmsys) + # This compiler won't grok `-c -o', but also, the minuso test has + # not run yet. These depmodes are late enough in the game, and + # so weak that their functioning should not be impacted. + am__obj=conftest.${OBJEXT-o} + am__minus_obj= + ;; + none) break ;; + esac + if depmode=$depmode \ + source=sub/conftest.c object=$am__obj \ + depfile=sub/conftest.Po tmpdepfile=sub/conftest.TPo \ + $SHELL ./depcomp $depcc -c $am__minus_obj sub/conftest.c \ + >/dev/null 2>conftest.err && + grep sub/conftst1.h sub/conftest.Po > /dev/null 2>&1 && + grep sub/conftst6.h sub/conftest.Po > /dev/null 2>&1 && + grep $am__obj sub/conftest.Po > /dev/null 2>&1 && + ${MAKE-make} -s -f confmf > /dev/null 2>&1; then + # icc doesn't choke on unknown options, it will just issue warnings + # or remarks (even with -Werror). So we grep stderr for any message + # that says an option was ignored or not supported. + # When given -MP, icc 7.0 and 7.1 complain thusly: + # icc: Command line warning: ignoring option '-M'; no argument required + # The diagnosis changed in icc 8.0: + # icc: Command line remark: option '-MP' not supported + if (grep 'ignoring option' conftest.err || + grep 'not supported' conftest.err) >/dev/null 2>&1; then :; else + am_cv_CXX_dependencies_compiler_type=$depmode + break + fi + fi + done + + cd .. + rm -rf conftest.dir +else + am_cv_CXX_dependencies_compiler_type=none +fi + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $am_cv_CXX_dependencies_compiler_type" >&5 +$as_echo "$am_cv_CXX_dependencies_compiler_type" >&6; } +CXXDEPMODE=depmode=$am_cv_CXX_dependencies_compiler_type + + if + test "x$enable_dependency_tracking" != xno \ + && test "$am_cv_CXX_dependencies_compiler_type" = gcc3; then + am__fastdepCXX_TRUE= + am__fastdepCXX_FALSE='#' +else + am__fastdepCXX_TRUE='#' + am__fastdepCXX_FALSE= +fi + + + + +func_stripname_cnf () +{ + case ${2} in + .*) func_stripname_result=`$ECHO "${3}" | $SED "s%^${1}%%; s%\\\\${2}\$%%"`;; + *) func_stripname_result=`$ECHO "${3}" | $SED "s%^${1}%%; s%${2}\$%%"`;; + esac +} # func_stripname_cnf + + if test -n "$CXX" && ( test "X$CXX" != "Xno" && + ( (test "X$CXX" = "Xg++" && `g++ -v >/dev/null 2>&1` ) || + (test "X$CXX" != "Xg++"))) ; then + ac_ext=cpp +ac_cpp='$CXXCPP $CPPFLAGS' +ac_compile='$CXX -c $CXXFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CXX -o conftest$ac_exeext $CXXFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_cxx_compiler_gnu +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking how to run the C++ preprocessor" >&5 +$as_echo_n "checking how to run the C++ preprocessor... " >&6; } +if test -z "$CXXCPP"; then + if ${ac_cv_prog_CXXCPP+:} false; then : + $as_echo_n "(cached) " >&6 +else + # Double quotes because CXXCPP needs to be expanded + for CXXCPP in "$CXX -E" "/lib/cpp" + do + ac_preproc_ok=false +for ac_cxx_preproc_warn_flag in '' yes +do + # Use a header file that comes with gcc, so configuring glibc + # with a fresh cross-compiler works. + # Prefer to if __STDC__ is defined, since + # exists even on freestanding compilers. + # On the NeXT, cc -E runs the code through the compiler's parser, + # not just through cpp. "Syntax error" is here to catch this case. + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#ifdef __STDC__ +# include +#else +# include +#endif + Syntax error +_ACEOF +if ac_fn_cxx_try_cpp "$LINENO"; then : + +else + # Broken: fails on valid input. +continue +fi +rm -f conftest.err conftest.i conftest.$ac_ext + + # OK, works on sane cases. Now check whether nonexistent headers + # can be detected and how. + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include +_ACEOF +if ac_fn_cxx_try_cpp "$LINENO"; then : + # Broken: success on invalid input. +continue +else + # Passes both tests. +ac_preproc_ok=: +break +fi +rm -f conftest.err conftest.i conftest.$ac_ext + +done +# Because of `break', _AC_PREPROC_IFELSE's cleaning code was skipped. +rm -f conftest.i conftest.err conftest.$ac_ext +if $ac_preproc_ok; then : + break +fi + + done + ac_cv_prog_CXXCPP=$CXXCPP + +fi + CXXCPP=$ac_cv_prog_CXXCPP +else + ac_cv_prog_CXXCPP=$CXXCPP +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $CXXCPP" >&5 +$as_echo "$CXXCPP" >&6; } +ac_preproc_ok=false +for ac_cxx_preproc_warn_flag in '' yes +do + # Use a header file that comes with gcc, so configuring glibc + # with a fresh cross-compiler works. + # Prefer to if __STDC__ is defined, since + # exists even on freestanding compilers. + # On the NeXT, cc -E runs the code through the compiler's parser, + # not just through cpp. "Syntax error" is here to catch this case. + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#ifdef __STDC__ +# include +#else +# include +#endif + Syntax error +_ACEOF +if ac_fn_cxx_try_cpp "$LINENO"; then : + +else + # Broken: fails on valid input. +continue +fi +rm -f conftest.err conftest.i conftest.$ac_ext + + # OK, works on sane cases. Now check whether nonexistent headers + # can be detected and how. + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include +_ACEOF +if ac_fn_cxx_try_cpp "$LINENO"; then : + # Broken: success on invalid input. +continue +else + # Passes both tests. +ac_preproc_ok=: +break +fi +rm -f conftest.err conftest.i conftest.$ac_ext + +done +# Because of `break', _AC_PREPROC_IFELSE's cleaning code was skipped. +rm -f conftest.i conftest.err conftest.$ac_ext +if $ac_preproc_ok; then : + +else + { { $as_echo "$as_me:${as_lineno-$LINENO}: error: in \`$ac_pwd':" >&5 +$as_echo "$as_me: error: in \`$ac_pwd':" >&2;} +as_fn_error $? "C++ preprocessor \"$CXXCPP\" fails sanity check +See \`config.log' for more details" "$LINENO" 5; } +fi + +ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu + +else + _lt_caught_CXX_error=yes +fi + +ac_ext=cpp +ac_cpp='$CXXCPP $CPPFLAGS' +ac_compile='$CXX -c $CXXFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CXX -o conftest$ac_exeext $CXXFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_cxx_compiler_gnu + +archive_cmds_need_lc_CXX=no +allow_undefined_flag_CXX= +always_export_symbols_CXX=no +archive_expsym_cmds_CXX= +compiler_needs_object_CXX=no +export_dynamic_flag_spec_CXX= +hardcode_direct_CXX=no +hardcode_direct_absolute_CXX=no +hardcode_libdir_flag_spec_CXX= +hardcode_libdir_separator_CXX= +hardcode_minus_L_CXX=no +hardcode_shlibpath_var_CXX=unsupported +hardcode_automatic_CXX=no +inherit_rpath_CXX=no +module_cmds_CXX= +module_expsym_cmds_CXX= +link_all_deplibs_CXX=unknown +old_archive_cmds_CXX=$old_archive_cmds +reload_flag_CXX=$reload_flag +reload_cmds_CXX=$reload_cmds +no_undefined_flag_CXX= +whole_archive_flag_spec_CXX= +enable_shared_with_static_runtimes_CXX=no + +# Source file extension for C++ test sources. +ac_ext=cpp + +# Object file extension for compiled C++ test sources. +objext=o +objext_CXX=$objext + +# No sense in running all these tests if we already determined that +# the CXX compiler isn't working. Some variables (like enable_shared) +# are currently assumed to apply to all compilers on this platform, +# and will be corrupted by setting them based on a non-working compiler. +if test "$_lt_caught_CXX_error" != yes; then + # Code to be used in simple compile tests + lt_simple_compile_test_code="int some_variable = 0;" + + # Code to be used in simple link tests + lt_simple_link_test_code='int main(int, char *[]) { return(0); }' + + # ltmain only uses $CC for tagged configurations so make sure $CC is set. + + + + + + +# If no C compiler was specified, use CC. +LTCC=${LTCC-"$CC"} + +# If no C compiler flags were specified, use CFLAGS. +LTCFLAGS=${LTCFLAGS-"$CFLAGS"} + +# Allow CC to be a program name with arguments. +compiler=$CC + + + # save warnings/boilerplate of simple test code + ac_outfile=conftest.$ac_objext +echo "$lt_simple_compile_test_code" >conftest.$ac_ext +eval "$ac_compile" 2>&1 >/dev/null | $SED '/^$/d; /^ *+/d' >conftest.err +_lt_compiler_boilerplate=`cat conftest.err` +$RM conftest* + + ac_outfile=conftest.$ac_objext +echo "$lt_simple_link_test_code" >conftest.$ac_ext +eval "$ac_link" 2>&1 >/dev/null | $SED '/^$/d; /^ *+/d' >conftest.err +_lt_linker_boilerplate=`cat conftest.err` +$RM -r conftest* + + + # Allow CC to be a program name with arguments. + lt_save_CC=$CC + lt_save_CFLAGS=$CFLAGS + lt_save_LD=$LD + lt_save_GCC=$GCC + GCC=$GXX + lt_save_with_gnu_ld=$with_gnu_ld + lt_save_path_LD=$lt_cv_path_LD + if test -n "${lt_cv_prog_gnu_ldcxx+set}"; then + lt_cv_prog_gnu_ld=$lt_cv_prog_gnu_ldcxx + else + $as_unset lt_cv_prog_gnu_ld + fi + if test -n "${lt_cv_path_LDCXX+set}"; then + lt_cv_path_LD=$lt_cv_path_LDCXX + else + $as_unset lt_cv_path_LD + fi + test -z "${LDCXX+set}" || LD=$LDCXX + CC=${CXX-"c++"} + CFLAGS=$CXXFLAGS + compiler=$CC + compiler_CXX=$CC + for cc_temp in $compiler""; do + case $cc_temp in + compile | *[\\/]compile | ccache | *[\\/]ccache ) ;; + distcc | *[\\/]distcc | purify | *[\\/]purify ) ;; + \-*) ;; + *) break;; + esac +done +cc_basename=`$ECHO "$cc_temp" | $SED "s%.*/%%; s%^$host_alias-%%"` + + + if test -n "$compiler"; then + # We don't want -fno-exception when compiling C++ code, so set the + # no_builtin_flag separately + if test "$GXX" = yes; then + lt_prog_compiler_no_builtin_flag_CXX=' -fno-builtin' + else + lt_prog_compiler_no_builtin_flag_CXX= + fi + + if test "$GXX" = yes; then + # Set up default GNU C++ configuration + + + +# Check whether --with-gnu-ld was given. +if test "${with_gnu_ld+set}" = set; then : + withval=$with_gnu_ld; test "$withval" = no || with_gnu_ld=yes +else + with_gnu_ld=no +fi + +ac_prog=ld +if test "$GCC" = yes; then + # Check if gcc -print-prog-name=ld gives a path. + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for ld used by $CC" >&5 +$as_echo_n "checking for ld used by $CC... " >&6; } + case $host in + *-*-mingw*) + # gcc leaves a trailing carriage return which upsets mingw + ac_prog=`($CC -print-prog-name=ld) 2>&5 | tr -d '\015'` ;; + *) + ac_prog=`($CC -print-prog-name=ld) 2>&5` ;; + esac + case $ac_prog in + # Accept absolute paths. + [\\/]* | ?:[\\/]*) + re_direlt='/[^/][^/]*/\.\./' + # Canonicalize the pathname of ld + ac_prog=`$ECHO "$ac_prog"| $SED 's%\\\\%/%g'` + while $ECHO "$ac_prog" | $GREP "$re_direlt" > /dev/null 2>&1; do + ac_prog=`$ECHO $ac_prog| $SED "s%$re_direlt%/%"` + done + test -z "$LD" && LD="$ac_prog" + ;; + "") + # If it fails, then pretend we aren't using GCC. + ac_prog=ld + ;; + *) + # If it is relative, then search for the first ld in PATH. + with_gnu_ld=unknown + ;; + esac +elif test "$with_gnu_ld" = yes; then + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for GNU ld" >&5 +$as_echo_n "checking for GNU ld... " >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: checking for non-GNU ld" >&5 +$as_echo_n "checking for non-GNU ld... " >&6; } +fi +if ${lt_cv_path_LD+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -z "$LD"; then + lt_save_ifs="$IFS"; IFS=$PATH_SEPARATOR + for ac_dir in $PATH; do + IFS="$lt_save_ifs" + test -z "$ac_dir" && ac_dir=. + if test -f "$ac_dir/$ac_prog" || test -f "$ac_dir/$ac_prog$ac_exeext"; then + lt_cv_path_LD="$ac_dir/$ac_prog" + # Check to see if the program is GNU ld. I'd rather use --version, + # but apparently some variants of GNU ld only accept -v. + # Break only if it was the GNU/non-GNU ld that we prefer. + case `"$lt_cv_path_LD" -v 2>&1 &5 +$as_echo "$LD" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi +test -z "$LD" && as_fn_error $? "no acceptable ld found in \$PATH" "$LINENO" 5 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking if the linker ($LD) is GNU ld" >&5 +$as_echo_n "checking if the linker ($LD) is GNU ld... " >&6; } +if ${lt_cv_prog_gnu_ld+:} false; then : + $as_echo_n "(cached) " >&6 +else + # I'd rather use --version here, but apparently some GNU lds only accept -v. +case `$LD -v 2>&1 &5 +$as_echo "$lt_cv_prog_gnu_ld" >&6; } +with_gnu_ld=$lt_cv_prog_gnu_ld + + + + + + + + # Check if GNU C++ uses GNU ld as the underlying linker, since the + # archiving commands below assume that GNU ld is being used. + if test "$with_gnu_ld" = yes; then + archive_cmds_CXX='$CC $pic_flag -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname -o $lib' + archive_expsym_cmds_CXX='$CC $pic_flag -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + + hardcode_libdir_flag_spec_CXX='${wl}-rpath ${wl}$libdir' + export_dynamic_flag_spec_CXX='${wl}--export-dynamic' + + # If archive_cmds runs LD, not CC, wlarc should be empty + # XXX I think wlarc can be eliminated in ltcf-cxx, but I need to + # investigate it a little bit more. (MM) + wlarc='${wl}' + + # ancient GNU ld didn't support --whole-archive et. al. + if eval "`$CC -print-prog-name=ld` --help 2>&1" | + $GREP 'no-whole-archive' > /dev/null; then + whole_archive_flag_spec_CXX="$wlarc"'--whole-archive$convenience '"$wlarc"'--no-whole-archive' + else + whole_archive_flag_spec_CXX= + fi + else + with_gnu_ld=no + wlarc= + + # A generic and very simple default shared library creation + # command for GNU C++ for the case where it uses the native + # linker, instead of GNU ld. If possible, this setting should + # overridden to take advantage of the native linker features on + # the platform it is being used on. + archive_cmds_CXX='$CC -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -o $lib' + fi + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + output_verbose_link_cmd='$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP -v "^Configured with:" | $GREP "\-L"' + + else + GXX=no + with_gnu_ld=no + wlarc= + fi + + # PORTME: fill in a description of your system's C++ link characteristics + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether the $compiler linker ($LD) supports shared libraries" >&5 +$as_echo_n "checking whether the $compiler linker ($LD) supports shared libraries... " >&6; } + ld_shlibs_CXX=yes + case $host_os in + aix3*) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + aix[4-9]*) + if test "$host_cpu" = ia64; then + # On IA64, the linker does run time linking by default, so we don't + # have to do anything special. + aix_use_runtimelinking=no + exp_sym_flag='-Bexport' + no_entry_flag="" + else + aix_use_runtimelinking=no + + # Test if we are trying to use run time linking or normal + # AIX style linking. If -brtl is somewhere in LDFLAGS, we + # need to do runtime linking. + case $host_os in aix4.[23]|aix4.[23].*|aix[5-9]*) + for ld_flag in $LDFLAGS; do + case $ld_flag in + *-brtl*) + aix_use_runtimelinking=yes + break + ;; + esac + done + ;; + esac + + exp_sym_flag='-bexport' + no_entry_flag='-bnoentry' + fi + + # When large executables or shared objects are built, AIX ld can + # have problems creating the table of contents. If linking a library + # or program results in "error TOC overflow" add -mminimal-toc to + # CXXFLAGS/CFLAGS for g++/gcc. In the cases where that is not + # enough to fix the problem, add -Wl,-bbigtoc to LDFLAGS. + + archive_cmds_CXX='' + hardcode_direct_CXX=yes + hardcode_direct_absolute_CXX=yes + hardcode_libdir_separator_CXX=':' + link_all_deplibs_CXX=yes + file_list_spec_CXX='${wl}-f,' + + if test "$GXX" = yes; then + case $host_os in aix4.[012]|aix4.[012].*) + # We only want to do this on AIX 4.2 and lower, the check + # below for broken collect2 doesn't work under 4.3+ + collect2name=`${CC} -print-prog-name=collect2` + if test -f "$collect2name" && + strings "$collect2name" | $GREP resolve_lib_name >/dev/null + then + # We have reworked collect2 + : + else + # We have old collect2 + hardcode_direct_CXX=unsupported + # It fails to find uninstalled libraries when the uninstalled + # path is not listed in the libpath. Setting hardcode_minus_L + # to unsupported forces relinking + hardcode_minus_L_CXX=yes + hardcode_libdir_flag_spec_CXX='-L$libdir' + hardcode_libdir_separator_CXX= + fi + esac + shared_flag='-shared' + if test "$aix_use_runtimelinking" = yes; then + shared_flag="$shared_flag "'${wl}-G' + fi + else + # not using gcc + if test "$host_cpu" = ia64; then + # VisualAge C++, Version 5.5 for AIX 5L for IA-64, Beta 3 Release + # chokes on -Wl,-G. The following line is correct: + shared_flag='-G' + else + if test "$aix_use_runtimelinking" = yes; then + shared_flag='${wl}-G' + else + shared_flag='${wl}-bM:SRE' + fi + fi + fi + + export_dynamic_flag_spec_CXX='${wl}-bexpall' + # It seems that -bexpall does not export symbols beginning with + # underscore (_), so it is better to generate a list of symbols to + # export. + always_export_symbols_CXX=yes + if test "$aix_use_runtimelinking" = yes; then + # Warning - without using the other runtime loading flags (-brtl), + # -berok will link without error, but may produce a broken library. + allow_undefined_flag_CXX='-berok' + # Determine the default libpath from the value encoded in an empty + # executable. + if test "${lt_cv_aix_libpath+set}" = set; then + aix_libpath=$lt_cv_aix_libpath +else + if ${lt_cv_aix_libpath__CXX+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_cxx_try_link "$LINENO"; then : + + lt_aix_libpath_sed=' + /Import File Strings/,/^$/ { + /^0/ { + s/^0 *\([^ ]*\) *$/\1/ + p + } + }' + lt_cv_aix_libpath__CXX=`dump -H conftest$ac_exeext 2>/dev/null | $SED -n -e "$lt_aix_libpath_sed"` + # Check for a 64-bit object if we didn't find anything. + if test -z "$lt_cv_aix_libpath__CXX"; then + lt_cv_aix_libpath__CXX=`dump -HX64 conftest$ac_exeext 2>/dev/null | $SED -n -e "$lt_aix_libpath_sed"` + fi +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext + if test -z "$lt_cv_aix_libpath__CXX"; then + lt_cv_aix_libpath__CXX="/usr/lib:/lib" + fi + +fi + + aix_libpath=$lt_cv_aix_libpath__CXX +fi + + hardcode_libdir_flag_spec_CXX='${wl}-blibpath:$libdir:'"$aix_libpath" + + archive_expsym_cmds_CXX='$CC -o $output_objdir/$soname $libobjs $deplibs '"\${wl}$no_entry_flag"' $compiler_flags `if test "x${allow_undefined_flag}" != "x"; then func_echo_all "${wl}${allow_undefined_flag}"; else :; fi` '"\${wl}$exp_sym_flag:\$export_symbols $shared_flag" + else + if test "$host_cpu" = ia64; then + hardcode_libdir_flag_spec_CXX='${wl}-R $libdir:/usr/lib:/lib' + allow_undefined_flag_CXX="-z nodefs" + archive_expsym_cmds_CXX="\$CC $shared_flag"' -o $output_objdir/$soname $libobjs $deplibs '"\${wl}$no_entry_flag"' $compiler_flags ${wl}${allow_undefined_flag} '"\${wl}$exp_sym_flag:\$export_symbols" + else + # Determine the default libpath from the value encoded in an + # empty executable. + if test "${lt_cv_aix_libpath+set}" = set; then + aix_libpath=$lt_cv_aix_libpath +else + if ${lt_cv_aix_libpath__CXX+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_cxx_try_link "$LINENO"; then : + + lt_aix_libpath_sed=' + /Import File Strings/,/^$/ { + /^0/ { + s/^0 *\([^ ]*\) *$/\1/ + p + } + }' + lt_cv_aix_libpath__CXX=`dump -H conftest$ac_exeext 2>/dev/null | $SED -n -e "$lt_aix_libpath_sed"` + # Check for a 64-bit object if we didn't find anything. + if test -z "$lt_cv_aix_libpath__CXX"; then + lt_cv_aix_libpath__CXX=`dump -HX64 conftest$ac_exeext 2>/dev/null | $SED -n -e "$lt_aix_libpath_sed"` + fi +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext + if test -z "$lt_cv_aix_libpath__CXX"; then + lt_cv_aix_libpath__CXX="/usr/lib:/lib" + fi + +fi + + aix_libpath=$lt_cv_aix_libpath__CXX +fi + + hardcode_libdir_flag_spec_CXX='${wl}-blibpath:$libdir:'"$aix_libpath" + # Warning - without using the other run time loading flags, + # -berok will link without error, but may produce a broken library. + no_undefined_flag_CXX=' ${wl}-bernotok' + allow_undefined_flag_CXX=' ${wl}-berok' + if test "$with_gnu_ld" = yes; then + # We only use this code for GNU lds that support --whole-archive. + whole_archive_flag_spec_CXX='${wl}--whole-archive$convenience ${wl}--no-whole-archive' + else + # Exported symbols can be pulled into shared objects from archives + whole_archive_flag_spec_CXX='$convenience' + fi + archive_cmds_need_lc_CXX=yes + # This is similar to how AIX traditionally builds its shared + # libraries. + archive_expsym_cmds_CXX="\$CC $shared_flag"' -o $output_objdir/$soname $libobjs $deplibs ${wl}-bnoentry $compiler_flags ${wl}-bE:$export_symbols${allow_undefined_flag}~$AR $AR_FLAGS $output_objdir/$libname$release.a $output_objdir/$soname' + fi + fi + ;; + + beos*) + if $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + allow_undefined_flag_CXX=unsupported + # Joseph Beckenbach says some releases of gcc + # support --undefined. This deserves some investigation. FIXME + archive_cmds_CXX='$CC -nostart $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + else + ld_shlibs_CXX=no + fi + ;; + + chorus*) + case $cc_basename in + *) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + esac + ;; + + cygwin* | mingw* | pw32* | cegcc*) + case $GXX,$cc_basename in + ,cl* | no,cl*) + # Native MSVC + # hardcode_libdir_flag_spec is actually meaningless, as there is + # no search path for DLLs. + hardcode_libdir_flag_spec_CXX=' ' + allow_undefined_flag_CXX=unsupported + always_export_symbols_CXX=yes + file_list_spec_CXX='@' + # Tell ltmain to make .lib files, not .a files. + libext=lib + # Tell ltmain to make .dll files, not .so files. + shrext_cmds=".dll" + # FIXME: Setting linknames here is a bad hack. + archive_cmds_CXX='$CC -o $output_objdir/$soname $libobjs $compiler_flags $deplibs -Wl,-dll~linknames=' + archive_expsym_cmds_CXX='if test "x`$SED 1q $export_symbols`" = xEXPORTS; then + $SED -n -e 's/\\\\\\\(.*\\\\\\\)/-link\\\ -EXPORT:\\\\\\\1/' -e '1\\\!p' < $export_symbols > $output_objdir/$soname.exp; + else + $SED -e 's/\\\\\\\(.*\\\\\\\)/-link\\\ -EXPORT:\\\\\\\1/' < $export_symbols > $output_objdir/$soname.exp; + fi~ + $CC -o $tool_output_objdir$soname $libobjs $compiler_flags $deplibs "@$tool_output_objdir$soname.exp" -Wl,-DLL,-IMPLIB:"$tool_output_objdir$libname.dll.lib"~ + linknames=' + # The linker will not automatically build a static lib if we build a DLL. + # _LT_TAGVAR(old_archive_from_new_cmds, CXX)='true' + enable_shared_with_static_runtimes_CXX=yes + # Don't use ranlib + old_postinstall_cmds_CXX='chmod 644 $oldlib' + postlink_cmds_CXX='lt_outputfile="@OUTPUT@"~ + lt_tool_outputfile="@TOOL_OUTPUT@"~ + case $lt_outputfile in + *.exe|*.EXE) ;; + *) + lt_outputfile="$lt_outputfile.exe" + lt_tool_outputfile="$lt_tool_outputfile.exe" + ;; + esac~ + func_to_tool_file "$lt_outputfile"~ + if test "$MANIFEST_TOOL" != ":" && test -f "$lt_outputfile.manifest"; then + $MANIFEST_TOOL -manifest "$lt_tool_outputfile.manifest" -outputresource:"$lt_tool_outputfile" || exit 1; + $RM "$lt_outputfile.manifest"; + fi' + ;; + *) + # g++ + # _LT_TAGVAR(hardcode_libdir_flag_spec, CXX) is actually meaningless, + # as there is no search path for DLLs. + hardcode_libdir_flag_spec_CXX='-L$libdir' + export_dynamic_flag_spec_CXX='${wl}--export-all-symbols' + allow_undefined_flag_CXX=unsupported + always_export_symbols_CXX=no + enable_shared_with_static_runtimes_CXX=yes + + if $LD --help 2>&1 | $GREP 'auto-import' > /dev/null; then + archive_cmds_CXX='$CC -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -o $output_objdir/$soname ${wl}--enable-auto-image-base -Xlinker --out-implib -Xlinker $lib' + # If the export-symbols file already is a .def file (1st line + # is EXPORTS), use it as is; otherwise, prepend... + archive_expsym_cmds_CXX='if test "x`$SED 1q $export_symbols`" = xEXPORTS; then + cp $export_symbols $output_objdir/$soname.def; + else + echo EXPORTS > $output_objdir/$soname.def; + cat $export_symbols >> $output_objdir/$soname.def; + fi~ + $CC -shared -nostdlib $output_objdir/$soname.def $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -o $output_objdir/$soname ${wl}--enable-auto-image-base -Xlinker --out-implib -Xlinker $lib' + else + ld_shlibs_CXX=no + fi + ;; + esac + ;; + darwin* | rhapsody*) + + + archive_cmds_need_lc_CXX=no + hardcode_direct_CXX=no + hardcode_automatic_CXX=yes + hardcode_shlibpath_var_CXX=unsupported + if test "$lt_cv_ld_force_load" = "yes"; then + whole_archive_flag_spec_CXX='`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience ${wl}-force_load,$conv\"; done; func_echo_all \"$new_convenience\"`' + + else + whole_archive_flag_spec_CXX='' + fi + link_all_deplibs_CXX=yes + allow_undefined_flag_CXX="$_lt_dar_allow_undefined" + case $cc_basename in + ifort*) _lt_dar_can_shared=yes ;; + *) _lt_dar_can_shared=$GCC ;; + esac + if test "$_lt_dar_can_shared" = "yes"; then + output_verbose_link_cmd=func_echo_all + archive_cmds_CXX="\$CC -dynamiclib \$allow_undefined_flag -o \$lib \$libobjs \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring $_lt_dar_single_mod${_lt_dsymutil}" + module_cmds_CXX="\$CC \$allow_undefined_flag -o \$lib -bundle \$libobjs \$deplibs \$compiler_flags${_lt_dsymutil}" + archive_expsym_cmds_CXX="sed 's,^,_,' < \$export_symbols > \$output_objdir/\${libname}-symbols.expsym~\$CC -dynamiclib \$allow_undefined_flag -o \$lib \$libobjs \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring ${_lt_dar_single_mod}${_lt_dar_export_syms}${_lt_dsymutil}" + module_expsym_cmds_CXX="sed -e 's,^,_,' < \$export_symbols > \$output_objdir/\${libname}-symbols.expsym~\$CC \$allow_undefined_flag -o \$lib -bundle \$libobjs \$deplibs \$compiler_flags${_lt_dar_export_syms}${_lt_dsymutil}" + if test "$lt_cv_apple_cc_single_mod" != "yes"; then + archive_cmds_CXX="\$CC -r -keep_private_externs -nostdlib -o \${lib}-master.o \$libobjs~\$CC -dynamiclib \$allow_undefined_flag -o \$lib \${lib}-master.o \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring${_lt_dsymutil}" + archive_expsym_cmds_CXX="sed 's,^,_,' < \$export_symbols > \$output_objdir/\${libname}-symbols.expsym~\$CC -r -keep_private_externs -nostdlib -o \${lib}-master.o \$libobjs~\$CC -dynamiclib \$allow_undefined_flag -o \$lib \${lib}-master.o \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring${_lt_dar_export_syms}${_lt_dsymutil}" + fi + + else + ld_shlibs_CXX=no + fi + + ;; + + dgux*) + case $cc_basename in + ec++*) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + ghcx*) + # Green Hills C++ Compiler + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + *) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + esac + ;; + + freebsd2.*) + # C++ shared libraries reported to be fairly broken before + # switch to ELF + ld_shlibs_CXX=no + ;; + + freebsd-elf*) + archive_cmds_need_lc_CXX=no + ;; + + freebsd* | dragonfly*) + # FreeBSD 3 and later use GNU C++ and GNU ld with standard ELF + # conventions + ld_shlibs_CXX=yes + ;; + + gnu*) + ;; + + haiku*) + archive_cmds_CXX='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + link_all_deplibs_CXX=yes + ;; + + hpux9*) + hardcode_libdir_flag_spec_CXX='${wl}+b ${wl}$libdir' + hardcode_libdir_separator_CXX=: + export_dynamic_flag_spec_CXX='${wl}-E' + hardcode_direct_CXX=yes + hardcode_minus_L_CXX=yes # Not in the search PATH, + # but as the default + # location of the library. + + case $cc_basename in + CC*) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + aCC*) + archive_cmds_CXX='$RM $output_objdir/$soname~$CC -b ${wl}+b ${wl}$install_libdir -o $output_objdir/$soname $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~test $output_objdir/$soname = $lib || mv $output_objdir/$soname $lib' + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`($CC -b $CFLAGS -v conftest.$objext 2>&1) | $EGREP "\-L"`; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "$list"' + ;; + *) + if test "$GXX" = yes; then + archive_cmds_CXX='$RM $output_objdir/$soname~$CC -shared -nostdlib $pic_flag ${wl}+b ${wl}$install_libdir -o $output_objdir/$soname $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~test $output_objdir/$soname = $lib || mv $output_objdir/$soname $lib' + else + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + fi + ;; + esac + ;; + + hpux10*|hpux11*) + if test $with_gnu_ld = no; then + hardcode_libdir_flag_spec_CXX='${wl}+b ${wl}$libdir' + hardcode_libdir_separator_CXX=: + + case $host_cpu in + hppa*64*|ia64*) + ;; + *) + export_dynamic_flag_spec_CXX='${wl}-E' + ;; + esac + fi + case $host_cpu in + hppa*64*|ia64*) + hardcode_direct_CXX=no + hardcode_shlibpath_var_CXX=no + ;; + *) + hardcode_direct_CXX=yes + hardcode_direct_absolute_CXX=yes + hardcode_minus_L_CXX=yes # Not in the search PATH, + # but as the default + # location of the library. + ;; + esac + + case $cc_basename in + CC*) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + aCC*) + case $host_cpu in + hppa*64*) + archive_cmds_CXX='$CC -b ${wl}+h ${wl}$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + ia64*) + archive_cmds_CXX='$CC -b ${wl}+h ${wl}$soname ${wl}+nodefaultrpath -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + *) + archive_cmds_CXX='$CC -b ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + esac + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`($CC -b $CFLAGS -v conftest.$objext 2>&1) | $GREP "\-L"`; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "$list"' + ;; + *) + if test "$GXX" = yes; then + if test $with_gnu_ld = no; then + case $host_cpu in + hppa*64*) + archive_cmds_CXX='$CC -shared -nostdlib -fPIC ${wl}+h ${wl}$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + ia64*) + archive_cmds_CXX='$CC -shared -nostdlib $pic_flag ${wl}+h ${wl}$soname ${wl}+nodefaultrpath -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + *) + archive_cmds_CXX='$CC -shared -nostdlib $pic_flag ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + esac + fi + else + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + fi + ;; + esac + ;; + + interix[3-9]*) + hardcode_direct_CXX=no + hardcode_shlibpath_var_CXX=no + hardcode_libdir_flag_spec_CXX='${wl}-rpath,$libdir' + export_dynamic_flag_spec_CXX='${wl}-E' + # Hack: On Interix 3.x, we cannot compile PIC because of a broken gcc. + # Instead, shared libraries are loaded at an image base (0x10000000 by + # default) and relocated if they conflict, which is a slow very memory + # consuming and fragmenting process. To avoid this, we pick a random, + # 256 KiB-aligned image base between 0x50000000 and 0x6FFC0000 at link + # time. Moving up from 0x10000000 also allows more sbrk(2) space. + archive_cmds_CXX='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-h,$soname ${wl}--image-base,`expr ${RANDOM-$$} % 4096 / 2 \* 262144 + 1342177280` -o $lib' + archive_expsym_cmds_CXX='sed "s,^,_," $export_symbols >$output_objdir/$soname.expsym~$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-h,$soname ${wl}--retain-symbols-file,$output_objdir/$soname.expsym ${wl}--image-base,`expr ${RANDOM-$$} % 4096 / 2 \* 262144 + 1342177280` -o $lib' + ;; + irix5* | irix6*) + case $cc_basename in + CC*) + # SGI C++ + archive_cmds_CXX='$CC -shared -all -multigot $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + + # Archives containing C++ object files must be created using + # "CC -ar", where "CC" is the IRIX C++ compiler. This is + # necessary to make sure instantiated templates are included + # in the archive. + old_archive_cmds_CXX='$CC -ar -WR,-u -o $oldlib $oldobjs' + ;; + *) + if test "$GXX" = yes; then + if test "$with_gnu_ld" = no; then + archive_cmds_CXX='$CC -shared $pic_flag -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + else + archive_cmds_CXX='$CC -shared $pic_flag -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` -o $lib' + fi + fi + link_all_deplibs_CXX=yes + ;; + esac + hardcode_libdir_flag_spec_CXX='${wl}-rpath ${wl}$libdir' + hardcode_libdir_separator_CXX=: + inherit_rpath_CXX=yes + ;; + + linux* | k*bsd*-gnu | kopensolaris*-gnu) + case $cc_basename in + KCC*) + # Kuck and Associates, Inc. (KAI) C++ Compiler + + # KCC will only create a shared library if the output file + # ends with ".so" (or ".sl" for HP-UX), so rename the library + # to its proper name (with version) after linking. + archive_cmds_CXX='tempext=`echo $shared_ext | $SED -e '\''s/\([^()0-9A-Za-z{}]\)/\\\\\1/g'\''`; templib=`echo $lib | $SED -e "s/\${tempext}\..*/.so/"`; $CC $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags --soname $soname -o \$templib; mv \$templib $lib' + archive_expsym_cmds_CXX='tempext=`echo $shared_ext | $SED -e '\''s/\([^()0-9A-Za-z{}]\)/\\\\\1/g'\''`; templib=`echo $lib | $SED -e "s/\${tempext}\..*/.so/"`; $CC $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags --soname $soname -o \$templib ${wl}-retain-symbols-file,$export_symbols; mv \$templib $lib' + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`$CC $CFLAGS -v conftest.$objext -o libconftest$shared_ext 2>&1 | $GREP "ld"`; rm -f libconftest$shared_ext; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "$list"' + + hardcode_libdir_flag_spec_CXX='${wl}-rpath,$libdir' + export_dynamic_flag_spec_CXX='${wl}--export-dynamic' + + # Archives containing C++ object files must be created using + # "CC -Bstatic", where "CC" is the KAI C++ compiler. + old_archive_cmds_CXX='$CC -Bstatic -o $oldlib $oldobjs' + ;; + icpc* | ecpc* ) + # Intel C++ + with_gnu_ld=yes + # version 8.0 and above of icpc choke on multiply defined symbols + # if we add $predep_objects and $postdep_objects, however 7.1 and + # earlier do not add the objects themselves. + case `$CC -V 2>&1` in + *"Version 7."*) + archive_cmds_CXX='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname -o $lib' + archive_expsym_cmds_CXX='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + ;; + *) # Version 8.0 or newer + tmp_idyn= + case $host_cpu in + ia64*) tmp_idyn=' -i_dynamic';; + esac + archive_cmds_CXX='$CC -shared'"$tmp_idyn"' $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + archive_expsym_cmds_CXX='$CC -shared'"$tmp_idyn"' $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + ;; + esac + archive_cmds_need_lc_CXX=no + hardcode_libdir_flag_spec_CXX='${wl}-rpath,$libdir' + export_dynamic_flag_spec_CXX='${wl}--export-dynamic' + whole_archive_flag_spec_CXX='${wl}--whole-archive$convenience ${wl}--no-whole-archive' + ;; + pgCC* | pgcpp*) + # Portland Group C++ compiler + case `$CC -V` in + *pgCC\ [1-5].* | *pgcpp\ [1-5].*) + prelink_cmds_CXX='tpldir=Template.dir~ + rm -rf $tpldir~ + $CC --prelink_objects --instantiation_dir $tpldir $objs $libobjs $compile_deplibs~ + compile_command="$compile_command `find $tpldir -name \*.o | sort | $NL2SP`"' + old_archive_cmds_CXX='tpldir=Template.dir~ + rm -rf $tpldir~ + $CC --prelink_objects --instantiation_dir $tpldir $oldobjs$old_deplibs~ + $AR $AR_FLAGS $oldlib$oldobjs$old_deplibs `find $tpldir -name \*.o | sort | $NL2SP`~ + $RANLIB $oldlib' + archive_cmds_CXX='tpldir=Template.dir~ + rm -rf $tpldir~ + $CC --prelink_objects --instantiation_dir $tpldir $predep_objects $libobjs $deplibs $convenience $postdep_objects~ + $CC -shared $pic_flag $predep_objects $libobjs $deplibs `find $tpldir -name \*.o | sort | $NL2SP` $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname -o $lib' + archive_expsym_cmds_CXX='tpldir=Template.dir~ + rm -rf $tpldir~ + $CC --prelink_objects --instantiation_dir $tpldir $predep_objects $libobjs $deplibs $convenience $postdep_objects~ + $CC -shared $pic_flag $predep_objects $libobjs $deplibs `find $tpldir -name \*.o | sort | $NL2SP` $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname ${wl}-retain-symbols-file ${wl}$export_symbols -o $lib' + ;; + *) # Version 6 and above use weak symbols + archive_cmds_CXX='$CC -shared $pic_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname -o $lib' + archive_expsym_cmds_CXX='$CC -shared $pic_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname ${wl}-retain-symbols-file ${wl}$export_symbols -o $lib' + ;; + esac + + hardcode_libdir_flag_spec_CXX='${wl}--rpath ${wl}$libdir' + export_dynamic_flag_spec_CXX='${wl}--export-dynamic' + whole_archive_flag_spec_CXX='${wl}--whole-archive`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + ;; + cxx*) + # Compaq C++ + archive_cmds_CXX='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname -o $lib' + archive_expsym_cmds_CXX='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname -o $lib ${wl}-retain-symbols-file $wl$export_symbols' + + runpath_var=LD_RUN_PATH + hardcode_libdir_flag_spec_CXX='-rpath $libdir' + hardcode_libdir_separator_CXX=: + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP "ld"`; templist=`func_echo_all "$templist" | $SED "s/\(^.*ld.*\)\( .*ld .*$\)/\1/"`; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "X$list" | $Xsed' + ;; + xl* | mpixl* | bgxl*) + # IBM XL 8.0 on PPC, with GNU ld + hardcode_libdir_flag_spec_CXX='${wl}-rpath ${wl}$libdir' + export_dynamic_flag_spec_CXX='${wl}--export-dynamic' + archive_cmds_CXX='$CC -qmkshrobj $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + if test "x$supports_anon_versioning" = xyes; then + archive_expsym_cmds_CXX='echo "{ global:" > $output_objdir/$libname.ver~ + cat $export_symbols | sed -e "s/\(.*\)/\1;/" >> $output_objdir/$libname.ver~ + echo "local: *; };" >> $output_objdir/$libname.ver~ + $CC -qmkshrobj $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-version-script ${wl}$output_objdir/$libname.ver -o $lib' + fi + ;; + *) + case `$CC -V 2>&1 | sed 5q` in + *Sun\ C*) + # Sun C++ 5.9 + no_undefined_flag_CXX=' -zdefs' + archive_cmds_CXX='$CC -G${allow_undefined_flag} -h$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + archive_expsym_cmds_CXX='$CC -G${allow_undefined_flag} -h$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-retain-symbols-file ${wl}$export_symbols' + hardcode_libdir_flag_spec_CXX='-R$libdir' + whole_archive_flag_spec_CXX='${wl}--whole-archive`new_convenience=; for conv in $convenience\"\"; do test -z \"$conv\" || new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + compiler_needs_object_CXX=yes + + # Not sure whether something based on + # $CC $CFLAGS -v conftest.$objext -o libconftest$shared_ext 2>&1 + # would be better. + output_verbose_link_cmd='func_echo_all' + + # Archives containing C++ object files must be created using + # "CC -xar", where "CC" is the Sun C++ compiler. This is + # necessary to make sure instantiated templates are included + # in the archive. + old_archive_cmds_CXX='$CC -xar -o $oldlib $oldobjs' + ;; + esac + ;; + esac + ;; + + lynxos*) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + + m88k*) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + + mvs*) + case $cc_basename in + cxx*) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + *) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + esac + ;; + + netbsd*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ >/dev/null; then + archive_cmds_CXX='$LD -Bshareable -o $lib $predep_objects $libobjs $deplibs $postdep_objects $linker_flags' + wlarc= + hardcode_libdir_flag_spec_CXX='-R$libdir' + hardcode_direct_CXX=yes + hardcode_shlibpath_var_CXX=no + fi + # Workaround some broken pre-1.5 toolchains + output_verbose_link_cmd='$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP conftest.$objext | $SED -e "s:-lgcc -lc -lgcc::"' + ;; + + *nto* | *qnx*) + ld_shlibs_CXX=yes + ;; + + openbsd2*) + # C++ shared libraries are fairly broken + ld_shlibs_CXX=no + ;; + + openbsd*) + if test -f /usr/libexec/ld.so; then + hardcode_direct_CXX=yes + hardcode_shlibpath_var_CXX=no + hardcode_direct_absolute_CXX=yes + archive_cmds_CXX='$CC -shared $pic_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -o $lib' + hardcode_libdir_flag_spec_CXX='${wl}-rpath,$libdir' + if test -z "`echo __ELF__ | $CC -E - | grep __ELF__`" || test "$host_os-$host_cpu" = "openbsd2.8-powerpc"; then + archive_expsym_cmds_CXX='$CC -shared $pic_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-retain-symbols-file,$export_symbols -o $lib' + export_dynamic_flag_spec_CXX='${wl}-E' + whole_archive_flag_spec_CXX="$wlarc"'--whole-archive$convenience '"$wlarc"'--no-whole-archive' + fi + output_verbose_link_cmd=func_echo_all + else + ld_shlibs_CXX=no + fi + ;; + + osf3* | osf4* | osf5*) + case $cc_basename in + KCC*) + # Kuck and Associates, Inc. (KAI) C++ Compiler + + # KCC will only create a shared library if the output file + # ends with ".so" (or ".sl" for HP-UX), so rename the library + # to its proper name (with version) after linking. + archive_cmds_CXX='tempext=`echo $shared_ext | $SED -e '\''s/\([^()0-9A-Za-z{}]\)/\\\\\1/g'\''`; templib=`echo "$lib" | $SED -e "s/\${tempext}\..*/.so/"`; $CC $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags --soname $soname -o \$templib; mv \$templib $lib' + + hardcode_libdir_flag_spec_CXX='${wl}-rpath,$libdir' + hardcode_libdir_separator_CXX=: + + # Archives containing C++ object files must be created using + # the KAI C++ compiler. + case $host in + osf3*) old_archive_cmds_CXX='$CC -Bstatic -o $oldlib $oldobjs' ;; + *) old_archive_cmds_CXX='$CC -o $oldlib $oldobjs' ;; + esac + ;; + RCC*) + # Rational C++ 2.4.1 + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + cxx*) + case $host in + osf3*) + allow_undefined_flag_CXX=' ${wl}-expect_unresolved ${wl}\*' + archive_cmds_CXX='$CC -shared${allow_undefined_flag} $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $soname `test -n "$verstring" && func_echo_all "${wl}-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + hardcode_libdir_flag_spec_CXX='${wl}-rpath ${wl}$libdir' + ;; + *) + allow_undefined_flag_CXX=' -expect_unresolved \*' + archive_cmds_CXX='$CC -shared${allow_undefined_flag} $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -msym -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + archive_expsym_cmds_CXX='for i in `cat $export_symbols`; do printf "%s %s\\n" -exported_symbol "\$i" >> $lib.exp; done~ + echo "-hidden">> $lib.exp~ + $CC -shared$allow_undefined_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -msym -soname $soname ${wl}-input ${wl}$lib.exp `test -n "$verstring" && $ECHO "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib~ + $RM $lib.exp' + hardcode_libdir_flag_spec_CXX='-rpath $libdir' + ;; + esac + + hardcode_libdir_separator_CXX=: + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP "ld" | $GREP -v "ld:"`; templist=`func_echo_all "$templist" | $SED "s/\(^.*ld.*\)\( .*ld.*$\)/\1/"`; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "$list"' + ;; + *) + if test "$GXX" = yes && test "$with_gnu_ld" = no; then + allow_undefined_flag_CXX=' ${wl}-expect_unresolved ${wl}\*' + case $host in + osf3*) + archive_cmds_CXX='$CC -shared -nostdlib ${allow_undefined_flag} $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + ;; + *) + archive_cmds_CXX='$CC -shared $pic_flag -nostdlib ${allow_undefined_flag} $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-msym ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + ;; + esac + + hardcode_libdir_flag_spec_CXX='${wl}-rpath ${wl}$libdir' + hardcode_libdir_separator_CXX=: + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + output_verbose_link_cmd='$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP -v "^Configured with:" | $GREP "\-L"' + + else + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + fi + ;; + esac + ;; + + psos*) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + + sunos4*) + case $cc_basename in + CC*) + # Sun C++ 4.x + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + lcc*) + # Lucid + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + *) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + esac + ;; + + solaris*) + case $cc_basename in + CC* | sunCC*) + # Sun C++ 4.2, 5.x and Centerline C++ + archive_cmds_need_lc_CXX=yes + no_undefined_flag_CXX=' -zdefs' + archive_cmds_CXX='$CC -G${allow_undefined_flag} -h$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + archive_expsym_cmds_CXX='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -G${allow_undefined_flag} ${wl}-M ${wl}$lib.exp -h$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~$RM $lib.exp' + + hardcode_libdir_flag_spec_CXX='-R$libdir' + hardcode_shlibpath_var_CXX=no + case $host_os in + solaris2.[0-5] | solaris2.[0-5].*) ;; + *) + # The compiler driver will combine and reorder linker options, + # but understands `-z linker_flag'. + # Supported since Solaris 2.6 (maybe 2.5.1?) + whole_archive_flag_spec_CXX='-z allextract$convenience -z defaultextract' + ;; + esac + link_all_deplibs_CXX=yes + + output_verbose_link_cmd='func_echo_all' + + # Archives containing C++ object files must be created using + # "CC -xar", where "CC" is the Sun C++ compiler. This is + # necessary to make sure instantiated templates are included + # in the archive. + old_archive_cmds_CXX='$CC -xar -o $oldlib $oldobjs' + ;; + gcx*) + # Green Hills C++ Compiler + archive_cmds_CXX='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-h $wl$soname -o $lib' + + # The C++ compiler must be used to create the archive. + old_archive_cmds_CXX='$CC $LDFLAGS -archive -o $oldlib $oldobjs' + ;; + *) + # GNU C++ compiler with Solaris linker + if test "$GXX" = yes && test "$with_gnu_ld" = no; then + no_undefined_flag_CXX=' ${wl}-z ${wl}defs' + if $CC --version | $GREP -v '^2\.7' > /dev/null; then + archive_cmds_CXX='$CC -shared $pic_flag -nostdlib $LDFLAGS $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-h $wl$soname -o $lib' + archive_expsym_cmds_CXX='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -shared $pic_flag -nostdlib ${wl}-M $wl$lib.exp -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~$RM $lib.exp' + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + output_verbose_link_cmd='$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP -v "^Configured with:" | $GREP "\-L"' + else + # g++ 2.7 appears to require `-G' NOT `-shared' on this + # platform. + archive_cmds_CXX='$CC -G -nostdlib $LDFLAGS $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-h $wl$soname -o $lib' + archive_expsym_cmds_CXX='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -G -nostdlib ${wl}-M $wl$lib.exp -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~$RM $lib.exp' + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + output_verbose_link_cmd='$CC -G $CFLAGS -v conftest.$objext 2>&1 | $GREP -v "^Configured with:" | $GREP "\-L"' + fi + + hardcode_libdir_flag_spec_CXX='${wl}-R $wl$libdir' + case $host_os in + solaris2.[0-5] | solaris2.[0-5].*) ;; + *) + whole_archive_flag_spec_CXX='${wl}-z ${wl}allextract$convenience ${wl}-z ${wl}defaultextract' + ;; + esac + fi + ;; + esac + ;; + + sysv4*uw2* | sysv5OpenUNIX* | sysv5UnixWare7.[01].[10]* | unixware7* | sco3.2v5.0.[024]*) + no_undefined_flag_CXX='${wl}-z,text' + archive_cmds_need_lc_CXX=no + hardcode_shlibpath_var_CXX=no + runpath_var='LD_RUN_PATH' + + case $cc_basename in + CC*) + archive_cmds_CXX='$CC -G ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + archive_expsym_cmds_CXX='$CC -G ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + *) + archive_cmds_CXX='$CC -shared ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + archive_expsym_cmds_CXX='$CC -shared ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + esac + ;; + + sysv5* | sco3.2v5* | sco5v6*) + # Note: We can NOT use -z defs as we might desire, because we do not + # link with -lc, and that would cause any symbols used from libc to + # always be unresolved, which means just about no library would + # ever link correctly. If we're not using GNU ld we use -z text + # though, which does catch some bad symbols but isn't as heavy-handed + # as -z defs. + no_undefined_flag_CXX='${wl}-z,text' + allow_undefined_flag_CXX='${wl}-z,nodefs' + archive_cmds_need_lc_CXX=no + hardcode_shlibpath_var_CXX=no + hardcode_libdir_flag_spec_CXX='${wl}-R,$libdir' + hardcode_libdir_separator_CXX=':' + link_all_deplibs_CXX=yes + export_dynamic_flag_spec_CXX='${wl}-Bexport' + runpath_var='LD_RUN_PATH' + + case $cc_basename in + CC*) + archive_cmds_CXX='$CC -G ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + archive_expsym_cmds_CXX='$CC -G ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + old_archive_cmds_CXX='$CC -Tprelink_objects $oldobjs~ + '"$old_archive_cmds_CXX" + reload_cmds_CXX='$CC -Tprelink_objects $reload_objs~ + '"$reload_cmds_CXX" + ;; + *) + archive_cmds_CXX='$CC -shared ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + archive_expsym_cmds_CXX='$CC -shared ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + esac + ;; + + tandem*) + case $cc_basename in + NCC*) + # NonStop-UX NCC 3.20 + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + *) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + esac + ;; + + vxworks*) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + + *) + # FIXME: insert proper C++ library support + ld_shlibs_CXX=no + ;; + esac + + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ld_shlibs_CXX" >&5 +$as_echo "$ld_shlibs_CXX" >&6; } + test "$ld_shlibs_CXX" = no && can_build_shared=no + + GCC_CXX="$GXX" + LD_CXX="$LD" + + ## CAVEAT EMPTOR: + ## There is no encapsulation within the following macros, do not change + ## the running order or otherwise move them around unless you know exactly + ## what you are doing... + # Dependencies to place before and after the object being linked: +predep_objects_CXX= +postdep_objects_CXX= +predeps_CXX= +postdeps_CXX= +compiler_lib_search_path_CXX= + +cat > conftest.$ac_ext <<_LT_EOF +class Foo +{ +public: + Foo (void) { a = 0; } +private: + int a; +}; +_LT_EOF + + +_lt_libdeps_save_CFLAGS=$CFLAGS +case "$CC $CFLAGS " in #( +*\ -flto*\ *) CFLAGS="$CFLAGS -fno-lto" ;; +*\ -fwhopr*\ *) CFLAGS="$CFLAGS -fno-whopr" ;; +*\ -fuse-linker-plugin*\ *) CFLAGS="$CFLAGS -fno-use-linker-plugin" ;; +esac + +if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$ac_compile\""; } >&5 + (eval $ac_compile) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; }; then + # Parse the compiler output and extract the necessary + # objects, libraries and library flags. + + # Sentinel used to keep track of whether or not we are before + # the conftest object file. + pre_test_object_deps_done=no + + for p in `eval "$output_verbose_link_cmd"`; do + case ${prev}${p} in + + -L* | -R* | -l*) + # Some compilers place space between "-{L,R}" and the path. + # Remove the space. + if test $p = "-L" || + test $p = "-R"; then + prev=$p + continue + fi + + # Expand the sysroot to ease extracting the directories later. + if test -z "$prev"; then + case $p in + -L*) func_stripname_cnf '-L' '' "$p"; prev=-L; p=$func_stripname_result ;; + -R*) func_stripname_cnf '-R' '' "$p"; prev=-R; p=$func_stripname_result ;; + -l*) func_stripname_cnf '-l' '' "$p"; prev=-l; p=$func_stripname_result ;; + esac + fi + case $p in + =*) func_stripname_cnf '=' '' "$p"; p=$lt_sysroot$func_stripname_result ;; + esac + if test "$pre_test_object_deps_done" = no; then + case ${prev} in + -L | -R) + # Internal compiler library paths should come after those + # provided the user. The postdeps already come after the + # user supplied libs so there is no need to process them. + if test -z "$compiler_lib_search_path_CXX"; then + compiler_lib_search_path_CXX="${prev}${p}" + else + compiler_lib_search_path_CXX="${compiler_lib_search_path_CXX} ${prev}${p}" + fi + ;; + # The "-l" case would never come before the object being + # linked, so don't bother handling this case. + esac + else + if test -z "$postdeps_CXX"; then + postdeps_CXX="${prev}${p}" + else + postdeps_CXX="${postdeps_CXX} ${prev}${p}" + fi + fi + prev= + ;; + + *.lto.$objext) ;; # Ignore GCC LTO objects + *.$objext) + # This assumes that the test object file only shows up + # once in the compiler output. + if test "$p" = "conftest.$objext"; then + pre_test_object_deps_done=yes + continue + fi + + if test "$pre_test_object_deps_done" = no; then + if test -z "$predep_objects_CXX"; then + predep_objects_CXX="$p" + else + predep_objects_CXX="$predep_objects_CXX $p" + fi + else + if test -z "$postdep_objects_CXX"; then + postdep_objects_CXX="$p" + else + postdep_objects_CXX="$postdep_objects_CXX $p" + fi + fi + ;; + + *) ;; # Ignore the rest. + + esac + done + + # Clean up. + rm -f a.out a.exe +else + echo "libtool.m4: error: problem compiling CXX test program" +fi + +$RM -f confest.$objext +CFLAGS=$_lt_libdeps_save_CFLAGS + +# PORTME: override above test on systems where it is broken +case $host_os in +interix[3-9]*) + # Interix 3.5 installs completely hosed .la files for C++, so rather than + # hack all around it, let's just trust "g++" to DTRT. + predep_objects_CXX= + postdep_objects_CXX= + postdeps_CXX= + ;; + +linux*) + case `$CC -V 2>&1 | sed 5q` in + *Sun\ C*) + # Sun C++ 5.9 + + # The more standards-conforming stlport4 library is + # incompatible with the Cstd library. Avoid specifying + # it if it's in CXXFLAGS. Ignore libCrun as + # -library=stlport4 depends on it. + case " $CXX $CXXFLAGS " in + *" -library=stlport4 "*) + solaris_use_stlport4=yes + ;; + esac + + if test "$solaris_use_stlport4" != yes; then + postdeps_CXX='-library=Cstd -library=Crun' + fi + ;; + esac + ;; + +solaris*) + case $cc_basename in + CC* | sunCC*) + # The more standards-conforming stlport4 library is + # incompatible with the Cstd library. Avoid specifying + # it if it's in CXXFLAGS. Ignore libCrun as + # -library=stlport4 depends on it. + case " $CXX $CXXFLAGS " in + *" -library=stlport4 "*) + solaris_use_stlport4=yes + ;; + esac + + # Adding this requires a known-good setup of shared libraries for + # Sun compiler versions before 5.6, else PIC objects from an old + # archive will be linked into the output, leading to subtle bugs. + if test "$solaris_use_stlport4" != yes; then + postdeps_CXX='-library=Cstd -library=Crun' + fi + ;; + esac + ;; +esac + + +case " $postdeps_CXX " in +*" -lc "*) archive_cmds_need_lc_CXX=no ;; +esac + compiler_lib_search_dirs_CXX= +if test -n "${compiler_lib_search_path_CXX}"; then + compiler_lib_search_dirs_CXX=`echo " ${compiler_lib_search_path_CXX}" | ${SED} -e 's! -L! !g' -e 's!^ !!'` +fi + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + lt_prog_compiler_wl_CXX= +lt_prog_compiler_pic_CXX= +lt_prog_compiler_static_CXX= + + + # C++ specific cases for pic, static, wl, etc. + if test "$GXX" = yes; then + lt_prog_compiler_wl_CXX='-Wl,' + lt_prog_compiler_static_CXX='-static' + + case $host_os in + aix*) + # All AIX code is PIC. + if test "$host_cpu" = ia64; then + # AIX 5 now supports IA64 processor + lt_prog_compiler_static_CXX='-Bstatic' + fi + ;; + + amigaos*) + case $host_cpu in + powerpc) + # see comment about AmigaOS4 .so support + lt_prog_compiler_pic_CXX='-fPIC' + ;; + m68k) + # FIXME: we need at least 68020 code to build shared libraries, but + # adding the `-m68020' flag to GCC prevents building anything better, + # like `-m68040'. + lt_prog_compiler_pic_CXX='-m68020 -resident32 -malways-restore-a4' + ;; + esac + ;; + + beos* | irix5* | irix6* | nonstopux* | osf3* | osf4* | osf5*) + # PIC is the default for these OSes. + ;; + mingw* | cygwin* | os2* | pw32* | cegcc*) + # This hack is so that the source file can tell whether it is being + # built for inclusion in a dll (and should export symbols for example). + # Although the cygwin gcc ignores -fPIC, still need this for old-style + # (--disable-auto-import) libraries + lt_prog_compiler_pic_CXX='-DDLL_EXPORT' + ;; + darwin* | rhapsody*) + # PIC is the default on this platform + # Common symbols not allowed in MH_DYLIB files + lt_prog_compiler_pic_CXX='-fno-common' + ;; + *djgpp*) + # DJGPP does not support shared libraries at all + lt_prog_compiler_pic_CXX= + ;; + haiku*) + # PIC is the default for Haiku. + # The "-static" flag exists, but is broken. + lt_prog_compiler_static_CXX= + ;; + interix[3-9]*) + # Interix 3.x gcc -fpic/-fPIC options generate broken code. + # Instead, we relocate shared libraries at runtime. + ;; + sysv4*MP*) + if test -d /usr/nec; then + lt_prog_compiler_pic_CXX=-Kconform_pic + fi + ;; + hpux*) + # PIC is the default for 64-bit PA HP-UX, but not for 32-bit + # PA HP-UX. On IA64 HP-UX, PIC is the default but the pic flag + # sets the default TLS model and affects inlining. + case $host_cpu in + hppa*64*) + ;; + *) + lt_prog_compiler_pic_CXX='-fPIC' + ;; + esac + ;; + *qnx* | *nto*) + # QNX uses GNU C++, but need to define -shared option too, otherwise + # it will coredump. + lt_prog_compiler_pic_CXX='-fPIC -shared' + ;; + *) + lt_prog_compiler_pic_CXX='-fPIC' + ;; + esac + else + case $host_os in + aix[4-9]*) + # All AIX code is PIC. + if test "$host_cpu" = ia64; then + # AIX 5 now supports IA64 processor + lt_prog_compiler_static_CXX='-Bstatic' + else + lt_prog_compiler_static_CXX='-bnso -bI:/lib/syscalls.exp' + fi + ;; + chorus*) + case $cc_basename in + cxch68*) + # Green Hills C++ Compiler + # _LT_TAGVAR(lt_prog_compiler_static, CXX)="--no_auto_instantiation -u __main -u __premain -u _abort -r $COOL_DIR/lib/libOrb.a $MVME_DIR/lib/CC/libC.a $MVME_DIR/lib/classix/libcx.s.a" + ;; + esac + ;; + mingw* | cygwin* | os2* | pw32* | cegcc*) + # This hack is so that the source file can tell whether it is being + # built for inclusion in a dll (and should export symbols for example). + lt_prog_compiler_pic_CXX='-DDLL_EXPORT' + ;; + dgux*) + case $cc_basename in + ec++*) + lt_prog_compiler_pic_CXX='-KPIC' + ;; + ghcx*) + # Green Hills C++ Compiler + lt_prog_compiler_pic_CXX='-pic' + ;; + *) + ;; + esac + ;; + freebsd* | dragonfly*) + # FreeBSD uses GNU C++ + ;; + hpux9* | hpux10* | hpux11*) + case $cc_basename in + CC*) + lt_prog_compiler_wl_CXX='-Wl,' + lt_prog_compiler_static_CXX='${wl}-a ${wl}archive' + if test "$host_cpu" != ia64; then + lt_prog_compiler_pic_CXX='+Z' + fi + ;; + aCC*) + lt_prog_compiler_wl_CXX='-Wl,' + lt_prog_compiler_static_CXX='${wl}-a ${wl}archive' + case $host_cpu in + hppa*64*|ia64*) + # +Z the default + ;; + *) + lt_prog_compiler_pic_CXX='+Z' + ;; + esac + ;; + *) + ;; + esac + ;; + interix*) + # This is c89, which is MS Visual C++ (no shared libs) + # Anyone wants to do a port? + ;; + irix5* | irix6* | nonstopux*) + case $cc_basename in + CC*) + lt_prog_compiler_wl_CXX='-Wl,' + lt_prog_compiler_static_CXX='-non_shared' + # CC pic flag -KPIC is the default. + ;; + *) + ;; + esac + ;; + linux* | k*bsd*-gnu | kopensolaris*-gnu) + case $cc_basename in + KCC*) + # KAI C++ Compiler + lt_prog_compiler_wl_CXX='--backend -Wl,' + lt_prog_compiler_pic_CXX='-fPIC' + ;; + ecpc* ) + # old Intel C++ for x86_64 which still supported -KPIC. + lt_prog_compiler_wl_CXX='-Wl,' + lt_prog_compiler_pic_CXX='-KPIC' + lt_prog_compiler_static_CXX='-static' + ;; + icpc* ) + # Intel C++, used to be incompatible with GCC. + # ICC 10 doesn't accept -KPIC any more. + lt_prog_compiler_wl_CXX='-Wl,' + lt_prog_compiler_pic_CXX='-fPIC' + lt_prog_compiler_static_CXX='-static' + ;; + pgCC* | pgcpp*) + # Portland Group C++ compiler + lt_prog_compiler_wl_CXX='-Wl,' + lt_prog_compiler_pic_CXX='-fpic' + lt_prog_compiler_static_CXX='-Bstatic' + ;; + cxx*) + # Compaq C++ + # Make sure the PIC flag is empty. It appears that all Alpha + # Linux and Compaq Tru64 Unix objects are PIC. + lt_prog_compiler_pic_CXX= + lt_prog_compiler_static_CXX='-non_shared' + ;; + xlc* | xlC* | bgxl[cC]* | mpixl[cC]*) + # IBM XL 8.0, 9.0 on PPC and BlueGene + lt_prog_compiler_wl_CXX='-Wl,' + lt_prog_compiler_pic_CXX='-qpic' + lt_prog_compiler_static_CXX='-qstaticlink' + ;; + *) + case `$CC -V 2>&1 | sed 5q` in + *Sun\ C*) + # Sun C++ 5.9 + lt_prog_compiler_pic_CXX='-KPIC' + lt_prog_compiler_static_CXX='-Bstatic' + lt_prog_compiler_wl_CXX='-Qoption ld ' + ;; + esac + ;; + esac + ;; + lynxos*) + ;; + m88k*) + ;; + mvs*) + case $cc_basename in + cxx*) + lt_prog_compiler_pic_CXX='-W c,exportall' + ;; + *) + ;; + esac + ;; + netbsd*) + ;; + *qnx* | *nto*) + # QNX uses GNU C++, but need to define -shared option too, otherwise + # it will coredump. + lt_prog_compiler_pic_CXX='-fPIC -shared' + ;; + osf3* | osf4* | osf5*) + case $cc_basename in + KCC*) + lt_prog_compiler_wl_CXX='--backend -Wl,' + ;; + RCC*) + # Rational C++ 2.4.1 + lt_prog_compiler_pic_CXX='-pic' + ;; + cxx*) + # Digital/Compaq C++ + lt_prog_compiler_wl_CXX='-Wl,' + # Make sure the PIC flag is empty. It appears that all Alpha + # Linux and Compaq Tru64 Unix objects are PIC. + lt_prog_compiler_pic_CXX= + lt_prog_compiler_static_CXX='-non_shared' + ;; + *) + ;; + esac + ;; + psos*) + ;; + solaris*) + case $cc_basename in + CC* | sunCC*) + # Sun C++ 4.2, 5.x and Centerline C++ + lt_prog_compiler_pic_CXX='-KPIC' + lt_prog_compiler_static_CXX='-Bstatic' + lt_prog_compiler_wl_CXX='-Qoption ld ' + ;; + gcx*) + # Green Hills C++ Compiler + lt_prog_compiler_pic_CXX='-PIC' + ;; + *) + ;; + esac + ;; + sunos4*) + case $cc_basename in + CC*) + # Sun C++ 4.x + lt_prog_compiler_pic_CXX='-pic' + lt_prog_compiler_static_CXX='-Bstatic' + ;; + lcc*) + # Lucid + lt_prog_compiler_pic_CXX='-pic' + ;; + *) + ;; + esac + ;; + sysv5* | unixware* | sco3.2v5* | sco5v6* | OpenUNIX*) + case $cc_basename in + CC*) + lt_prog_compiler_wl_CXX='-Wl,' + lt_prog_compiler_pic_CXX='-KPIC' + lt_prog_compiler_static_CXX='-Bstatic' + ;; + esac + ;; + tandem*) + case $cc_basename in + NCC*) + # NonStop-UX NCC 3.20 + lt_prog_compiler_pic_CXX='-KPIC' + ;; + *) + ;; + esac + ;; + vxworks*) + ;; + *) + lt_prog_compiler_can_build_shared_CXX=no + ;; + esac + fi + +case $host_os in + # For platforms which do not support PIC, -DPIC is meaningless: + *djgpp*) + lt_prog_compiler_pic_CXX= + ;; + *) + lt_prog_compiler_pic_CXX="$lt_prog_compiler_pic_CXX -DPIC" + ;; +esac + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $compiler option to produce PIC" >&5 +$as_echo_n "checking for $compiler option to produce PIC... " >&6; } +if ${lt_cv_prog_compiler_pic_CXX+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_prog_compiler_pic_CXX=$lt_prog_compiler_pic_CXX +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_prog_compiler_pic_CXX" >&5 +$as_echo "$lt_cv_prog_compiler_pic_CXX" >&6; } +lt_prog_compiler_pic_CXX=$lt_cv_prog_compiler_pic_CXX + +# +# Check to make sure the PIC flag actually works. +# +if test -n "$lt_prog_compiler_pic_CXX"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: checking if $compiler PIC flag $lt_prog_compiler_pic_CXX works" >&5 +$as_echo_n "checking if $compiler PIC flag $lt_prog_compiler_pic_CXX works... " >&6; } +if ${lt_cv_prog_compiler_pic_works_CXX+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_prog_compiler_pic_works_CXX=no + ac_outfile=conftest.$ac_objext + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + lt_compiler_flag="$lt_prog_compiler_pic_CXX -DPIC" + # Insert the option either (1) after the last *FLAGS variable, or + # (2) before a word containing "conftest.", or (3) at the end. + # Note that $ac_compile itself does not contain backslashes and begins + # with a dollar sign (not a hyphen), so the echo should work correctly. + # The option is referenced via a variable to avoid confusing sed. + lt_compile=`echo "$ac_compile" | $SED \ + -e 's:.*FLAGS}\{0,1\} :&$lt_compiler_flag :; t' \ + -e 's: [^ ]*conftest\.: $lt_compiler_flag&:; t' \ + -e 's:$: $lt_compiler_flag:'` + (eval echo "\"\$as_me:$LINENO: $lt_compile\"" >&5) + (eval "$lt_compile" 2>conftest.err) + ac_status=$? + cat conftest.err >&5 + echo "$as_me:$LINENO: \$? = $ac_status" >&5 + if (exit $ac_status) && test -s "$ac_outfile"; then + # The compiler can only warn and ignore the option if not recognized + # So say no if there are warnings other than the usual output. + $ECHO "$_lt_compiler_boilerplate" | $SED '/^$/d' >conftest.exp + $SED '/^$/d; /^ *+/d' conftest.err >conftest.er2 + if test ! -s conftest.er2 || diff conftest.exp conftest.er2 >/dev/null; then + lt_cv_prog_compiler_pic_works_CXX=yes + fi + fi + $RM conftest* + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_prog_compiler_pic_works_CXX" >&5 +$as_echo "$lt_cv_prog_compiler_pic_works_CXX" >&6; } + +if test x"$lt_cv_prog_compiler_pic_works_CXX" = xyes; then + case $lt_prog_compiler_pic_CXX in + "" | " "*) ;; + *) lt_prog_compiler_pic_CXX=" $lt_prog_compiler_pic_CXX" ;; + esac +else + lt_prog_compiler_pic_CXX= + lt_prog_compiler_can_build_shared_CXX=no +fi + +fi + + + + + +# +# Check to make sure the static flag actually works. +# +wl=$lt_prog_compiler_wl_CXX eval lt_tmp_static_flag=\"$lt_prog_compiler_static_CXX\" +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking if $compiler static flag $lt_tmp_static_flag works" >&5 +$as_echo_n "checking if $compiler static flag $lt_tmp_static_flag works... " >&6; } +if ${lt_cv_prog_compiler_static_works_CXX+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_prog_compiler_static_works_CXX=no + save_LDFLAGS="$LDFLAGS" + LDFLAGS="$LDFLAGS $lt_tmp_static_flag" + echo "$lt_simple_link_test_code" > conftest.$ac_ext + if (eval $ac_link 2>conftest.err) && test -s conftest$ac_exeext; then + # The linker can only warn and ignore the option if not recognized + # So say no if there are warnings + if test -s conftest.err; then + # Append any errors to the config.log. + cat conftest.err 1>&5 + $ECHO "$_lt_linker_boilerplate" | $SED '/^$/d' > conftest.exp + $SED '/^$/d; /^ *+/d' conftest.err >conftest.er2 + if diff conftest.exp conftest.er2 >/dev/null; then + lt_cv_prog_compiler_static_works_CXX=yes + fi + else + lt_cv_prog_compiler_static_works_CXX=yes + fi + fi + $RM -r conftest* + LDFLAGS="$save_LDFLAGS" + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_prog_compiler_static_works_CXX" >&5 +$as_echo "$lt_cv_prog_compiler_static_works_CXX" >&6; } + +if test x"$lt_cv_prog_compiler_static_works_CXX" = xyes; then + : +else + lt_prog_compiler_static_CXX= +fi + + + + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking if $compiler supports -c -o file.$ac_objext" >&5 +$as_echo_n "checking if $compiler supports -c -o file.$ac_objext... " >&6; } +if ${lt_cv_prog_compiler_c_o_CXX+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_prog_compiler_c_o_CXX=no + $RM -r conftest 2>/dev/null + mkdir conftest + cd conftest + mkdir out + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + + lt_compiler_flag="-o out/conftest2.$ac_objext" + # Insert the option either (1) after the last *FLAGS variable, or + # (2) before a word containing "conftest.", or (3) at the end. + # Note that $ac_compile itself does not contain backslashes and begins + # with a dollar sign (not a hyphen), so the echo should work correctly. + lt_compile=`echo "$ac_compile" | $SED \ + -e 's:.*FLAGS}\{0,1\} :&$lt_compiler_flag :; t' \ + -e 's: [^ ]*conftest\.: $lt_compiler_flag&:; t' \ + -e 's:$: $lt_compiler_flag:'` + (eval echo "\"\$as_me:$LINENO: $lt_compile\"" >&5) + (eval "$lt_compile" 2>out/conftest.err) + ac_status=$? + cat out/conftest.err >&5 + echo "$as_me:$LINENO: \$? = $ac_status" >&5 + if (exit $ac_status) && test -s out/conftest2.$ac_objext + then + # The compiler can only warn and ignore the option if not recognized + # So say no if there are warnings + $ECHO "$_lt_compiler_boilerplate" | $SED '/^$/d' > out/conftest.exp + $SED '/^$/d; /^ *+/d' out/conftest.err >out/conftest.er2 + if test ! -s out/conftest.er2 || diff out/conftest.exp out/conftest.er2 >/dev/null; then + lt_cv_prog_compiler_c_o_CXX=yes + fi + fi + chmod u+w . 2>&5 + $RM conftest* + # SGI C++ compiler will create directory out/ii_files/ for + # template instantiation + test -d out/ii_files && $RM out/ii_files/* && rmdir out/ii_files + $RM out/* && rmdir out + cd .. + $RM -r conftest + $RM conftest* + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_prog_compiler_c_o_CXX" >&5 +$as_echo "$lt_cv_prog_compiler_c_o_CXX" >&6; } + + + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking if $compiler supports -c -o file.$ac_objext" >&5 +$as_echo_n "checking if $compiler supports -c -o file.$ac_objext... " >&6; } +if ${lt_cv_prog_compiler_c_o_CXX+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_prog_compiler_c_o_CXX=no + $RM -r conftest 2>/dev/null + mkdir conftest + cd conftest + mkdir out + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + + lt_compiler_flag="-o out/conftest2.$ac_objext" + # Insert the option either (1) after the last *FLAGS variable, or + # (2) before a word containing "conftest.", or (3) at the end. + # Note that $ac_compile itself does not contain backslashes and begins + # with a dollar sign (not a hyphen), so the echo should work correctly. + lt_compile=`echo "$ac_compile" | $SED \ + -e 's:.*FLAGS}\{0,1\} :&$lt_compiler_flag :; t' \ + -e 's: [^ ]*conftest\.: $lt_compiler_flag&:; t' \ + -e 's:$: $lt_compiler_flag:'` + (eval echo "\"\$as_me:$LINENO: $lt_compile\"" >&5) + (eval "$lt_compile" 2>out/conftest.err) + ac_status=$? + cat out/conftest.err >&5 + echo "$as_me:$LINENO: \$? = $ac_status" >&5 + if (exit $ac_status) && test -s out/conftest2.$ac_objext + then + # The compiler can only warn and ignore the option if not recognized + # So say no if there are warnings + $ECHO "$_lt_compiler_boilerplate" | $SED '/^$/d' > out/conftest.exp + $SED '/^$/d; /^ *+/d' out/conftest.err >out/conftest.er2 + if test ! -s out/conftest.er2 || diff out/conftest.exp out/conftest.er2 >/dev/null; then + lt_cv_prog_compiler_c_o_CXX=yes + fi + fi + chmod u+w . 2>&5 + $RM conftest* + # SGI C++ compiler will create directory out/ii_files/ for + # template instantiation + test -d out/ii_files && $RM out/ii_files/* && rmdir out/ii_files + $RM out/* && rmdir out + cd .. + $RM -r conftest + $RM conftest* + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_prog_compiler_c_o_CXX" >&5 +$as_echo "$lt_cv_prog_compiler_c_o_CXX" >&6; } + + + + +hard_links="nottested" +if test "$lt_cv_prog_compiler_c_o_CXX" = no && test "$need_locks" != no; then + # do not overwrite the value of need_locks provided by the user + { $as_echo "$as_me:${as_lineno-$LINENO}: checking if we can lock with hard links" >&5 +$as_echo_n "checking if we can lock with hard links... " >&6; } + hard_links=yes + $RM conftest* + ln conftest.a conftest.b 2>/dev/null && hard_links=no + touch conftest.a + ln conftest.a conftest.b 2>&5 || hard_links=no + ln conftest.a conftest.b 2>/dev/null && hard_links=no + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $hard_links" >&5 +$as_echo "$hard_links" >&6; } + if test "$hard_links" = no; then + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: \`$CC' does not support \`-c -o', so \`make -j' may be unsafe" >&5 +$as_echo "$as_me: WARNING: \`$CC' does not support \`-c -o', so \`make -j' may be unsafe" >&2;} + need_locks=warn + fi +else + need_locks=no +fi + + + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether the $compiler linker ($LD) supports shared libraries" >&5 +$as_echo_n "checking whether the $compiler linker ($LD) supports shared libraries... " >&6; } + + export_symbols_cmds_CXX='$NM $libobjs $convenience | $global_symbol_pipe | $SED '\''s/.* //'\'' | sort | uniq > $export_symbols' + exclude_expsyms_CXX='_GLOBAL_OFFSET_TABLE_|_GLOBAL__F[ID]_.*' + case $host_os in + aix[4-9]*) + # If we're using GNU nm, then we don't want the "-C" option. + # -C means demangle to AIX nm, but means don't demangle with GNU nm + # Also, AIX nm treats weak defined symbols like other global defined + # symbols, whereas GNU nm marks them as "W". + if $NM -V 2>&1 | $GREP 'GNU' > /dev/null; then + export_symbols_cmds_CXX='$NM -Bpg $libobjs $convenience | awk '\''{ if (((\$ 2 == "T") || (\$ 2 == "D") || (\$ 2 == "B") || (\$ 2 == "W")) && (substr(\$ 3,1,1) != ".")) { print \$ 3 } }'\'' | sort -u > $export_symbols' + else + export_symbols_cmds_CXX='$NM -BCpg $libobjs $convenience | awk '\''{ if (((\$ 2 == "T") || (\$ 2 == "D") || (\$ 2 == "B")) && (substr(\$ 3,1,1) != ".")) { print \$ 3 } }'\'' | sort -u > $export_symbols' + fi + ;; + pw32*) + export_symbols_cmds_CXX="$ltdll_cmds" + ;; + cygwin* | mingw* | cegcc*) + case $cc_basename in + cl*) + exclude_expsyms_CXX='_NULL_IMPORT_DESCRIPTOR|_IMPORT_DESCRIPTOR_.*' + ;; + *) + export_symbols_cmds_CXX='$NM $libobjs $convenience | $global_symbol_pipe | $SED -e '\''/^[BCDGRS][ ]/s/.*[ ]\([^ ]*\)/\1 DATA/;s/^.*[ ]__nm__\([^ ]*\)[ ][^ ]*/\1 DATA/;/^I[ ]/d;/^[AITW][ ]/s/.* //'\'' | sort | uniq > $export_symbols' + exclude_expsyms_CXX='[_]+GLOBAL_OFFSET_TABLE_|[_]+GLOBAL__[FID]_.*|[_]+head_[A-Za-z0-9_]+_dll|[A-Za-z0-9_]+_dll_iname' + ;; + esac + ;; + *) + export_symbols_cmds_CXX='$NM $libobjs $convenience | $global_symbol_pipe | $SED '\''s/.* //'\'' | sort | uniq > $export_symbols' + ;; + esac + +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ld_shlibs_CXX" >&5 +$as_echo "$ld_shlibs_CXX" >&6; } +test "$ld_shlibs_CXX" = no && can_build_shared=no + +with_gnu_ld_CXX=$with_gnu_ld + + + + + + +# +# Do we need to explicitly link libc? +# +case "x$archive_cmds_need_lc_CXX" in +x|xyes) + # Assume -lc should be added + archive_cmds_need_lc_CXX=yes + + if test "$enable_shared" = yes && test "$GCC" = yes; then + case $archive_cmds_CXX in + *'~'*) + # FIXME: we may have to deal with multi-command sequences. + ;; + '$CC '*) + # Test whether the compiler implicitly links with -lc since on some + # systems, -lgcc has to come before -lc. If gcc already passes -lc + # to ld, don't add -lc before -lgcc. + { $as_echo "$as_me:${as_lineno-$LINENO}: checking whether -lc should be explicitly linked in" >&5 +$as_echo_n "checking whether -lc should be explicitly linked in... " >&6; } +if ${lt_cv_archive_cmds_need_lc_CXX+:} false; then : + $as_echo_n "(cached) " >&6 +else + $RM conftest* + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + + if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$ac_compile\""; } >&5 + (eval $ac_compile) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } 2>conftest.err; then + soname=conftest + lib=conftest + libobjs=conftest.$ac_objext + deplibs= + wl=$lt_prog_compiler_wl_CXX + pic_flag=$lt_prog_compiler_pic_CXX + compiler_flags=-v + linker_flags=-v + verstring= + output_objdir=. + libname=conftest + lt_save_allow_undefined_flag=$allow_undefined_flag_CXX + allow_undefined_flag_CXX= + if { { eval echo "\"\$as_me\":${as_lineno-$LINENO}: \"$archive_cmds_CXX 2\>\&1 \| $GREP \" -lc \" \>/dev/null 2\>\&1\""; } >&5 + (eval $archive_cmds_CXX 2\>\&1 \| $GREP \" -lc \" \>/dev/null 2\>\&1) 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } + then + lt_cv_archive_cmds_need_lc_CXX=no + else + lt_cv_archive_cmds_need_lc_CXX=yes + fi + allow_undefined_flag_CXX=$lt_save_allow_undefined_flag + else + cat conftest.err 1>&5 + fi + $RM conftest* + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $lt_cv_archive_cmds_need_lc_CXX" >&5 +$as_echo "$lt_cv_archive_cmds_need_lc_CXX" >&6; } + archive_cmds_need_lc_CXX=$lt_cv_archive_cmds_need_lc_CXX + ;; + esac + fi + ;; +esac + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking dynamic linker characteristics" >&5 +$as_echo_n "checking dynamic linker characteristics... " >&6; } + +library_names_spec= +libname_spec='lib$name' +soname_spec= +shrext_cmds=".so" +postinstall_cmds= +postuninstall_cmds= +finish_cmds= +finish_eval= +shlibpath_var= +shlibpath_overrides_runpath=unknown +version_type=none +dynamic_linker="$host_os ld.so" +sys_lib_dlsearch_path_spec="/lib /usr/lib" +need_lib_prefix=unknown +hardcode_into_libs=no + +# when you set need_version to no, make sure it does not cause -set_version +# flags to be left without arguments +need_version=unknown + +case $host_os in +aix3*) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix $libname.a' + shlibpath_var=LIBPATH + + # AIX 3 has no versioning support, so we append a major version to the name. + soname_spec='${libname}${release}${shared_ext}$major' + ;; + +aix[4-9]*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + hardcode_into_libs=yes + if test "$host_cpu" = ia64; then + # AIX 5 supports IA64 + library_names_spec='${libname}${release}${shared_ext}$major ${libname}${release}${shared_ext}$versuffix $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + else + # With GCC up to 2.95.x, collect2 would create an import file + # for dependence libraries. The import file would start with + # the line `#! .'. This would cause the generated library to + # depend on `.', always an invalid library. This was fixed in + # development snapshots of GCC prior to 3.0. + case $host_os in + aix4 | aix4.[01] | aix4.[01].*) + if { echo '#if __GNUC__ > 2 || (__GNUC__ == 2 && __GNUC_MINOR__ >= 97)' + echo ' yes ' + echo '#endif'; } | ${CC} -E - | $GREP yes > /dev/null; then + : + else + can_build_shared=no + fi + ;; + esac + # AIX (on Power*) has no versioning support, so currently we can not hardcode correct + # soname into executable. Probably we can add versioning support to + # collect2, so additional links can be useful in future. + if test "$aix_use_runtimelinking" = yes; then + # If using run time linking (on AIX 4.2 or later) use lib.so + # instead of lib.a to let people know that these are not + # typical AIX shared libraries. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + else + # We preserve .a as extension for shared libraries through AIX4.2 + # and later when we are not doing run time linking. + library_names_spec='${libname}${release}.a $libname.a' + soname_spec='${libname}${release}${shared_ext}$major' + fi + shlibpath_var=LIBPATH + fi + ;; + +amigaos*) + case $host_cpu in + powerpc) + # Since July 2007 AmigaOS4 officially supports .so libraries. + # When compiling the executable, add -use-dynld -Lsobjs: to the compileline. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + ;; + m68k) + library_names_spec='$libname.ixlibrary $libname.a' + # Create ${libname}_ixlibrary.a entries in /sys/libs. + finish_eval='for lib in `ls $libdir/*.ixlibrary 2>/dev/null`; do libname=`func_echo_all "$lib" | $SED '\''s%^.*/\([^/]*\)\.ixlibrary$%\1%'\''`; test $RM /sys/libs/${libname}_ixlibrary.a; $show "cd /sys/libs && $LN_S $lib ${libname}_ixlibrary.a"; cd /sys/libs && $LN_S $lib ${libname}_ixlibrary.a || exit 1; done' + ;; + esac + ;; + +beos*) + library_names_spec='${libname}${shared_ext}' + dynamic_linker="$host_os ld.so" + shlibpath_var=LIBRARY_PATH + ;; + +bsdi[45]*) + version_type=linux # correct to gnu/linux during the next big refactor + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + finish_cmds='PATH="\$PATH:/sbin" ldconfig $libdir' + shlibpath_var=LD_LIBRARY_PATH + sys_lib_search_path_spec="/shlib /usr/lib /usr/X11/lib /usr/contrib/lib /lib /usr/local/lib" + sys_lib_dlsearch_path_spec="/shlib /usr/lib /usr/local/lib" + # the default ld.so.conf also contains /usr/contrib/lib and + # /usr/X11R6/lib (/usr/X11 is a link to /usr/X11R6), but let us allow + # libtool to hard-code these into programs + ;; + +cygwin* | mingw* | pw32* | cegcc*) + version_type=windows + shrext_cmds=".dll" + need_version=no + need_lib_prefix=no + + case $GCC,$cc_basename in + yes,*) + # gcc + library_names_spec='$libname.dll.a' + # DLL is installed to $(libdir)/../bin by postinstall_cmds + postinstall_cmds='base_file=`basename \${file}`~ + dlpath=`$SHELL 2>&1 -c '\''. $dir/'\''\${base_file}'\''i; echo \$dlname'\''`~ + dldir=$destdir/`dirname \$dlpath`~ + test -d \$dldir || mkdir -p \$dldir~ + $install_prog $dir/$dlname \$dldir/$dlname~ + chmod a+x \$dldir/$dlname~ + if test -n '\''$stripme'\'' && test -n '\''$striplib'\''; then + eval '\''$striplib \$dldir/$dlname'\'' || exit \$?; + fi' + postuninstall_cmds='dldll=`$SHELL 2>&1 -c '\''. $file; echo \$dlname'\''`~ + dlpath=$dir/\$dldll~ + $RM \$dlpath' + shlibpath_overrides_runpath=yes + + case $host_os in + cygwin*) + # Cygwin DLLs use 'cyg' prefix rather than 'lib' + soname_spec='`echo ${libname} | sed -e 's/^lib/cyg/'``echo ${release} | $SED -e 's/[.]/-/g'`${versuffix}${shared_ext}' + + ;; + mingw* | cegcc*) + # MinGW DLLs use traditional 'lib' prefix + soname_spec='${libname}`echo ${release} | $SED -e 's/[.]/-/g'`${versuffix}${shared_ext}' + ;; + pw32*) + # pw32 DLLs use 'pw' prefix rather than 'lib' + library_names_spec='`echo ${libname} | sed -e 's/^lib/pw/'``echo ${release} | $SED -e 's/[.]/-/g'`${versuffix}${shared_ext}' + ;; + esac + dynamic_linker='Win32 ld.exe' + ;; + + *,cl*) + # Native MSVC + libname_spec='$name' + soname_spec='${libname}`echo ${release} | $SED -e 's/[.]/-/g'`${versuffix}${shared_ext}' + library_names_spec='${libname}.dll.lib' + + case $build_os in + mingw*) + sys_lib_search_path_spec= + lt_save_ifs=$IFS + IFS=';' + for lt_path in $LIB + do + IFS=$lt_save_ifs + # Let DOS variable expansion print the short 8.3 style file name. + lt_path=`cd "$lt_path" 2>/dev/null && cmd //C "for %i in (".") do @echo %~si"` + sys_lib_search_path_spec="$sys_lib_search_path_spec $lt_path" + done + IFS=$lt_save_ifs + # Convert to MSYS style. + sys_lib_search_path_spec=`$ECHO "$sys_lib_search_path_spec" | sed -e 's|\\\\|/|g' -e 's| \\([a-zA-Z]\\):| /\\1|g' -e 's|^ ||'` + ;; + cygwin*) + # Convert to unix form, then to dos form, then back to unix form + # but this time dos style (no spaces!) so that the unix form looks + # like /cygdrive/c/PROGRA~1:/cygdr... + sys_lib_search_path_spec=`cygpath --path --unix "$LIB"` + sys_lib_search_path_spec=`cygpath --path --dos "$sys_lib_search_path_spec" 2>/dev/null` + sys_lib_search_path_spec=`cygpath --path --unix "$sys_lib_search_path_spec" | $SED -e "s/$PATH_SEPARATOR/ /g"` + ;; + *) + sys_lib_search_path_spec="$LIB" + if $ECHO "$sys_lib_search_path_spec" | $GREP ';[c-zC-Z]:/' >/dev/null; then + # It is most probably a Windows format PATH. + sys_lib_search_path_spec=`$ECHO "$sys_lib_search_path_spec" | $SED -e 's/;/ /g'` + else + sys_lib_search_path_spec=`$ECHO "$sys_lib_search_path_spec" | $SED -e "s/$PATH_SEPARATOR/ /g"` + fi + # FIXME: find the short name or the path components, as spaces are + # common. (e.g. "Program Files" -> "PROGRA~1") + ;; + esac + + # DLL is installed to $(libdir)/../bin by postinstall_cmds + postinstall_cmds='base_file=`basename \${file}`~ + dlpath=`$SHELL 2>&1 -c '\''. $dir/'\''\${base_file}'\''i; echo \$dlname'\''`~ + dldir=$destdir/`dirname \$dlpath`~ + test -d \$dldir || mkdir -p \$dldir~ + $install_prog $dir/$dlname \$dldir/$dlname' + postuninstall_cmds='dldll=`$SHELL 2>&1 -c '\''. $file; echo \$dlname'\''`~ + dlpath=$dir/\$dldll~ + $RM \$dlpath' + shlibpath_overrides_runpath=yes + dynamic_linker='Win32 link.exe' + ;; + + *) + # Assume MSVC wrapper + library_names_spec='${libname}`echo ${release} | $SED -e 's/[.]/-/g'`${versuffix}${shared_ext} $libname.lib' + dynamic_linker='Win32 ld.exe' + ;; + esac + # FIXME: first we should search . and the directory the executable is in + shlibpath_var=PATH + ;; + +darwin* | rhapsody*) + dynamic_linker="$host_os dyld" + version_type=darwin + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${major}$shared_ext ${libname}$shared_ext' + soname_spec='${libname}${release}${major}$shared_ext' + shlibpath_overrides_runpath=yes + shlibpath_var=DYLD_LIBRARY_PATH + shrext_cmds='`test .$module = .yes && echo .so || echo .dylib`' + + sys_lib_dlsearch_path_spec='/usr/local/lib /lib /usr/lib' + ;; + +dgux*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname$shared_ext' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + ;; + +freebsd* | dragonfly*) + # DragonFly does not have aout. When/if they implement a new + # versioning mechanism, adjust this. + if test -x /usr/bin/objformat; then + objformat=`/usr/bin/objformat` + else + case $host_os in + freebsd[23].*) objformat=aout ;; + *) objformat=elf ;; + esac + fi + version_type=freebsd-$objformat + case $version_type in + freebsd-elf*) + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext} $libname${shared_ext}' + need_version=no + need_lib_prefix=no + ;; + freebsd-*) + library_names_spec='${libname}${release}${shared_ext}$versuffix $libname${shared_ext}$versuffix' + need_version=yes + ;; + esac + shlibpath_var=LD_LIBRARY_PATH + case $host_os in + freebsd2.*) + shlibpath_overrides_runpath=yes + ;; + freebsd3.[01]* | freebsdelf3.[01]*) + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + ;; + freebsd3.[2-9]* | freebsdelf3.[2-9]* | \ + freebsd4.[0-5] | freebsdelf4.[0-5] | freebsd4.1.1 | freebsdelf4.1.1) + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + *) # from 4.6 on, and DragonFly + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + ;; + esac + ;; + +gnu*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}${major} ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + +haiku*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + dynamic_linker="$host_os runtime_loader" + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}${major} ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LIBRARY_PATH + shlibpath_overrides_runpath=yes + sys_lib_dlsearch_path_spec='/boot/home/config/lib /boot/common/lib /boot/system/lib' + hardcode_into_libs=yes + ;; + +hpux9* | hpux10* | hpux11*) + # Give a soname corresponding to the major version so that dld.sl refuses to + # link against other versions. + version_type=sunos + need_lib_prefix=no + need_version=no + case $host_cpu in + ia64*) + shrext_cmds='.so' + hardcode_into_libs=yes + dynamic_linker="$host_os dld.so" + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes # Unless +noenvvar is specified. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + if test "X$HPUX_IA64_MODE" = X32; then + sys_lib_search_path_spec="/usr/lib/hpux32 /usr/local/lib/hpux32 /usr/local/lib" + else + sys_lib_search_path_spec="/usr/lib/hpux64 /usr/local/lib/hpux64" + fi + sys_lib_dlsearch_path_spec=$sys_lib_search_path_spec + ;; + hppa*64*) + shrext_cmds='.sl' + hardcode_into_libs=yes + dynamic_linker="$host_os dld.sl" + shlibpath_var=LD_LIBRARY_PATH # How should we handle SHLIB_PATH + shlibpath_overrides_runpath=yes # Unless +noenvvar is specified. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + sys_lib_search_path_spec="/usr/lib/pa20_64 /usr/ccs/lib/pa20_64" + sys_lib_dlsearch_path_spec=$sys_lib_search_path_spec + ;; + *) + shrext_cmds='.sl' + dynamic_linker="$host_os dld.sl" + shlibpath_var=SHLIB_PATH + shlibpath_overrides_runpath=no # +s is required to enable SHLIB_PATH + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + ;; + esac + # HP-UX runs *really* slowly unless shared libraries are mode 555, ... + postinstall_cmds='chmod 555 $lib' + # or fails outright, so override atomically: + install_override_mode=555 + ;; + +interix[3-9]*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + dynamic_linker='Interix 3.x ld.so.1 (PE, like ELF)' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + +irix5* | irix6* | nonstopux*) + case $host_os in + nonstopux*) version_type=nonstopux ;; + *) + if test "$lt_cv_prog_gnu_ld" = yes; then + version_type=linux # correct to gnu/linux during the next big refactor + else + version_type=irix + fi ;; + esac + need_lib_prefix=no + need_version=no + soname_spec='${libname}${release}${shared_ext}$major' + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major ${libname}${release}${shared_ext} $libname${shared_ext}' + case $host_os in + irix5* | nonstopux*) + libsuff= shlibsuff= + ;; + *) + case $LD in # libtool.m4 will add one of these switches to LD + *-32|*"-32 "|*-melf32bsmip|*"-melf32bsmip ") + libsuff= shlibsuff= libmagic=32-bit;; + *-n32|*"-n32 "|*-melf32bmipn32|*"-melf32bmipn32 ") + libsuff=32 shlibsuff=N32 libmagic=N32;; + *-64|*"-64 "|*-melf64bmip|*"-melf64bmip ") + libsuff=64 shlibsuff=64 libmagic=64-bit;; + *) libsuff= shlibsuff= libmagic=never-match;; + esac + ;; + esac + shlibpath_var=LD_LIBRARY${shlibsuff}_PATH + shlibpath_overrides_runpath=no + sys_lib_search_path_spec="/usr/lib${libsuff} /lib${libsuff} /usr/local/lib${libsuff}" + sys_lib_dlsearch_path_spec="/usr/lib${libsuff} /lib${libsuff}" + hardcode_into_libs=yes + ;; + +# No shared lib support for Linux oldld, aout, or coff. +linux*oldld* | linux*aout* | linux*coff*) + dynamic_linker=no + ;; + +# This must be glibc/ELF. +linux* | k*bsd*-gnu | kopensolaris*-gnu) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + finish_cmds='PATH="\$PATH:/sbin" ldconfig -n $libdir' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + + # Some binutils ld are patched to set DT_RUNPATH + if ${lt_cv_shlibpath_overrides_runpath+:} false; then : + $as_echo_n "(cached) " >&6 +else + lt_cv_shlibpath_overrides_runpath=no + save_LDFLAGS=$LDFLAGS + save_libdir=$libdir + eval "libdir=/foo; wl=\"$lt_prog_compiler_wl_CXX\"; \ + LDFLAGS=\"\$LDFLAGS $hardcode_libdir_flag_spec_CXX\"" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_cxx_try_link "$LINENO"; then : + if ($OBJDUMP -p conftest$ac_exeext) 2>/dev/null | grep "RUNPATH.*$libdir" >/dev/null; then : + lt_cv_shlibpath_overrides_runpath=yes +fi +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext + LDFLAGS=$save_LDFLAGS + libdir=$save_libdir + +fi + + shlibpath_overrides_runpath=$lt_cv_shlibpath_overrides_runpath + + # This implies no fast_install, which is unacceptable. + # Some rework will be needed to allow for fast_install + # before this can be enabled. + hardcode_into_libs=yes + + # Append ld.so.conf contents to the search path + if test -f /etc/ld.so.conf; then + lt_ld_extra=`awk '/^include / { system(sprintf("cd /etc; cat %s 2>/dev/null", \$2)); skip = 1; } { if (!skip) print \$0; skip = 0; }' < /etc/ld.so.conf | $SED -e 's/#.*//;/^[ ]*hwcap[ ]/d;s/[:, ]/ /g;s/=[^=]*$//;s/=[^= ]* / /g;s/"//g;/^$/d' | tr '\n' ' '` + sys_lib_dlsearch_path_spec="/lib /usr/lib $lt_ld_extra" + fi + + # We used to test for /lib/ld.so.1 and disable shared libraries on + # powerpc, because MkLinux only supported shared libraries with the + # GNU dynamic linker. Since this was broken with cross compilers, + # most powerpc-linux boxes support dynamic linking these days and + # people can always --disable-shared, the test was removed, and we + # assume the GNU/Linux dynamic linker is in use. + dynamic_linker='GNU/Linux ld.so' + ;; + +netbsd*) + version_type=sunos + need_lib_prefix=no + need_version=no + if echo __ELF__ | $CC -E - | $GREP __ELF__ >/dev/null; then + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${shared_ext}$versuffix' + finish_cmds='PATH="\$PATH:/sbin" ldconfig -m $libdir' + dynamic_linker='NetBSD (a.out) ld.so' + else + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + dynamic_linker='NetBSD ld.elf_so' + fi + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + ;; + +newsos6) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + ;; + +*nto* | *qnx*) + version_type=qnx + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + dynamic_linker='ldqnx.so' + ;; + +openbsd*) + version_type=sunos + sys_lib_dlsearch_path_spec="/usr/lib" + need_lib_prefix=no + # Some older versions of OpenBSD (3.3 at least) *do* need versioned libs. + case $host_os in + openbsd3.3 | openbsd3.3.*) need_version=yes ;; + *) need_version=no ;; + esac + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${shared_ext}$versuffix' + finish_cmds='PATH="\$PATH:/sbin" ldconfig -m $libdir' + shlibpath_var=LD_LIBRARY_PATH + if test -z "`echo __ELF__ | $CC -E - | $GREP __ELF__`" || test "$host_os-$host_cpu" = "openbsd2.8-powerpc"; then + case $host_os in + openbsd2.[89] | openbsd2.[89].*) + shlibpath_overrides_runpath=no + ;; + *) + shlibpath_overrides_runpath=yes + ;; + esac + else + shlibpath_overrides_runpath=yes + fi + ;; + +os2*) + libname_spec='$name' + shrext_cmds=".dll" + need_lib_prefix=no + library_names_spec='$libname${shared_ext} $libname.a' + dynamic_linker='OS/2 ld.exe' + shlibpath_var=LIBPATH + ;; + +osf3* | osf4* | osf5*) + version_type=osf + need_lib_prefix=no + need_version=no + soname_spec='${libname}${release}${shared_ext}$major' + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + sys_lib_search_path_spec="/usr/shlib /usr/ccs/lib /usr/lib/cmplrs/cc /usr/lib /usr/local/lib /var/shlib" + sys_lib_dlsearch_path_spec="$sys_lib_search_path_spec" + ;; + +rdos*) + dynamic_linker=no + ;; + +solaris*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + # ldd complains unless libraries are executable + postinstall_cmds='chmod +x $lib' + ;; + +sunos4*) + version_type=sunos + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${shared_ext}$versuffix' + finish_cmds='PATH="\$PATH:/usr/etc" ldconfig $libdir' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + if test "$with_gnu_ld" = yes; then + need_lib_prefix=no + fi + need_version=yes + ;; + +sysv4 | sysv4.3*) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + case $host_vendor in + sni) + shlibpath_overrides_runpath=no + need_lib_prefix=no + runpath_var=LD_RUN_PATH + ;; + siemens) + need_lib_prefix=no + ;; + motorola) + need_lib_prefix=no + need_version=no + shlibpath_overrides_runpath=no + sys_lib_search_path_spec='/lib /usr/lib /usr/ccs/lib' + ;; + esac + ;; + +sysv4*MP*) + if test -d /usr/nec ;then + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='$libname${shared_ext}.$versuffix $libname${shared_ext}.$major $libname${shared_ext}' + soname_spec='$libname${shared_ext}.$major' + shlibpath_var=LD_LIBRARY_PATH + fi + ;; + +sysv5* | sco3.2v5* | sco5v6* | unixware* | OpenUNIX* | sysv4*uw2*) + version_type=freebsd-elf + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext} $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + if test "$with_gnu_ld" = yes; then + sys_lib_search_path_spec='/usr/local/lib /usr/gnu/lib /usr/ccs/lib /usr/lib /lib' + else + sys_lib_search_path_spec='/usr/ccs/lib /usr/lib' + case $host_os in + sco3.2v5*) + sys_lib_search_path_spec="$sys_lib_search_path_spec /lib" + ;; + esac + fi + sys_lib_dlsearch_path_spec='/usr/lib' + ;; + +tpf*) + # TPF is a cross-target only. Preferred cross-host = GNU/Linux. + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + +uts4*) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + ;; + +*) + dynamic_linker=no + ;; +esac +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $dynamic_linker" >&5 +$as_echo "$dynamic_linker" >&6; } +test "$dynamic_linker" = no && can_build_shared=no + +variables_saved_for_relink="PATH $shlibpath_var $runpath_var" +if test "$GCC" = yes; then + variables_saved_for_relink="$variables_saved_for_relink GCC_EXEC_PREFIX COMPILER_PATH LIBRARY_PATH" +fi + +if test "${lt_cv_sys_lib_search_path_spec+set}" = set; then + sys_lib_search_path_spec="$lt_cv_sys_lib_search_path_spec" +fi +if test "${lt_cv_sys_lib_dlsearch_path_spec+set}" = set; then + sys_lib_dlsearch_path_spec="$lt_cv_sys_lib_dlsearch_path_spec" +fi + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + { $as_echo "$as_me:${as_lineno-$LINENO}: checking how to hardcode library paths into programs" >&5 +$as_echo_n "checking how to hardcode library paths into programs... " >&6; } +hardcode_action_CXX= +if test -n "$hardcode_libdir_flag_spec_CXX" || + test -n "$runpath_var_CXX" || + test "X$hardcode_automatic_CXX" = "Xyes" ; then + + # We can hardcode non-existent directories. + if test "$hardcode_direct_CXX" != no && + # If the only mechanism to avoid hardcoding is shlibpath_var, we + # have to relink, otherwise we might link with an installed library + # when we should be linking with a yet-to-be-installed one + ## test "$_LT_TAGVAR(hardcode_shlibpath_var, CXX)" != no && + test "$hardcode_minus_L_CXX" != no; then + # Linking always hardcodes the temporary library directory. + hardcode_action_CXX=relink + else + # We can link without hardcoding, and we can hardcode nonexisting dirs. + hardcode_action_CXX=immediate + fi +else + # We cannot hardcode anything, or else we can only hardcode existing + # directories. + hardcode_action_CXX=unsupported +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $hardcode_action_CXX" >&5 +$as_echo "$hardcode_action_CXX" >&6; } + +if test "$hardcode_action_CXX" = relink || + test "$inherit_rpath_CXX" = yes; then + # Fast installation is not supported + enable_fast_install=no +elif test "$shlibpath_overrides_runpath" = yes || + test "$enable_shared" = no; then + # Fast installation is not necessary + enable_fast_install=needless +fi + + + + + + + + fi # test -n "$compiler" + + CC=$lt_save_CC + CFLAGS=$lt_save_CFLAGS + LDCXX=$LD + LD=$lt_save_LD + GCC=$lt_save_GCC + with_gnu_ld=$lt_save_with_gnu_ld + lt_cv_path_LDCXX=$lt_cv_path_LD + lt_cv_path_LD=$lt_save_path_LD + lt_cv_prog_gnu_ldcxx=$lt_cv_prog_gnu_ld + lt_cv_prog_gnu_ld=$lt_save_with_gnu_ld +fi # test "$_lt_caught_CXX_error" != yes + +ac_ext=c +ac_cpp='$CPP $CPPFLAGS' +ac_compile='$CC -c $CFLAGS $CPPFLAGS conftest.$ac_ext >&5' +ac_link='$CC -o conftest$ac_exeext $CFLAGS $CPPFLAGS $LDFLAGS conftest.$ac_ext $LIBS >&5' +ac_compiler_gnu=$ac_cv_c_compiler_gnu + + +enable_win32_dll=yes + +case $host in +*-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-cegcc*) + if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}as", so it can be a program name with args. +set dummy ${ac_tool_prefix}as; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_AS+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$AS"; then + ac_cv_prog_AS="$AS" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_AS="${ac_tool_prefix}as" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +AS=$ac_cv_prog_AS +if test -n "$AS"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $AS" >&5 +$as_echo "$AS" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_AS"; then + ac_ct_AS=$AS + # Extract the first word of "as", so it can be a program name with args. +set dummy as; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_AS+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_AS"; then + ac_cv_prog_ac_ct_AS="$ac_ct_AS" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_AS="as" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_AS=$ac_cv_prog_ac_ct_AS +if test -n "$ac_ct_AS"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_AS" >&5 +$as_echo "$ac_ct_AS" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_AS" = x; then + AS="false" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + AS=$ac_ct_AS + fi +else + AS="$ac_cv_prog_AS" +fi + + if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}dlltool", so it can be a program name with args. +set dummy ${ac_tool_prefix}dlltool; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_DLLTOOL+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$DLLTOOL"; then + ac_cv_prog_DLLTOOL="$DLLTOOL" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_DLLTOOL="${ac_tool_prefix}dlltool" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +DLLTOOL=$ac_cv_prog_DLLTOOL +if test -n "$DLLTOOL"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $DLLTOOL" >&5 +$as_echo "$DLLTOOL" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_DLLTOOL"; then + ac_ct_DLLTOOL=$DLLTOOL + # Extract the first word of "dlltool", so it can be a program name with args. +set dummy dlltool; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_DLLTOOL+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_DLLTOOL"; then + ac_cv_prog_ac_ct_DLLTOOL="$ac_ct_DLLTOOL" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_DLLTOOL="dlltool" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_DLLTOOL=$ac_cv_prog_ac_ct_DLLTOOL +if test -n "$ac_ct_DLLTOOL"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_DLLTOOL" >&5 +$as_echo "$ac_ct_DLLTOOL" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_DLLTOOL" = x; then + DLLTOOL="false" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + DLLTOOL=$ac_ct_DLLTOOL + fi +else + DLLTOOL="$ac_cv_prog_DLLTOOL" +fi + + if test -n "$ac_tool_prefix"; then + # Extract the first word of "${ac_tool_prefix}objdump", so it can be a program name with args. +set dummy ${ac_tool_prefix}objdump; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_OBJDUMP+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$OBJDUMP"; then + ac_cv_prog_OBJDUMP="$OBJDUMP" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_OBJDUMP="${ac_tool_prefix}objdump" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +OBJDUMP=$ac_cv_prog_OBJDUMP +if test -n "$OBJDUMP"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $OBJDUMP" >&5 +$as_echo "$OBJDUMP" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + +fi +if test -z "$ac_cv_prog_OBJDUMP"; then + ac_ct_OBJDUMP=$OBJDUMP + # Extract the first word of "objdump", so it can be a program name with args. +set dummy objdump; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_ac_ct_OBJDUMP+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$ac_ct_OBJDUMP"; then + ac_cv_prog_ac_ct_OBJDUMP="$ac_ct_OBJDUMP" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_ac_ct_OBJDUMP="objdump" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +ac_ct_OBJDUMP=$ac_cv_prog_ac_ct_OBJDUMP +if test -n "$ac_ct_OBJDUMP"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_ct_OBJDUMP" >&5 +$as_echo "$ac_ct_OBJDUMP" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + if test "x$ac_ct_OBJDUMP" = x; then + OBJDUMP="false" + else + case $cross_compiling:$ac_tool_warned in +yes:) +{ $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: using cross tools not prefixed with host triplet" >&5 +$as_echo "$as_me: WARNING: using cross tools not prefixed with host triplet" >&2;} +ac_tool_warned=yes ;; +esac + OBJDUMP=$ac_ct_OBJDUMP + fi +else + OBJDUMP="$ac_cv_prog_OBJDUMP" +fi + + ;; +esac + +test -z "$AS" && AS=as + + + + + +test -z "$DLLTOOL" && DLLTOOL=dlltool + + +test -z "$OBJDUMP" && OBJDUMP=objdump + + + + + + +for ac_prog in flex lex +do + # Extract the first word of "$ac_prog", so it can be a program name with args. +set dummy $ac_prog; ac_word=$2 +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for $ac_word" >&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_LEX+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$LEX"; then + ac_cv_prog_LEX="$LEX" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_LEX="$ac_prog" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +LEX=$ac_cv_prog_LEX +if test -n "$LEX"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $LEX" >&5 +$as_echo "$LEX" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + test -n "$LEX" && break +done +test -n "$LEX" || LEX=":" + +if test "x$LEX" != "x:"; then + cat >conftest.l <<_ACEOF +%% +a { ECHO; } +b { REJECT; } +c { yymore (); } +d { yyless (1); } +e { yyless (input () != 0); } +f { unput (yytext[0]); } +. { BEGIN INITIAL; } +%% +#ifdef YYTEXT_POINTER +extern char *yytext; +#endif +int +main (void) +{ + return ! yylex () + ! yywrap (); +} +_ACEOF +{ { ac_try="$LEX conftest.l" +case "(($ac_try" in + *\"* | *\`* | *\\*) ac_try_echo=\$ac_try;; + *) ac_try_echo=$ac_try;; +esac +eval ac_try_echo="\"\$as_me:${as_lineno-$LINENO}: $ac_try_echo\"" +$as_echo "$ac_try_echo"; } >&5 + (eval "$LEX conftest.l") 2>&5 + ac_status=$? + $as_echo "$as_me:${as_lineno-$LINENO}: \$? = $ac_status" >&5 + test $ac_status = 0; } +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking lex output file root" >&5 +$as_echo_n "checking lex output file root... " >&6; } +if ${ac_cv_prog_lex_root+:} false; then : + $as_echo_n "(cached) " >&6 +else + +if test -f lex.yy.c; then + ac_cv_prog_lex_root=lex.yy +elif test -f lexyy.c; then + ac_cv_prog_lex_root=lexyy +else + as_fn_error $? "cannot find output from $LEX; giving up" "$LINENO" 5 +fi +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_lex_root" >&5 +$as_echo "$ac_cv_prog_lex_root" >&6; } +LEX_OUTPUT_ROOT=$ac_cv_prog_lex_root + +if test -z "${LEXLIB+set}"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: checking lex library" >&5 +$as_echo_n "checking lex library... " >&6; } +if ${ac_cv_lib_lex+:} false; then : + $as_echo_n "(cached) " >&6 +else + + ac_save_LIBS=$LIBS + ac_cv_lib_lex='none needed' + for ac_lib in '' -lfl -ll; do + LIBS="$ac_lib $ac_save_LIBS" + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +`cat $LEX_OUTPUT_ROOT.c` +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + ac_cv_lib_lex=$ac_lib +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext + test "$ac_cv_lib_lex" != 'none needed' && break + done + LIBS=$ac_save_LIBS + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_lib_lex" >&5 +$as_echo "$ac_cv_lib_lex" >&6; } + test "$ac_cv_lib_lex" != 'none needed' && LEXLIB=$ac_cv_lib_lex +fi + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking whether yytext is a pointer" >&5 +$as_echo_n "checking whether yytext is a pointer... " >&6; } +if ${ac_cv_prog_lex_yytext_pointer+:} false; then : + $as_echo_n "(cached) " >&6 +else + # POSIX says lex can declare yytext either as a pointer or an array; the +# default is implementation-dependent. Figure out which it is, since +# not all implementations provide the %pointer and %array declarations. +ac_cv_prog_lex_yytext_pointer=no +ac_save_LIBS=$LIBS +LIBS="$LEXLIB $ac_save_LIBS" +cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + + #define YYTEXT_POINTER 1 +`cat $LEX_OUTPUT_ROOT.c` +_ACEOF +if ac_fn_c_try_link "$LINENO"; then : + ac_cv_prog_lex_yytext_pointer=yes +fi +rm -f core conftest.err conftest.$ac_objext \ + conftest$ac_exeext conftest.$ac_ext +LIBS=$ac_save_LIBS + +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_prog_lex_yytext_pointer" >&5 +$as_echo "$ac_cv_prog_lex_yytext_pointer" >&6; } +if test $ac_cv_prog_lex_yytext_pointer = yes; then + +$as_echo "#define YYTEXT_POINTER 1" >>confdefs.h + +fi +rm -f conftest.l $LEX_OUTPUT_ROOT.c + +fi +if test "$LEX" = :; then + LEX=${am_missing_run}flex +fi +if test Z"$LEX" != Zflex; then +cat <&5 +$as_echo_n "checking for $ac_word... " >&6; } +if ${ac_cv_prog_YACC+:} false; then : + $as_echo_n "(cached) " >&6 +else + if test -n "$YACC"; then + ac_cv_prog_YACC="$YACC" # Let the user override the test. +else +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for ac_exec_ext in '' $ac_executable_extensions; do + if { test -f "$as_dir/$ac_word$ac_exec_ext" && $as_test_x "$as_dir/$ac_word$ac_exec_ext"; }; then + ac_cv_prog_YACC="$ac_prog" + $as_echo "$as_me:${as_lineno-$LINENO}: found $as_dir/$ac_word$ac_exec_ext" >&5 + break 2 + fi +done + done +IFS=$as_save_IFS + +fi +fi +YACC=$ac_cv_prog_YACC +if test -n "$YACC"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: result: $YACC" >&5 +$as_echo "$YACC" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: no" >&5 +$as_echo "no" >&6; } +fi + + + test -n "$YACC" && break +done +test -n "$YACC" || YACC="yacc" + +if test Z"$YACC" != "Zbison -y"; then +cat <&5 +$as_echo_n "checking for compiler switch to enable full C/C++ warnings... " >&6; }; + + +case "${CC}" in + +gcc) + warn_c_sw="-Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter" + warn_cxx_sw="-Wall -Wshadow -Wextra -Wno-unused-parameter";; +*) + warn_cxx_sw="" + warn_c_sw="";; +esac + +if test -n "${warn_c_sw}"; +then + CFLAGS="${CFLAGS} ${warn_c_sw}"; + CXXFLAGS="${CXXFLAGS} ${warn_cxx_sw}"; + { $as_echo "$as_me:${as_lineno-$LINENO}: result: ${warn_c_sw}, ${warn_cxx_sw}" >&5 +$as_echo "${warn_c_sw}, ${warn_cxx_sw}" >&6; } +else + { $as_echo "$as_me:${as_lineno-$LINENO}: result: (cannot determine)" >&5 +$as_echo "(cannot determine)" >&6; } +fi; + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for ANSI C header files" >&5 +$as_echo_n "checking for ANSI C header files... " >&6; } +if ${ac_cv_header_stdc+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include +#include +#include +#include + +int +main () +{ + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + ac_cv_header_stdc=yes +else + ac_cv_header_stdc=no +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext + +if test $ac_cv_header_stdc = yes; then + # SunOS 4.x string.h does not declare mem*, contrary to ANSI. + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include + +_ACEOF +if (eval "$ac_cpp conftest.$ac_ext") 2>&5 | + $EGREP "memchr" >/dev/null 2>&1; then : + +else + ac_cv_header_stdc=no +fi +rm -f conftest* + +fi + +if test $ac_cv_header_stdc = yes; then + # ISC 2.0.2 stdlib.h does not declare free, contrary to ANSI. + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include + +_ACEOF +if (eval "$ac_cpp conftest.$ac_ext") 2>&5 | + $EGREP "free" >/dev/null 2>&1; then : + +else + ac_cv_header_stdc=no +fi +rm -f conftest* + +fi + +if test $ac_cv_header_stdc = yes; then + # /bin/cc in Irix-4.0.5 gets non-ANSI ctype macros unless using -ansi. + if test "$cross_compiling" = yes; then : + : +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ +#include +#include +#if ((' ' & 0x0FF) == 0x020) +# define ISLOWER(c) ('a' <= (c) && (c) <= 'z') +# define TOUPPER(c) (ISLOWER(c) ? 'A' + ((c) - 'a') : (c)) +#else +# define ISLOWER(c) \ + (('a' <= (c) && (c) <= 'i') \ + || ('j' <= (c) && (c) <= 'r') \ + || ('s' <= (c) && (c) <= 'z')) +# define TOUPPER(c) (ISLOWER(c) ? ((c) | 0x40) : (c)) +#endif + +#define XOR(e, f) (((e) && !(f)) || (!(e) && (f))) +int +main () +{ + int i; + for (i = 0; i < 256; i++) + if (XOR (islower (i), ISLOWER (i)) + || toupper (i) != TOUPPER (i)) + return 2; + return 0; +} +_ACEOF +if ac_fn_c_try_run "$LINENO"; then : + +else + ac_cv_header_stdc=no +fi +rm -f core *.core core.conftest.* gmon.out bb.out conftest$ac_exeext \ + conftest.$ac_objext conftest.beam conftest.$ac_ext +fi + +fi +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_header_stdc" >&5 +$as_echo "$ac_cv_header_stdc" >&6; } +if test $ac_cv_header_stdc = yes; then + +$as_echo "#define STDC_HEADERS 1" >>confdefs.h + +fi + +for ac_header in unistd.h stdint.h xlocale.h +do : + as_ac_Header=`$as_echo "ac_cv_header_$ac_header" | $as_tr_sh` +ac_fn_c_check_header_mongrel "$LINENO" "$ac_header" "$as_ac_Header" "$ac_includes_default" +if eval test \"x\$"$as_ac_Header"\" = x"yes"; then : + cat >>confdefs.h <<_ACEOF +#define `$as_echo "HAVE_$ac_header" | $as_tr_cpp` 1 +_ACEOF + +fi + +done + + +{ $as_echo "$as_me:${as_lineno-$LINENO}: checking for an ANSI C-conforming const" >&5 +$as_echo_n "checking for an ANSI C-conforming const... " >&6; } +if ${ac_cv_c_const+:} false; then : + $as_echo_n "(cached) " >&6 +else + cat confdefs.h - <<_ACEOF >conftest.$ac_ext +/* end confdefs.h. */ + +int +main () +{ +/* FIXME: Include the comments suggested by Paul. */ +#ifndef __cplusplus + /* Ultrix mips cc rejects this. */ + typedef int charset[2]; + const charset cs; + /* SunOS 4.1.1 cc rejects this. */ + char const *const *pcpcc; + char **ppc; + /* NEC SVR4.0.2 mips cc rejects this. */ + struct point {int x, y;}; + static struct point const zero = {0,0}; + /* AIX XL C 1.02.0.0 rejects this. + It does not let you subtract one const X* pointer from another in + an arm of an if-expression whose if-part is not a constant + expression */ + const char *g = "string"; + pcpcc = &g + (g ? g-g : 0); + /* HPUX 7.0 cc rejects these. */ + ++pcpcc; + ppc = (char**) pcpcc; + pcpcc = (char const *const *) ppc; + { /* SCO 3.2v4 cc rejects this. */ + char *t; + char const *s = 0 ? (char *) 0 : (char const *) 0; + + *t++ = 0; + if (s) return 0; + } + { /* Someone thinks the Sun supposedly-ANSI compiler will reject this. */ + int x[] = {25, 17}; + const int *foo = &x[0]; + ++foo; + } + { /* Sun SC1.0 ANSI compiler rejects this -- but not the above. */ + typedef const int *iptr; + iptr p = 0; + ++p; + } + { /* AIX XL C 1.02.0.0 rejects this saying + "k.c", line 2.27: 1506-025 (S) Operand must be a modifiable lvalue. */ + struct s { int j; const int *ap[3]; }; + struct s *b; b->j = 5; + } + { /* ULTRIX-32 V3.1 (Rev 9) vcc rejects this */ + const int foo = 10; + if (!foo) return 0; + } + return !cs[0] && !zero.x; +#endif + + ; + return 0; +} +_ACEOF +if ac_fn_c_try_compile "$LINENO"; then : + ac_cv_c_const=yes +else + ac_cv_c_const=no +fi +rm -f core conftest.err conftest.$ac_objext conftest.$ac_ext +fi +{ $as_echo "$as_me:${as_lineno-$LINENO}: result: $ac_cv_c_const" >&5 +$as_echo "$ac_cv_c_const" >&6; } +if test $ac_cv_c_const = no; then + +$as_echo "#define const /**/" >>confdefs.h + +fi + + + +for ac_func in newlocale uselocale freelocale +do : + as_ac_var=`$as_echo "ac_cv_func_$ac_func" | $as_tr_sh` +ac_fn_c_check_func "$LINENO" "$ac_func" "$as_ac_var" +if eval test \"x\$"$as_ac_var"\" = x"yes"; then : + cat >>confdefs.h <<_ACEOF +#define `$as_echo "HAVE_$ac_func" | $as_tr_cpp` 1 +_ACEOF + +fi +done + + + +docxx=yes + +# Check whether --enable-cxx was given. +if test "${enable_cxx+set}" = set; then : + enableval=$enable_cxx; if test "$enableval" = "no"; then docxx="no"; fi +else + +docxx=yes + + +fi + + + if test x$docxx = xyes; then + BUILDCXX_TRUE= + BUILDCXX_FALSE='#' +else + BUILDCXX_TRUE='#' + BUILDCXX_FALSE= +fi + + +doexamples=yes + +# Check whether --enable-examples was given. +if test "${enable_examples+set}" = set; then : + enableval=$enable_examples; if test "$enableval" = "no"; then doexamples="no"; fi +else + +doexamples=yes + + +fi + + + if test x$doexamples = xyes; then + BUILDEXAMPLES_TRUE= + BUILDEXAMPLES_FALSE='#' +else + BUILDEXAMPLES_TRUE='#' + BUILDEXAMPLES_FALSE= +fi + + + +case "$target" in + *-*-cygwin* | *-*-mingw*) + gnuwin=yes;; +esac + + if test x$gnuwin = xyes; then + GNU_WIN_TRUE= + GNU_WIN_FALSE='#' +else + GNU_WIN_TRUE='#' + GNU_WIN_FALSE= +fi + + + +ac_config_files="$ac_config_files Makefile lib/Makefile lib/libconfig.pc lib/libconfig++.pc doc/Makefile examples/Makefile examples/c/Makefile examples/c++/Makefile tinytest/Makefile tests/Makefile libconfig.spec" + +cat >confcache <<\_ACEOF +# This file is a shell script that caches the results of configure +# tests run on this system so they can be shared between configure +# scripts and configure runs, see configure's option --config-cache. +# It is not useful on other systems. If it contains results you don't +# want to keep, you may remove or edit it. +# +# config.status only pays attention to the cache file if you give it +# the --recheck option to rerun configure. +# +# `ac_cv_env_foo' variables (set or unset) will be overridden when +# loading this file, other *unset* `ac_cv_foo' will be assigned the +# following values. + +_ACEOF + +# The following way of writing the cache mishandles newlines in values, +# but we know of no workaround that is simple, portable, and efficient. +# So, we kill variables containing newlines. +# Ultrix sh set writes to stderr and can't be redirected directly, +# and sets the high bit in the cache file unless we assign to the vars. +( + for ac_var in `(set) 2>&1 | sed -n 's/^\([a-zA-Z_][a-zA-Z0-9_]*\)=.*/\1/p'`; do + eval ac_val=\$$ac_var + case $ac_val in #( + *${as_nl}*) + case $ac_var in #( + *_cv_*) { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: cache variable $ac_var contains a newline" >&5 +$as_echo "$as_me: WARNING: cache variable $ac_var contains a newline" >&2;} ;; + esac + case $ac_var in #( + _ | IFS | as_nl) ;; #( + BASH_ARGV | BASH_SOURCE) eval $ac_var= ;; #( + *) { eval $ac_var=; unset $ac_var;} ;; + esac ;; + esac + done + + (set) 2>&1 | + case $as_nl`(ac_space=' '; set) 2>&1` in #( + *${as_nl}ac_space=\ *) + # `set' does not quote correctly, so add quotes: double-quote + # substitution turns \\\\ into \\, and sed turns \\ into \. + sed -n \ + "s/'/'\\\\''/g; + s/^\\([_$as_cr_alnum]*_cv_[_$as_cr_alnum]*\\)=\\(.*\\)/\\1='\\2'/p" + ;; #( + *) + # `set' quotes correctly as required by POSIX, so do not add quotes. + sed -n "/^[_$as_cr_alnum]*_cv_[_$as_cr_alnum]*=/p" + ;; + esac | + sort +) | + sed ' + /^ac_cv_env_/b end + t clear + :clear + s/^\([^=]*\)=\(.*[{}].*\)$/test "${\1+set}" = set || &/ + t end + s/^\([^=]*\)=\(.*\)$/\1=${\1=\2}/ + :end' >>confcache +if diff "$cache_file" confcache >/dev/null 2>&1; then :; else + if test -w "$cache_file"; then + if test "x$cache_file" != "x/dev/null"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: updating cache $cache_file" >&5 +$as_echo "$as_me: updating cache $cache_file" >&6;} + if test ! -f "$cache_file" || test -h "$cache_file"; then + cat confcache >"$cache_file" + else + case $cache_file in #( + */* | ?:*) + mv -f confcache "$cache_file"$$ && + mv -f "$cache_file"$$ "$cache_file" ;; #( + *) + mv -f confcache "$cache_file" ;; + esac + fi + fi + else + { $as_echo "$as_me:${as_lineno-$LINENO}: not updating unwritable cache $cache_file" >&5 +$as_echo "$as_me: not updating unwritable cache $cache_file" >&6;} + fi +fi +rm -f confcache + +test "x$prefix" = xNONE && prefix=$ac_default_prefix +# Let make expand exec_prefix. +test "x$exec_prefix" = xNONE && exec_prefix='${prefix}' + +DEFS=-DHAVE_CONFIG_H + +ac_libobjs= +ac_ltlibobjs= +U= +for ac_i in : $LIBOBJS; do test "x$ac_i" = x: && continue + # 1. Remove the extension, and $U if already installed. + ac_script='s/\$U\././;s/\.o$//;s/\.obj$//' + ac_i=`$as_echo "$ac_i" | sed "$ac_script"` + # 2. Prepend LIBOBJDIR. When used with automake>=1.10 LIBOBJDIR + # will be set to the directory where LIBOBJS objects are built. + as_fn_append ac_libobjs " \${LIBOBJDIR}$ac_i\$U.$ac_objext" + as_fn_append ac_ltlibobjs " \${LIBOBJDIR}$ac_i"'$U.lo' +done +LIBOBJS=$ac_libobjs + +LTLIBOBJS=$ac_ltlibobjs + + + if test -n "$EXEEXT"; then + am__EXEEXT_TRUE= + am__EXEEXT_FALSE='#' +else + am__EXEEXT_TRUE='#' + am__EXEEXT_FALSE= +fi + +if test -z "${AMDEP_TRUE}" && test -z "${AMDEP_FALSE}"; then + as_fn_error $? "conditional \"AMDEP\" was never defined. +Usually this means the macro was only invoked conditionally." "$LINENO" 5 +fi +if test -z "${am__fastdepCC_TRUE}" && test -z "${am__fastdepCC_FALSE}"; then + as_fn_error $? "conditional \"am__fastdepCC\" was never defined. +Usually this means the macro was only invoked conditionally." "$LINENO" 5 +fi +if test -z "${am__fastdepCC_TRUE}" && test -z "${am__fastdepCC_FALSE}"; then + as_fn_error $? "conditional \"am__fastdepCC\" was never defined. +Usually this means the macro was only invoked conditionally." "$LINENO" 5 +fi +if test -z "${am__fastdepCXX_TRUE}" && test -z "${am__fastdepCXX_FALSE}"; then + as_fn_error $? "conditional \"am__fastdepCXX\" was never defined. +Usually this means the macro was only invoked conditionally." "$LINENO" 5 +fi +if test -z "${BUILDCXX_TRUE}" && test -z "${BUILDCXX_FALSE}"; then + as_fn_error $? "conditional \"BUILDCXX\" was never defined. +Usually this means the macro was only invoked conditionally." "$LINENO" 5 +fi +if test -z "${BUILDEXAMPLES_TRUE}" && test -z "${BUILDEXAMPLES_FALSE}"; then + as_fn_error $? "conditional \"BUILDEXAMPLES\" was never defined. +Usually this means the macro was only invoked conditionally." "$LINENO" 5 +fi +if test -z "${GNU_WIN_TRUE}" && test -z "${GNU_WIN_FALSE}"; then + as_fn_error $? "conditional \"GNU_WIN\" was never defined. +Usually this means the macro was only invoked conditionally." "$LINENO" 5 +fi + +: "${CONFIG_STATUS=./config.status}" +ac_write_fail=0 +ac_clean_files_save=$ac_clean_files +ac_clean_files="$ac_clean_files $CONFIG_STATUS" +{ $as_echo "$as_me:${as_lineno-$LINENO}: creating $CONFIG_STATUS" >&5 +$as_echo "$as_me: creating $CONFIG_STATUS" >&6;} +as_write_fail=0 +cat >$CONFIG_STATUS <<_ASEOF || as_write_fail=1 +#! $SHELL +# Generated by $as_me. +# Run this file to recreate the current configuration. +# Compiler output produced by configure, useful for debugging +# configure, is in config.log if it exists. + +debug=false +ac_cs_recheck=false +ac_cs_silent=false + +SHELL=\${CONFIG_SHELL-$SHELL} +export SHELL +_ASEOF +cat >>$CONFIG_STATUS <<\_ASEOF || as_write_fail=1 +## -------------------- ## +## M4sh Initialization. ## +## -------------------- ## + +# Be more Bourne compatible +DUALCASE=1; export DUALCASE # for MKS sh +if test -n "${ZSH_VERSION+set}" && (emulate sh) >/dev/null 2>&1; then : + emulate sh + NULLCMD=: + # Pre-4.2 versions of Zsh do word splitting on ${1+"$@"}, which + # is contrary to our usage. Disable this feature. + alias -g '${1+"$@"}'='"$@"' + setopt NO_GLOB_SUBST +else + case `(set -o) 2>/dev/null` in #( + *posix*) : + set -o posix ;; #( + *) : + ;; +esac +fi + + +as_nl=' +' +export as_nl +# Printing a long string crashes Solaris 7 /usr/bin/printf. +as_echo='\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\' +as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo +as_echo=$as_echo$as_echo$as_echo$as_echo$as_echo$as_echo +# Prefer a ksh shell builtin over an external printf program on Solaris, +# but without wasting forks for bash or zsh. +if test -z "$BASH_VERSION$ZSH_VERSION" \ + && (test "X`print -r -- $as_echo`" = "X$as_echo") 2>/dev/null; then + as_echo='print -r --' + as_echo_n='print -rn --' +elif (test "X`printf %s $as_echo`" = "X$as_echo") 2>/dev/null; then + as_echo='printf %s\n' + as_echo_n='printf %s' +else + if test "X`(/usr/ucb/echo -n -n $as_echo) 2>/dev/null`" = "X-n $as_echo"; then + as_echo_body='eval /usr/ucb/echo -n "$1$as_nl"' + as_echo_n='/usr/ucb/echo -n' + else + as_echo_body='eval expr "X$1" : "X\\(.*\\)"' + as_echo_n_body='eval + arg=$1; + case $arg in #( + *"$as_nl"*) + expr "X$arg" : "X\\(.*\\)$as_nl"; + arg=`expr "X$arg" : ".*$as_nl\\(.*\\)"`;; + esac; + expr "X$arg" : "X\\(.*\\)" | tr -d "$as_nl" + ' + export as_echo_n_body + as_echo_n='sh -c $as_echo_n_body as_echo' + fi + export as_echo_body + as_echo='sh -c $as_echo_body as_echo' +fi + +# The user is always right. +if test "${PATH_SEPARATOR+set}" != set; then + PATH_SEPARATOR=: + (PATH='/bin;/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 && { + (PATH='/bin:/bin'; FPATH=$PATH; sh -c :) >/dev/null 2>&1 || + PATH_SEPARATOR=';' + } +fi + + +# IFS +# We need space, tab and new line, in precisely that order. Quoting is +# there to prevent editors from complaining about space-tab. +# (If _AS_PATH_WALK were called with IFS unset, it would disable word +# splitting by setting IFS to empty value.) +IFS=" "" $as_nl" + +# Find who we are. Look in the path if we contain no directory separator. +as_myself= +case $0 in #(( + *[\\/]* ) as_myself=$0 ;; + *) as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + test -r "$as_dir/$0" && as_myself=$as_dir/$0 && break + done +IFS=$as_save_IFS + + ;; +esac +# We did not find ourselves, most probably we were run as `sh COMMAND' +# in which case we are not to be found in the path. +if test "x$as_myself" = x; then + as_myself=$0 +fi +if test ! -f "$as_myself"; then + $as_echo "$as_myself: error: cannot find myself; rerun with an absolute file name" >&2 + exit 1 +fi + +# Unset variables that we do not need and which cause bugs (e.g. in +# pre-3.0 UWIN ksh). But do not cause bugs in bash 2.01; the "|| exit 1" +# suppresses any "Segmentation fault" message there. '((' could +# trigger a bug in pdksh 5.2.14. +for as_var in BASH_ENV ENV MAIL MAILPATH +do eval test x\${$as_var+set} = xset \ + && ( (unset $as_var) || exit 1) >/dev/null 2>&1 && unset $as_var || : +done +PS1='$ ' +PS2='> ' +PS4='+ ' + +# NLS nuisances. +LC_ALL=C +export LC_ALL +LANGUAGE=C +export LANGUAGE + +# CDPATH. +(unset CDPATH) >/dev/null 2>&1 && unset CDPATH + + +# as_fn_error STATUS ERROR [LINENO LOG_FD] +# ---------------------------------------- +# Output "`basename $0`: error: ERROR" to stderr. If LINENO and LOG_FD are +# provided, also output the error to LOG_FD, referencing LINENO. Then exit the +# script with STATUS, using 1 if that was 0. +as_fn_error () +{ + as_status=$1; test $as_status -eq 0 && as_status=1 + if test "$4"; then + as_lineno=${as_lineno-"$3"} as_lineno_stack=as_lineno_stack=$as_lineno_stack + $as_echo "$as_me:${as_lineno-$LINENO}: error: $2" >&$4 + fi + $as_echo "$as_me: error: $2" >&2 + as_fn_exit $as_status +} # as_fn_error + + +# as_fn_set_status STATUS +# ----------------------- +# Set $? to STATUS, without forking. +as_fn_set_status () +{ + return $1 +} # as_fn_set_status + +# as_fn_exit STATUS +# ----------------- +# Exit the shell with STATUS, even in a "trap 0" or "set -e" context. +as_fn_exit () +{ + set +e + as_fn_set_status $1 + exit $1 +} # as_fn_exit + +# as_fn_unset VAR +# --------------- +# Portably unset VAR. +as_fn_unset () +{ + { eval $1=; unset $1;} +} +as_unset=as_fn_unset +# as_fn_append VAR VALUE +# ---------------------- +# Append the text in VALUE to the end of the definition contained in VAR. Take +# advantage of any shell optimizations that allow amortized linear growth over +# repeated appends, instead of the typical quadratic growth present in naive +# implementations. +if (eval "as_var=1; as_var+=2; test x\$as_var = x12") 2>/dev/null; then : + eval 'as_fn_append () + { + eval $1+=\$2 + }' +else + as_fn_append () + { + eval $1=\$$1\$2 + } +fi # as_fn_append + +# as_fn_arith ARG... +# ------------------ +# Perform arithmetic evaluation on the ARGs, and store the result in the +# global $as_val. Take advantage of shells that can avoid forks. The arguments +# must be portable across $(()) and expr. +if (eval "test \$(( 1 + 1 )) = 2") 2>/dev/null; then : + eval 'as_fn_arith () + { + as_val=$(( $* )) + }' +else + as_fn_arith () + { + as_val=`expr "$@" || test $? -eq 1` + } +fi # as_fn_arith + + +if expr a : '\(a\)' >/dev/null 2>&1 && + test "X`expr 00001 : '.*\(...\)'`" = X001; then + as_expr=expr +else + as_expr=false +fi + +if (basename -- /) >/dev/null 2>&1 && test "X`basename -- / 2>&1`" = "X/"; then + as_basename=basename +else + as_basename=false +fi + +if (as_dir=`dirname -- /` && test "X$as_dir" = X/) >/dev/null 2>&1; then + as_dirname=dirname +else + as_dirname=false +fi + +as_me=`$as_basename -- "$0" || +$as_expr X/"$0" : '.*/\([^/][^/]*\)/*$' \| \ + X"$0" : 'X\(//\)$' \| \ + X"$0" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X/"$0" | + sed '/^.*\/\([^/][^/]*\)\/*$/{ + s//\1/ + q + } + /^X\/\(\/\/\)$/{ + s//\1/ + q + } + /^X\/\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'` + +# Avoid depending upon Character Ranges. +as_cr_letters='abcdefghijklmnopqrstuvwxyz' +as_cr_LETTERS='ABCDEFGHIJKLMNOPQRSTUVWXYZ' +as_cr_Letters=$as_cr_letters$as_cr_LETTERS +as_cr_digits='0123456789' +as_cr_alnum=$as_cr_Letters$as_cr_digits + +ECHO_C= ECHO_N= ECHO_T= +case `echo -n x` in #((((( +-n*) + case `echo 'xy\c'` in + *c*) ECHO_T=' ';; # ECHO_T is single tab character. + xy) ECHO_C='\c';; + *) echo `echo ksh88 bug on AIX 6.1` > /dev/null + ECHO_T=' ';; + esac;; +*) + ECHO_N='-n';; +esac + +rm -f conf$$ conf$$.exe conf$$.file +if test -d conf$$.dir; then + rm -f conf$$.dir/conf$$.file +else + rm -f conf$$.dir + mkdir conf$$.dir 2>/dev/null +fi +if (echo >conf$$.file) 2>/dev/null; then + if ln -s conf$$.file conf$$ 2>/dev/null; then + as_ln_s='ln -s' + # ... but there are two gotchas: + # 1) On MSYS, both `ln -s file dir' and `ln file dir' fail. + # 2) DJGPP < 2.04 has no symlinks; `ln -s' creates a wrapper executable. + # In both cases, we have to default to `cp -p'. + ln -s conf$$.file conf$$.dir 2>/dev/null && test ! -f conf$$.exe || + as_ln_s='cp -p' + elif ln conf$$.file conf$$ 2>/dev/null; then + as_ln_s=ln + else + as_ln_s='cp -p' + fi +else + as_ln_s='cp -p' +fi +rm -f conf$$ conf$$.exe conf$$.dir/conf$$.file conf$$.file +rmdir conf$$.dir 2>/dev/null + + +# as_fn_mkdir_p +# ------------- +# Create "$as_dir" as a directory, including parents if necessary. +as_fn_mkdir_p () +{ + + case $as_dir in #( + -*) as_dir=./$as_dir;; + esac + test -d "$as_dir" || eval $as_mkdir_p || { + as_dirs= + while :; do + case $as_dir in #( + *\'*) as_qdir=`$as_echo "$as_dir" | sed "s/'/'\\\\\\\\''/g"`;; #'( + *) as_qdir=$as_dir;; + esac + as_dirs="'$as_qdir' $as_dirs" + as_dir=`$as_dirname -- "$as_dir" || +$as_expr X"$as_dir" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ + X"$as_dir" : 'X\(//\)[^/]' \| \ + X"$as_dir" : 'X\(//\)$' \| \ + X"$as_dir" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X"$as_dir" | + sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ + s//\1/ + q + } + /^X\(\/\/\)[^/].*/{ + s//\1/ + q + } + /^X\(\/\/\)$/{ + s//\1/ + q + } + /^X\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'` + test -d "$as_dir" && break + done + test -z "$as_dirs" || eval "mkdir $as_dirs" + } || test -d "$as_dir" || as_fn_error $? "cannot create directory $as_dir" + + +} # as_fn_mkdir_p +if mkdir -p . 2>/dev/null; then + as_mkdir_p='mkdir -p "$as_dir"' +else + test -d ./-p && rmdir ./-p + as_mkdir_p=false +fi + +if test -x / >/dev/null 2>&1; then + as_test_x='test -x' +else + if ls -dL / >/dev/null 2>&1; then + as_ls_L_option=L + else + as_ls_L_option= + fi + as_test_x=' + eval sh -c '\'' + if test -d "$1"; then + test -d "$1/."; + else + case $1 in #( + -*)set "./$1";; + esac; + case `ls -ld'$as_ls_L_option' "$1" 2>/dev/null` in #(( + ???[sx]*):;;*)false;;esac;fi + '\'' sh + ' +fi +as_executable_p=$as_test_x + +# Sed expression to map a string onto a valid CPP name. +as_tr_cpp="eval sed 'y%*$as_cr_letters%P$as_cr_LETTERS%;s%[^_$as_cr_alnum]%_%g'" + +# Sed expression to map a string onto a valid variable name. +as_tr_sh="eval sed 'y%*+%pp%;s%[^_$as_cr_alnum]%_%g'" + + +exec 6>&1 +## ----------------------------------- ## +## Main body of $CONFIG_STATUS script. ## +## ----------------------------------- ## +_ASEOF +test $as_write_fail = 0 && chmod +x $CONFIG_STATUS || ac_write_fail=1 + +cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 +# Save the log message, to keep $0 and so on meaningful, and to +# report actual input values of CONFIG_FILES etc. instead of their +# values after options handling. +ac_log=" +This file was extended by libconfig $as_me 1.4.9, which was +generated by GNU Autoconf 2.68. Invocation command line was + + CONFIG_FILES = $CONFIG_FILES + CONFIG_HEADERS = $CONFIG_HEADERS + CONFIG_LINKS = $CONFIG_LINKS + CONFIG_COMMANDS = $CONFIG_COMMANDS + $ $0 $@ + +on `(hostname || uname -n) 2>/dev/null | sed 1q` +" + +_ACEOF + +case $ac_config_files in *" +"*) set x $ac_config_files; shift; ac_config_files=$*;; +esac + +case $ac_config_headers in *" +"*) set x $ac_config_headers; shift; ac_config_headers=$*;; +esac + + +cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 +# Files that config.status was made for. +config_files="$ac_config_files" +config_headers="$ac_config_headers" +config_commands="$ac_config_commands" + +_ACEOF + +cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 +ac_cs_usage="\ +\`$as_me' instantiates files and other configuration actions +from templates according to the current configuration. Unless the files +and actions are specified as TAGs, all are instantiated by default. + +Usage: $0 [OPTION]... [TAG]... + + -h, --help print this help, then exit + -V, --version print version number and configuration settings, then exit + --config print configuration, then exit + -q, --quiet, --silent + do not print progress messages + -d, --debug don't remove temporary files + --recheck update $as_me by reconfiguring in the same conditions + --file=FILE[:TEMPLATE] + instantiate the configuration file FILE + --header=FILE[:TEMPLATE] + instantiate the configuration header FILE + +Configuration files: +$config_files + +Configuration headers: +$config_headers + +Configuration commands: +$config_commands + +Report bugs to . +libconfig home page: ." + +_ACEOF +cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 +ac_cs_config="`$as_echo "$ac_configure_args" | sed 's/^ //; s/[\\""\`\$]/\\\\&/g'`" +ac_cs_version="\\ +libconfig config.status 1.4.9 +configured by $0, generated by GNU Autoconf 2.68, + with options \\"\$ac_cs_config\\" + +Copyright (C) 2010 Free Software Foundation, Inc. +This config.status script is free software; the Free Software Foundation +gives unlimited permission to copy, distribute and modify it." + +ac_pwd='$ac_pwd' +srcdir='$srcdir' +INSTALL='$INSTALL' +MKDIR_P='$MKDIR_P' +AWK='$AWK' +test -n "\$AWK" || AWK=awk +_ACEOF + +cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 +# The default lists apply if the user does not specify any file. +ac_need_defaults=: +while test $# != 0 +do + case $1 in + --*=?*) + ac_option=`expr "X$1" : 'X\([^=]*\)='` + ac_optarg=`expr "X$1" : 'X[^=]*=\(.*\)'` + ac_shift=: + ;; + --*=) + ac_option=`expr "X$1" : 'X\([^=]*\)='` + ac_optarg= + ac_shift=: + ;; + *) + ac_option=$1 + ac_optarg=$2 + ac_shift=shift + ;; + esac + + case $ac_option in + # Handling of the options. + -recheck | --recheck | --rechec | --reche | --rech | --rec | --re | --r) + ac_cs_recheck=: ;; + --version | --versio | --versi | --vers | --ver | --ve | --v | -V ) + $as_echo "$ac_cs_version"; exit ;; + --config | --confi | --conf | --con | --co | --c ) + $as_echo "$ac_cs_config"; exit ;; + --debug | --debu | --deb | --de | --d | -d ) + debug=: ;; + --file | --fil | --fi | --f ) + $ac_shift + case $ac_optarg in + *\'*) ac_optarg=`$as_echo "$ac_optarg" | sed "s/'/'\\\\\\\\''/g"` ;; + '') as_fn_error $? "missing file argument" ;; + esac + as_fn_append CONFIG_FILES " '$ac_optarg'" + ac_need_defaults=false;; + --header | --heade | --head | --hea ) + $ac_shift + case $ac_optarg in + *\'*) ac_optarg=`$as_echo "$ac_optarg" | sed "s/'/'\\\\\\\\''/g"` ;; + esac + as_fn_append CONFIG_HEADERS " '$ac_optarg'" + ac_need_defaults=false;; + --he | --h) + # Conflict between --help and --header + as_fn_error $? "ambiguous option: \`$1' +Try \`$0 --help' for more information.";; + --help | --hel | -h ) + $as_echo "$ac_cs_usage"; exit ;; + -q | -quiet | --quiet | --quie | --qui | --qu | --q \ + | -silent | --silent | --silen | --sile | --sil | --si | --s) + ac_cs_silent=: ;; + + # This is an error. + -*) as_fn_error $? "unrecognized option: \`$1' +Try \`$0 --help' for more information." ;; + + *) as_fn_append ac_config_targets " $1" + ac_need_defaults=false ;; + + esac + shift +done + +ac_configure_extra_args= + +if $ac_cs_silent; then + exec 6>/dev/null + ac_configure_extra_args="$ac_configure_extra_args --silent" +fi + +_ACEOF +cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 +if \$ac_cs_recheck; then + set X '$SHELL' '$0' $ac_configure_args \$ac_configure_extra_args --no-create --no-recursion + shift + \$as_echo "running CONFIG_SHELL=$SHELL \$*" >&6 + CONFIG_SHELL='$SHELL' + export CONFIG_SHELL + exec "\$@" +fi + +_ACEOF +cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 +exec 5>>config.log +{ + echo + sed 'h;s/./-/g;s/^.../## /;s/...$/ ##/;p;x;p;x' <<_ASBOX +## Running $as_me. ## +_ASBOX + $as_echo "$ac_log" +} >&5 + +_ACEOF +cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 +# +# INIT-COMMANDS +# +AMDEP_TRUE="$AMDEP_TRUE" ac_aux_dir="$ac_aux_dir" + + +# The HP-UX ksh and POSIX shell print the target directory to stdout +# if CDPATH is set. +(unset CDPATH) >/dev/null 2>&1 && unset CDPATH + +sed_quote_subst='$sed_quote_subst' +double_quote_subst='$double_quote_subst' +delay_variable_subst='$delay_variable_subst' +macro_version='`$ECHO "$macro_version" | $SED "$delay_single_quote_subst"`' +macro_revision='`$ECHO "$macro_revision" | $SED "$delay_single_quote_subst"`' +enable_shared='`$ECHO "$enable_shared" | $SED "$delay_single_quote_subst"`' +enable_static='`$ECHO "$enable_static" | $SED "$delay_single_quote_subst"`' +pic_mode='`$ECHO "$pic_mode" | $SED "$delay_single_quote_subst"`' +enable_fast_install='`$ECHO "$enable_fast_install" | $SED "$delay_single_quote_subst"`' +SHELL='`$ECHO "$SHELL" | $SED "$delay_single_quote_subst"`' +ECHO='`$ECHO "$ECHO" | $SED "$delay_single_quote_subst"`' +PATH_SEPARATOR='`$ECHO "$PATH_SEPARATOR" | $SED "$delay_single_quote_subst"`' +host_alias='`$ECHO "$host_alias" | $SED "$delay_single_quote_subst"`' +host='`$ECHO "$host" | $SED "$delay_single_quote_subst"`' +host_os='`$ECHO "$host_os" | $SED "$delay_single_quote_subst"`' +build_alias='`$ECHO "$build_alias" | $SED "$delay_single_quote_subst"`' +build='`$ECHO "$build" | $SED "$delay_single_quote_subst"`' +build_os='`$ECHO "$build_os" | $SED "$delay_single_quote_subst"`' +SED='`$ECHO "$SED" | $SED "$delay_single_quote_subst"`' +Xsed='`$ECHO "$Xsed" | $SED "$delay_single_quote_subst"`' +GREP='`$ECHO "$GREP" | $SED "$delay_single_quote_subst"`' +EGREP='`$ECHO "$EGREP" | $SED "$delay_single_quote_subst"`' +FGREP='`$ECHO "$FGREP" | $SED "$delay_single_quote_subst"`' +LD='`$ECHO "$LD" | $SED "$delay_single_quote_subst"`' +NM='`$ECHO "$NM" | $SED "$delay_single_quote_subst"`' +LN_S='`$ECHO "$LN_S" | $SED "$delay_single_quote_subst"`' +max_cmd_len='`$ECHO "$max_cmd_len" | $SED "$delay_single_quote_subst"`' +ac_objext='`$ECHO "$ac_objext" | $SED "$delay_single_quote_subst"`' +exeext='`$ECHO "$exeext" | $SED "$delay_single_quote_subst"`' +lt_unset='`$ECHO "$lt_unset" | $SED "$delay_single_quote_subst"`' +lt_SP2NL='`$ECHO "$lt_SP2NL" | $SED "$delay_single_quote_subst"`' +lt_NL2SP='`$ECHO "$lt_NL2SP" | $SED "$delay_single_quote_subst"`' +lt_cv_to_host_file_cmd='`$ECHO "$lt_cv_to_host_file_cmd" | $SED "$delay_single_quote_subst"`' +lt_cv_to_tool_file_cmd='`$ECHO "$lt_cv_to_tool_file_cmd" | $SED "$delay_single_quote_subst"`' +reload_flag='`$ECHO "$reload_flag" | $SED "$delay_single_quote_subst"`' +reload_cmds='`$ECHO "$reload_cmds" | $SED "$delay_single_quote_subst"`' +OBJDUMP='`$ECHO "$OBJDUMP" | $SED "$delay_single_quote_subst"`' +deplibs_check_method='`$ECHO "$deplibs_check_method" | $SED "$delay_single_quote_subst"`' +file_magic_cmd='`$ECHO "$file_magic_cmd" | $SED "$delay_single_quote_subst"`' +file_magic_glob='`$ECHO "$file_magic_glob" | $SED "$delay_single_quote_subst"`' +want_nocaseglob='`$ECHO "$want_nocaseglob" | $SED "$delay_single_quote_subst"`' +DLLTOOL='`$ECHO "$DLLTOOL" | $SED "$delay_single_quote_subst"`' +sharedlib_from_linklib_cmd='`$ECHO "$sharedlib_from_linklib_cmd" | $SED "$delay_single_quote_subst"`' +AR='`$ECHO "$AR" | $SED "$delay_single_quote_subst"`' +AR_FLAGS='`$ECHO "$AR_FLAGS" | $SED "$delay_single_quote_subst"`' +archiver_list_spec='`$ECHO "$archiver_list_spec" | $SED "$delay_single_quote_subst"`' +STRIP='`$ECHO "$STRIP" | $SED "$delay_single_quote_subst"`' +RANLIB='`$ECHO "$RANLIB" | $SED "$delay_single_quote_subst"`' +old_postinstall_cmds='`$ECHO "$old_postinstall_cmds" | $SED "$delay_single_quote_subst"`' +old_postuninstall_cmds='`$ECHO "$old_postuninstall_cmds" | $SED "$delay_single_quote_subst"`' +old_archive_cmds='`$ECHO "$old_archive_cmds" | $SED "$delay_single_quote_subst"`' +lock_old_archive_extraction='`$ECHO "$lock_old_archive_extraction" | $SED "$delay_single_quote_subst"`' +CC='`$ECHO "$CC" | $SED "$delay_single_quote_subst"`' +CFLAGS='`$ECHO "$CFLAGS" | $SED "$delay_single_quote_subst"`' +compiler='`$ECHO "$compiler" | $SED "$delay_single_quote_subst"`' +GCC='`$ECHO "$GCC" | $SED "$delay_single_quote_subst"`' +lt_cv_sys_global_symbol_pipe='`$ECHO "$lt_cv_sys_global_symbol_pipe" | $SED "$delay_single_quote_subst"`' +lt_cv_sys_global_symbol_to_cdecl='`$ECHO "$lt_cv_sys_global_symbol_to_cdecl" | $SED "$delay_single_quote_subst"`' +lt_cv_sys_global_symbol_to_c_name_address='`$ECHO "$lt_cv_sys_global_symbol_to_c_name_address" | $SED "$delay_single_quote_subst"`' +lt_cv_sys_global_symbol_to_c_name_address_lib_prefix='`$ECHO "$lt_cv_sys_global_symbol_to_c_name_address_lib_prefix" | $SED "$delay_single_quote_subst"`' +nm_file_list_spec='`$ECHO "$nm_file_list_spec" | $SED "$delay_single_quote_subst"`' +lt_sysroot='`$ECHO "$lt_sysroot" | $SED "$delay_single_quote_subst"`' +objdir='`$ECHO "$objdir" | $SED "$delay_single_quote_subst"`' +MAGIC_CMD='`$ECHO "$MAGIC_CMD" | $SED "$delay_single_quote_subst"`' +lt_prog_compiler_no_builtin_flag='`$ECHO "$lt_prog_compiler_no_builtin_flag" | $SED "$delay_single_quote_subst"`' +lt_prog_compiler_pic='`$ECHO "$lt_prog_compiler_pic" | $SED "$delay_single_quote_subst"`' +lt_prog_compiler_wl='`$ECHO "$lt_prog_compiler_wl" | $SED "$delay_single_quote_subst"`' +lt_prog_compiler_static='`$ECHO "$lt_prog_compiler_static" | $SED "$delay_single_quote_subst"`' +lt_cv_prog_compiler_c_o='`$ECHO "$lt_cv_prog_compiler_c_o" | $SED "$delay_single_quote_subst"`' +need_locks='`$ECHO "$need_locks" | $SED "$delay_single_quote_subst"`' +MANIFEST_TOOL='`$ECHO "$MANIFEST_TOOL" | $SED "$delay_single_quote_subst"`' +DSYMUTIL='`$ECHO "$DSYMUTIL" | $SED "$delay_single_quote_subst"`' +NMEDIT='`$ECHO "$NMEDIT" | $SED "$delay_single_quote_subst"`' +LIPO='`$ECHO "$LIPO" | $SED "$delay_single_quote_subst"`' +OTOOL='`$ECHO "$OTOOL" | $SED "$delay_single_quote_subst"`' +OTOOL64='`$ECHO "$OTOOL64" | $SED "$delay_single_quote_subst"`' +libext='`$ECHO "$libext" | $SED "$delay_single_quote_subst"`' +shrext_cmds='`$ECHO "$shrext_cmds" | $SED "$delay_single_quote_subst"`' +extract_expsyms_cmds='`$ECHO "$extract_expsyms_cmds" | $SED "$delay_single_quote_subst"`' +archive_cmds_need_lc='`$ECHO "$archive_cmds_need_lc" | $SED "$delay_single_quote_subst"`' +enable_shared_with_static_runtimes='`$ECHO "$enable_shared_with_static_runtimes" | $SED "$delay_single_quote_subst"`' +export_dynamic_flag_spec='`$ECHO "$export_dynamic_flag_spec" | $SED "$delay_single_quote_subst"`' +whole_archive_flag_spec='`$ECHO "$whole_archive_flag_spec" | $SED "$delay_single_quote_subst"`' +compiler_needs_object='`$ECHO "$compiler_needs_object" | $SED "$delay_single_quote_subst"`' +old_archive_from_new_cmds='`$ECHO "$old_archive_from_new_cmds" | $SED "$delay_single_quote_subst"`' +old_archive_from_expsyms_cmds='`$ECHO "$old_archive_from_expsyms_cmds" | $SED "$delay_single_quote_subst"`' +archive_cmds='`$ECHO "$archive_cmds" | $SED "$delay_single_quote_subst"`' +archive_expsym_cmds='`$ECHO "$archive_expsym_cmds" | $SED "$delay_single_quote_subst"`' +module_cmds='`$ECHO "$module_cmds" | $SED "$delay_single_quote_subst"`' +module_expsym_cmds='`$ECHO "$module_expsym_cmds" | $SED "$delay_single_quote_subst"`' +with_gnu_ld='`$ECHO "$with_gnu_ld" | $SED "$delay_single_quote_subst"`' +allow_undefined_flag='`$ECHO "$allow_undefined_flag" | $SED "$delay_single_quote_subst"`' +no_undefined_flag='`$ECHO "$no_undefined_flag" | $SED "$delay_single_quote_subst"`' +hardcode_libdir_flag_spec='`$ECHO "$hardcode_libdir_flag_spec" | $SED "$delay_single_quote_subst"`' +hardcode_libdir_separator='`$ECHO "$hardcode_libdir_separator" | $SED "$delay_single_quote_subst"`' +hardcode_direct='`$ECHO "$hardcode_direct" | $SED "$delay_single_quote_subst"`' +hardcode_direct_absolute='`$ECHO "$hardcode_direct_absolute" | $SED "$delay_single_quote_subst"`' +hardcode_minus_L='`$ECHO "$hardcode_minus_L" | $SED "$delay_single_quote_subst"`' +hardcode_shlibpath_var='`$ECHO "$hardcode_shlibpath_var" | $SED "$delay_single_quote_subst"`' +hardcode_automatic='`$ECHO "$hardcode_automatic" | $SED "$delay_single_quote_subst"`' +inherit_rpath='`$ECHO "$inherit_rpath" | $SED "$delay_single_quote_subst"`' +link_all_deplibs='`$ECHO "$link_all_deplibs" | $SED "$delay_single_quote_subst"`' +always_export_symbols='`$ECHO "$always_export_symbols" | $SED "$delay_single_quote_subst"`' +export_symbols_cmds='`$ECHO "$export_symbols_cmds" | $SED "$delay_single_quote_subst"`' +exclude_expsyms='`$ECHO "$exclude_expsyms" | $SED "$delay_single_quote_subst"`' +include_expsyms='`$ECHO "$include_expsyms" | $SED "$delay_single_quote_subst"`' +prelink_cmds='`$ECHO "$prelink_cmds" | $SED "$delay_single_quote_subst"`' +postlink_cmds='`$ECHO "$postlink_cmds" | $SED "$delay_single_quote_subst"`' +file_list_spec='`$ECHO "$file_list_spec" | $SED "$delay_single_quote_subst"`' +variables_saved_for_relink='`$ECHO "$variables_saved_for_relink" | $SED "$delay_single_quote_subst"`' +need_lib_prefix='`$ECHO "$need_lib_prefix" | $SED "$delay_single_quote_subst"`' +need_version='`$ECHO "$need_version" | $SED "$delay_single_quote_subst"`' +version_type='`$ECHO "$version_type" | $SED "$delay_single_quote_subst"`' +runpath_var='`$ECHO "$runpath_var" | $SED "$delay_single_quote_subst"`' +shlibpath_var='`$ECHO "$shlibpath_var" | $SED "$delay_single_quote_subst"`' +shlibpath_overrides_runpath='`$ECHO "$shlibpath_overrides_runpath" | $SED "$delay_single_quote_subst"`' +libname_spec='`$ECHO "$libname_spec" | $SED "$delay_single_quote_subst"`' +library_names_spec='`$ECHO "$library_names_spec" | $SED "$delay_single_quote_subst"`' +soname_spec='`$ECHO "$soname_spec" | $SED "$delay_single_quote_subst"`' +install_override_mode='`$ECHO "$install_override_mode" | $SED "$delay_single_quote_subst"`' +postinstall_cmds='`$ECHO "$postinstall_cmds" | $SED "$delay_single_quote_subst"`' +postuninstall_cmds='`$ECHO "$postuninstall_cmds" | $SED "$delay_single_quote_subst"`' +finish_cmds='`$ECHO "$finish_cmds" | $SED "$delay_single_quote_subst"`' +finish_eval='`$ECHO "$finish_eval" | $SED "$delay_single_quote_subst"`' +hardcode_into_libs='`$ECHO "$hardcode_into_libs" | $SED "$delay_single_quote_subst"`' +sys_lib_search_path_spec='`$ECHO "$sys_lib_search_path_spec" | $SED "$delay_single_quote_subst"`' +sys_lib_dlsearch_path_spec='`$ECHO "$sys_lib_dlsearch_path_spec" | $SED "$delay_single_quote_subst"`' +hardcode_action='`$ECHO "$hardcode_action" | $SED "$delay_single_quote_subst"`' +enable_dlopen='`$ECHO "$enable_dlopen" | $SED "$delay_single_quote_subst"`' +enable_dlopen_self='`$ECHO "$enable_dlopen_self" | $SED "$delay_single_quote_subst"`' +enable_dlopen_self_static='`$ECHO "$enable_dlopen_self_static" | $SED "$delay_single_quote_subst"`' +old_striplib='`$ECHO "$old_striplib" | $SED "$delay_single_quote_subst"`' +striplib='`$ECHO "$striplib" | $SED "$delay_single_quote_subst"`' +compiler_lib_search_dirs='`$ECHO "$compiler_lib_search_dirs" | $SED "$delay_single_quote_subst"`' +predep_objects='`$ECHO "$predep_objects" | $SED "$delay_single_quote_subst"`' +postdep_objects='`$ECHO "$postdep_objects" | $SED "$delay_single_quote_subst"`' +predeps='`$ECHO "$predeps" | $SED "$delay_single_quote_subst"`' +postdeps='`$ECHO "$postdeps" | $SED "$delay_single_quote_subst"`' +compiler_lib_search_path='`$ECHO "$compiler_lib_search_path" | $SED "$delay_single_quote_subst"`' +AS='`$ECHO "$AS" | $SED "$delay_single_quote_subst"`' +LD_CXX='`$ECHO "$LD_CXX" | $SED "$delay_single_quote_subst"`' +reload_flag_CXX='`$ECHO "$reload_flag_CXX" | $SED "$delay_single_quote_subst"`' +reload_cmds_CXX='`$ECHO "$reload_cmds_CXX" | $SED "$delay_single_quote_subst"`' +old_archive_cmds_CXX='`$ECHO "$old_archive_cmds_CXX" | $SED "$delay_single_quote_subst"`' +compiler_CXX='`$ECHO "$compiler_CXX" | $SED "$delay_single_quote_subst"`' +GCC_CXX='`$ECHO "$GCC_CXX" | $SED "$delay_single_quote_subst"`' +lt_prog_compiler_no_builtin_flag_CXX='`$ECHO "$lt_prog_compiler_no_builtin_flag_CXX" | $SED "$delay_single_quote_subst"`' +lt_prog_compiler_pic_CXX='`$ECHO "$lt_prog_compiler_pic_CXX" | $SED "$delay_single_quote_subst"`' +lt_prog_compiler_wl_CXX='`$ECHO "$lt_prog_compiler_wl_CXX" | $SED "$delay_single_quote_subst"`' +lt_prog_compiler_static_CXX='`$ECHO "$lt_prog_compiler_static_CXX" | $SED "$delay_single_quote_subst"`' +lt_cv_prog_compiler_c_o_CXX='`$ECHO "$lt_cv_prog_compiler_c_o_CXX" | $SED "$delay_single_quote_subst"`' +archive_cmds_need_lc_CXX='`$ECHO "$archive_cmds_need_lc_CXX" | $SED "$delay_single_quote_subst"`' +enable_shared_with_static_runtimes_CXX='`$ECHO "$enable_shared_with_static_runtimes_CXX" | $SED "$delay_single_quote_subst"`' +export_dynamic_flag_spec_CXX='`$ECHO "$export_dynamic_flag_spec_CXX" | $SED "$delay_single_quote_subst"`' +whole_archive_flag_spec_CXX='`$ECHO "$whole_archive_flag_spec_CXX" | $SED "$delay_single_quote_subst"`' +compiler_needs_object_CXX='`$ECHO "$compiler_needs_object_CXX" | $SED "$delay_single_quote_subst"`' +old_archive_from_new_cmds_CXX='`$ECHO "$old_archive_from_new_cmds_CXX" | $SED "$delay_single_quote_subst"`' +old_archive_from_expsyms_cmds_CXX='`$ECHO "$old_archive_from_expsyms_cmds_CXX" | $SED "$delay_single_quote_subst"`' +archive_cmds_CXX='`$ECHO "$archive_cmds_CXX" | $SED "$delay_single_quote_subst"`' +archive_expsym_cmds_CXX='`$ECHO "$archive_expsym_cmds_CXX" | $SED "$delay_single_quote_subst"`' +module_cmds_CXX='`$ECHO "$module_cmds_CXX" | $SED "$delay_single_quote_subst"`' +module_expsym_cmds_CXX='`$ECHO "$module_expsym_cmds_CXX" | $SED "$delay_single_quote_subst"`' +with_gnu_ld_CXX='`$ECHO "$with_gnu_ld_CXX" | $SED "$delay_single_quote_subst"`' +allow_undefined_flag_CXX='`$ECHO "$allow_undefined_flag_CXX" | $SED "$delay_single_quote_subst"`' +no_undefined_flag_CXX='`$ECHO "$no_undefined_flag_CXX" | $SED "$delay_single_quote_subst"`' +hardcode_libdir_flag_spec_CXX='`$ECHO "$hardcode_libdir_flag_spec_CXX" | $SED "$delay_single_quote_subst"`' +hardcode_libdir_separator_CXX='`$ECHO "$hardcode_libdir_separator_CXX" | $SED "$delay_single_quote_subst"`' +hardcode_direct_CXX='`$ECHO "$hardcode_direct_CXX" | $SED "$delay_single_quote_subst"`' +hardcode_direct_absolute_CXX='`$ECHO "$hardcode_direct_absolute_CXX" | $SED "$delay_single_quote_subst"`' +hardcode_minus_L_CXX='`$ECHO "$hardcode_minus_L_CXX" | $SED "$delay_single_quote_subst"`' +hardcode_shlibpath_var_CXX='`$ECHO "$hardcode_shlibpath_var_CXX" | $SED "$delay_single_quote_subst"`' +hardcode_automatic_CXX='`$ECHO "$hardcode_automatic_CXX" | $SED "$delay_single_quote_subst"`' +inherit_rpath_CXX='`$ECHO "$inherit_rpath_CXX" | $SED "$delay_single_quote_subst"`' +link_all_deplibs_CXX='`$ECHO "$link_all_deplibs_CXX" | $SED "$delay_single_quote_subst"`' +always_export_symbols_CXX='`$ECHO "$always_export_symbols_CXX" | $SED "$delay_single_quote_subst"`' +export_symbols_cmds_CXX='`$ECHO "$export_symbols_cmds_CXX" | $SED "$delay_single_quote_subst"`' +exclude_expsyms_CXX='`$ECHO "$exclude_expsyms_CXX" | $SED "$delay_single_quote_subst"`' +include_expsyms_CXX='`$ECHO "$include_expsyms_CXX" | $SED "$delay_single_quote_subst"`' +prelink_cmds_CXX='`$ECHO "$prelink_cmds_CXX" | $SED "$delay_single_quote_subst"`' +postlink_cmds_CXX='`$ECHO "$postlink_cmds_CXX" | $SED "$delay_single_quote_subst"`' +file_list_spec_CXX='`$ECHO "$file_list_spec_CXX" | $SED "$delay_single_quote_subst"`' +hardcode_action_CXX='`$ECHO "$hardcode_action_CXX" | $SED "$delay_single_quote_subst"`' +compiler_lib_search_dirs_CXX='`$ECHO "$compiler_lib_search_dirs_CXX" | $SED "$delay_single_quote_subst"`' +predep_objects_CXX='`$ECHO "$predep_objects_CXX" | $SED "$delay_single_quote_subst"`' +postdep_objects_CXX='`$ECHO "$postdep_objects_CXX" | $SED "$delay_single_quote_subst"`' +predeps_CXX='`$ECHO "$predeps_CXX" | $SED "$delay_single_quote_subst"`' +postdeps_CXX='`$ECHO "$postdeps_CXX" | $SED "$delay_single_quote_subst"`' +compiler_lib_search_path_CXX='`$ECHO "$compiler_lib_search_path_CXX" | $SED "$delay_single_quote_subst"`' + +LTCC='$LTCC' +LTCFLAGS='$LTCFLAGS' +compiler='$compiler_DEFAULT' + +# A function that is used when there is no print builtin or printf. +func_fallback_echo () +{ + eval 'cat <<_LTECHO_EOF +\$1 +_LTECHO_EOF' +} + +# Quote evaled strings. +for var in SHELL \ +ECHO \ +PATH_SEPARATOR \ +SED \ +GREP \ +EGREP \ +FGREP \ +LD \ +NM \ +LN_S \ +lt_SP2NL \ +lt_NL2SP \ +reload_flag \ +OBJDUMP \ +deplibs_check_method \ +file_magic_cmd \ +file_magic_glob \ +want_nocaseglob \ +DLLTOOL \ +sharedlib_from_linklib_cmd \ +AR \ +AR_FLAGS \ +archiver_list_spec \ +STRIP \ +RANLIB \ +CC \ +CFLAGS \ +compiler \ +lt_cv_sys_global_symbol_pipe \ +lt_cv_sys_global_symbol_to_cdecl \ +lt_cv_sys_global_symbol_to_c_name_address \ +lt_cv_sys_global_symbol_to_c_name_address_lib_prefix \ +nm_file_list_spec \ +lt_prog_compiler_no_builtin_flag \ +lt_prog_compiler_pic \ +lt_prog_compiler_wl \ +lt_prog_compiler_static \ +lt_cv_prog_compiler_c_o \ +need_locks \ +MANIFEST_TOOL \ +DSYMUTIL \ +NMEDIT \ +LIPO \ +OTOOL \ +OTOOL64 \ +shrext_cmds \ +export_dynamic_flag_spec \ +whole_archive_flag_spec \ +compiler_needs_object \ +with_gnu_ld \ +allow_undefined_flag \ +no_undefined_flag \ +hardcode_libdir_flag_spec \ +hardcode_libdir_separator \ +exclude_expsyms \ +include_expsyms \ +file_list_spec \ +variables_saved_for_relink \ +libname_spec \ +library_names_spec \ +soname_spec \ +install_override_mode \ +finish_eval \ +old_striplib \ +striplib \ +compiler_lib_search_dirs \ +predep_objects \ +postdep_objects \ +predeps \ +postdeps \ +compiler_lib_search_path \ +AS \ +LD_CXX \ +reload_flag_CXX \ +compiler_CXX \ +lt_prog_compiler_no_builtin_flag_CXX \ +lt_prog_compiler_pic_CXX \ +lt_prog_compiler_wl_CXX \ +lt_prog_compiler_static_CXX \ +lt_cv_prog_compiler_c_o_CXX \ +export_dynamic_flag_spec_CXX \ +whole_archive_flag_spec_CXX \ +compiler_needs_object_CXX \ +with_gnu_ld_CXX \ +allow_undefined_flag_CXX \ +no_undefined_flag_CXX \ +hardcode_libdir_flag_spec_CXX \ +hardcode_libdir_separator_CXX \ +exclude_expsyms_CXX \ +include_expsyms_CXX \ +file_list_spec_CXX \ +compiler_lib_search_dirs_CXX \ +predep_objects_CXX \ +postdep_objects_CXX \ +predeps_CXX \ +postdeps_CXX \ +compiler_lib_search_path_CXX; do + case \`eval \\\\\$ECHO \\\\""\\\\\$\$var"\\\\"\` in + *[\\\\\\\`\\"\\\$]*) + eval "lt_\$var=\\\\\\"\\\`\\\$ECHO \\"\\\$\$var\\" | \\\$SED \\"\\\$sed_quote_subst\\"\\\`\\\\\\"" + ;; + *) + eval "lt_\$var=\\\\\\"\\\$\$var\\\\\\"" + ;; + esac +done + +# Double-quote double-evaled strings. +for var in reload_cmds \ +old_postinstall_cmds \ +old_postuninstall_cmds \ +old_archive_cmds \ +extract_expsyms_cmds \ +old_archive_from_new_cmds \ +old_archive_from_expsyms_cmds \ +archive_cmds \ +archive_expsym_cmds \ +module_cmds \ +module_expsym_cmds \ +export_symbols_cmds \ +prelink_cmds \ +postlink_cmds \ +postinstall_cmds \ +postuninstall_cmds \ +finish_cmds \ +sys_lib_search_path_spec \ +sys_lib_dlsearch_path_spec \ +reload_cmds_CXX \ +old_archive_cmds_CXX \ +old_archive_from_new_cmds_CXX \ +old_archive_from_expsyms_cmds_CXX \ +archive_cmds_CXX \ +archive_expsym_cmds_CXX \ +module_cmds_CXX \ +module_expsym_cmds_CXX \ +export_symbols_cmds_CXX \ +prelink_cmds_CXX \ +postlink_cmds_CXX; do + case \`eval \\\\\$ECHO \\\\""\\\\\$\$var"\\\\"\` in + *[\\\\\\\`\\"\\\$]*) + eval "lt_\$var=\\\\\\"\\\`\\\$ECHO \\"\\\$\$var\\" | \\\$SED -e \\"\\\$double_quote_subst\\" -e \\"\\\$sed_quote_subst\\" -e \\"\\\$delay_variable_subst\\"\\\`\\\\\\"" + ;; + *) + eval "lt_\$var=\\\\\\"\\\$\$var\\\\\\"" + ;; + esac +done + +ac_aux_dir='$ac_aux_dir' +xsi_shell='$xsi_shell' +lt_shell_append='$lt_shell_append' + +# See if we are running on zsh, and set the options which allow our +# commands through without removal of \ escapes INIT. +if test -n "\${ZSH_VERSION+set}" ; then + setopt NO_GLOB_SUBST +fi + + + PACKAGE='$PACKAGE' + VERSION='$VERSION' + TIMESTAMP='$TIMESTAMP' + RM='$RM' + ofile='$ofile' + + + + + + +_ACEOF + +cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 + +# Handling of arguments. +for ac_config_target in $ac_config_targets +do + case $ac_config_target in + "ac_config.h") CONFIG_HEADERS="$CONFIG_HEADERS ac_config.h" ;; + "depfiles") CONFIG_COMMANDS="$CONFIG_COMMANDS depfiles" ;; + "libtool") CONFIG_COMMANDS="$CONFIG_COMMANDS libtool" ;; + "Makefile") CONFIG_FILES="$CONFIG_FILES Makefile" ;; + "lib/Makefile") CONFIG_FILES="$CONFIG_FILES lib/Makefile" ;; + "lib/libconfig.pc") CONFIG_FILES="$CONFIG_FILES lib/libconfig.pc" ;; + "lib/libconfig++.pc") CONFIG_FILES="$CONFIG_FILES lib/libconfig++.pc" ;; + "doc/Makefile") CONFIG_FILES="$CONFIG_FILES doc/Makefile" ;; + "examples/Makefile") CONFIG_FILES="$CONFIG_FILES examples/Makefile" ;; + "examples/c/Makefile") CONFIG_FILES="$CONFIG_FILES examples/c/Makefile" ;; + "examples/c++/Makefile") CONFIG_FILES="$CONFIG_FILES examples/c++/Makefile" ;; + "tinytest/Makefile") CONFIG_FILES="$CONFIG_FILES tinytest/Makefile" ;; + "tests/Makefile") CONFIG_FILES="$CONFIG_FILES tests/Makefile" ;; + "libconfig.spec") CONFIG_FILES="$CONFIG_FILES libconfig.spec" ;; + + *) as_fn_error $? "invalid argument: \`$ac_config_target'" "$LINENO" 5;; + esac +done + + +# If the user did not use the arguments to specify the items to instantiate, +# then the envvar interface is used. Set only those that are not. +# We use the long form for the default assignment because of an extremely +# bizarre bug on SunOS 4.1.3. +if $ac_need_defaults; then + test "${CONFIG_FILES+set}" = set || CONFIG_FILES=$config_files + test "${CONFIG_HEADERS+set}" = set || CONFIG_HEADERS=$config_headers + test "${CONFIG_COMMANDS+set}" = set || CONFIG_COMMANDS=$config_commands +fi + +# Have a temporary directory for convenience. Make it in the build tree +# simply because there is no reason against having it here, and in addition, +# creating and moving files from /tmp can sometimes cause problems. +# Hook for its removal unless debugging. +# Note that there is a small window in which the directory will not be cleaned: +# after its creation but before its name has been assigned to `$tmp'. +$debug || +{ + tmp= ac_tmp= + trap 'exit_status=$? + : "${ac_tmp:=$tmp}" + { test ! -d "$ac_tmp" || rm -fr "$ac_tmp"; } && exit $exit_status +' 0 + trap 'as_fn_exit 1' 1 2 13 15 +} +# Create a (secure) tmp directory for tmp files. + +{ + tmp=`(umask 077 && mktemp -d "./confXXXXXX") 2>/dev/null` && + test -d "$tmp" +} || +{ + tmp=./conf$$-$RANDOM + (umask 077 && mkdir "$tmp") +} || as_fn_error $? "cannot create a temporary directory in ." "$LINENO" 5 +ac_tmp=$tmp + +# Set up the scripts for CONFIG_FILES section. +# No need to generate them if there are no CONFIG_FILES. +# This happens for instance with `./config.status config.h'. +if test -n "$CONFIG_FILES"; then + + +ac_cr=`echo X | tr X '\015'` +# On cygwin, bash can eat \r inside `` if the user requested igncr. +# But we know of no other shell where ac_cr would be empty at this +# point, so we can use a bashism as a fallback. +if test "x$ac_cr" = x; then + eval ac_cr=\$\'\\r\' +fi +ac_cs_awk_cr=`$AWK 'BEGIN { print "a\rb" }' /dev/null` +if test "$ac_cs_awk_cr" = "a${ac_cr}b"; then + ac_cs_awk_cr='\\r' +else + ac_cs_awk_cr=$ac_cr +fi + +echo 'BEGIN {' >"$ac_tmp/subs1.awk" && +_ACEOF + + +{ + echo "cat >conf$$subs.awk <<_ACEOF" && + echo "$ac_subst_vars" | sed 's/.*/&!$&$ac_delim/' && + echo "_ACEOF" +} >conf$$subs.sh || + as_fn_error $? "could not make $CONFIG_STATUS" "$LINENO" 5 +ac_delim_num=`echo "$ac_subst_vars" | grep -c '^'` +ac_delim='%!_!# ' +for ac_last_try in false false false false false :; do + . ./conf$$subs.sh || + as_fn_error $? "could not make $CONFIG_STATUS" "$LINENO" 5 + + ac_delim_n=`sed -n "s/.*$ac_delim\$/X/p" conf$$subs.awk | grep -c X` + if test $ac_delim_n = $ac_delim_num; then + break + elif $ac_last_try; then + as_fn_error $? "could not make $CONFIG_STATUS" "$LINENO" 5 + else + ac_delim="$ac_delim!$ac_delim _$ac_delim!! " + fi +done +rm -f conf$$subs.sh + +cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 +cat >>"\$ac_tmp/subs1.awk" <<\\_ACAWK && +_ACEOF +sed -n ' +h +s/^/S["/; s/!.*/"]=/ +p +g +s/^[^!]*!// +:repl +t repl +s/'"$ac_delim"'$// +t delim +:nl +h +s/\(.\{148\}\)..*/\1/ +t more1 +s/["\\]/\\&/g; s/^/"/; s/$/\\n"\\/ +p +n +b repl +:more1 +s/["\\]/\\&/g; s/^/"/; s/$/"\\/ +p +g +s/.\{148\}// +t nl +:delim +h +s/\(.\{148\}\)..*/\1/ +t more2 +s/["\\]/\\&/g; s/^/"/; s/$/"/ +p +b +:more2 +s/["\\]/\\&/g; s/^/"/; s/$/"\\/ +p +g +s/.\{148\}// +t delim +' >$CONFIG_STATUS || ac_write_fail=1 +rm -f conf$$subs.awk +cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 +_ACAWK +cat >>"\$ac_tmp/subs1.awk" <<_ACAWK && + for (key in S) S_is_set[key] = 1 + FS = "" + +} +{ + line = $ 0 + nfields = split(line, field, "@") + substed = 0 + len = length(field[1]) + for (i = 2; i < nfields; i++) { + key = field[i] + keylen = length(key) + if (S_is_set[key]) { + value = S[key] + line = substr(line, 1, len) "" value "" substr(line, len + keylen + 3) + len += length(value) + length(field[++i]) + substed = 1 + } else + len += 1 + keylen + } + + print line +} + +_ACAWK +_ACEOF +cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 +if sed "s/$ac_cr//" < /dev/null > /dev/null 2>&1; then + sed "s/$ac_cr\$//; s/$ac_cr/$ac_cs_awk_cr/g" +else + cat +fi < "$ac_tmp/subs1.awk" > "$ac_tmp/subs.awk" \ + || as_fn_error $? "could not setup config files machinery" "$LINENO" 5 +_ACEOF + +# VPATH may cause trouble with some makes, so we remove sole $(srcdir), +# ${srcdir} and @srcdir@ entries from VPATH if srcdir is ".", strip leading and +# trailing colons and then remove the whole line if VPATH becomes empty +# (actually we leave an empty line to preserve line numbers). +if test "x$srcdir" = x.; then + ac_vpsub='/^[ ]*VPATH[ ]*=[ ]*/{ +h +s/// +s/^/:/ +s/[ ]*$/:/ +s/:\$(srcdir):/:/g +s/:\${srcdir}:/:/g +s/:@srcdir@:/:/g +s/^:*// +s/:*$// +x +s/\(=[ ]*\).*/\1/ +G +s/\n// +s/^[^=]*=[ ]*$// +}' +fi + +cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 +fi # test -n "$CONFIG_FILES" + +# Set up the scripts for CONFIG_HEADERS section. +# No need to generate them if there are no CONFIG_HEADERS. +# This happens for instance with `./config.status Makefile'. +if test -n "$CONFIG_HEADERS"; then +cat >"$ac_tmp/defines.awk" <<\_ACAWK || +BEGIN { +_ACEOF + +# Transform confdefs.h into an awk script `defines.awk', embedded as +# here-document in config.status, that substitutes the proper values into +# config.h.in to produce config.h. + +# Create a delimiter string that does not exist in confdefs.h, to ease +# handling of long lines. +ac_delim='%!_!# ' +for ac_last_try in false false :; do + ac_tt=`sed -n "/$ac_delim/p" confdefs.h` + if test -z "$ac_tt"; then + break + elif $ac_last_try; then + as_fn_error $? "could not make $CONFIG_HEADERS" "$LINENO" 5 + else + ac_delim="$ac_delim!$ac_delim _$ac_delim!! " + fi +done + +# For the awk script, D is an array of macro values keyed by name, +# likewise P contains macro parameters if any. Preserve backslash +# newline sequences. + +ac_word_re=[_$as_cr_Letters][_$as_cr_alnum]* +sed -n ' +s/.\{148\}/&'"$ac_delim"'/g +t rset +:rset +s/^[ ]*#[ ]*define[ ][ ]*/ / +t def +d +:def +s/\\$// +t bsnl +s/["\\]/\\&/g +s/^ \('"$ac_word_re"'\)\(([^()]*)\)[ ]*\(.*\)/P["\1"]="\2"\ +D["\1"]=" \3"/p +s/^ \('"$ac_word_re"'\)[ ]*\(.*\)/D["\1"]=" \2"/p +d +:bsnl +s/["\\]/\\&/g +s/^ \('"$ac_word_re"'\)\(([^()]*)\)[ ]*\(.*\)/P["\1"]="\2"\ +D["\1"]=" \3\\\\\\n"\\/p +t cont +s/^ \('"$ac_word_re"'\)[ ]*\(.*\)/D["\1"]=" \2\\\\\\n"\\/p +t cont +d +:cont +n +s/.\{148\}/&'"$ac_delim"'/g +t clear +:clear +s/\\$// +t bsnlc +s/["\\]/\\&/g; s/^/"/; s/$/"/p +d +:bsnlc +s/["\\]/\\&/g; s/^/"/; s/$/\\\\\\n"\\/p +b cont +' >$CONFIG_STATUS || ac_write_fail=1 + +cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 + for (key in D) D_is_set[key] = 1 + FS = "" +} +/^[\t ]*#[\t ]*(define|undef)[\t ]+$ac_word_re([\t (]|\$)/ { + line = \$ 0 + split(line, arg, " ") + if (arg[1] == "#") { + defundef = arg[2] + mac1 = arg[3] + } else { + defundef = substr(arg[1], 2) + mac1 = arg[2] + } + split(mac1, mac2, "(") #) + macro = mac2[1] + prefix = substr(line, 1, index(line, defundef) - 1) + if (D_is_set[macro]) { + # Preserve the white space surrounding the "#". + print prefix "define", macro P[macro] D[macro] + next + } else { + # Replace #undef with comments. This is necessary, for example, + # in the case of _POSIX_SOURCE, which is predefined and required + # on some systems where configure will not decide to define it. + if (defundef == "undef") { + print "/*", prefix defundef, macro, "*/" + next + } + } +} +{ print } +_ACAWK +_ACEOF +cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 + as_fn_error $? "could not setup config headers machinery" "$LINENO" 5 +fi # test -n "$CONFIG_HEADERS" + + +eval set X " :F $CONFIG_FILES :H $CONFIG_HEADERS :C $CONFIG_COMMANDS" +shift +for ac_tag +do + case $ac_tag in + :[FHLC]) ac_mode=$ac_tag; continue;; + esac + case $ac_mode$ac_tag in + :[FHL]*:*);; + :L* | :C*:*) as_fn_error $? "invalid tag \`$ac_tag'" "$LINENO" 5;; + :[FH]-) ac_tag=-:-;; + :[FH]*) ac_tag=$ac_tag:$ac_tag.in;; + esac + ac_save_IFS=$IFS + IFS=: + set x $ac_tag + IFS=$ac_save_IFS + shift + ac_file=$1 + shift + + case $ac_mode in + :L) ac_source=$1;; + :[FH]) + ac_file_inputs= + for ac_f + do + case $ac_f in + -) ac_f="$ac_tmp/stdin";; + *) # Look for the file first in the build tree, then in the source tree + # (if the path is not absolute). The absolute path cannot be DOS-style, + # because $ac_f cannot contain `:'. + test -f "$ac_f" || + case $ac_f in + [\\/$]*) false;; + *) test -f "$srcdir/$ac_f" && ac_f="$srcdir/$ac_f";; + esac || + as_fn_error 1 "cannot find input file: \`$ac_f'" "$LINENO" 5;; + esac + case $ac_f in *\'*) ac_f=`$as_echo "$ac_f" | sed "s/'/'\\\\\\\\''/g"`;; esac + as_fn_append ac_file_inputs " '$ac_f'" + done + + # Let's still pretend it is `configure' which instantiates (i.e., don't + # use $as_me), people would be surprised to read: + # /* config.h. Generated by config.status. */ + configure_input='Generated from '` + $as_echo "$*" | sed 's|^[^:]*/||;s|:[^:]*/|, |g' + `' by configure.' + if test x"$ac_file" != x-; then + configure_input="$ac_file. $configure_input" + { $as_echo "$as_me:${as_lineno-$LINENO}: creating $ac_file" >&5 +$as_echo "$as_me: creating $ac_file" >&6;} + fi + # Neutralize special characters interpreted by sed in replacement strings. + case $configure_input in #( + *\&* | *\|* | *\\* ) + ac_sed_conf_input=`$as_echo "$configure_input" | + sed 's/[\\\\&|]/\\\\&/g'`;; #( + *) ac_sed_conf_input=$configure_input;; + esac + + case $ac_tag in + *:-:* | *:-) cat >"$ac_tmp/stdin" \ + || as_fn_error $? "could not create $ac_file" "$LINENO" 5 ;; + esac + ;; + esac + + ac_dir=`$as_dirname -- "$ac_file" || +$as_expr X"$ac_file" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ + X"$ac_file" : 'X\(//\)[^/]' \| \ + X"$ac_file" : 'X\(//\)$' \| \ + X"$ac_file" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X"$ac_file" | + sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ + s//\1/ + q + } + /^X\(\/\/\)[^/].*/{ + s//\1/ + q + } + /^X\(\/\/\)$/{ + s//\1/ + q + } + /^X\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'` + as_dir="$ac_dir"; as_fn_mkdir_p + ac_builddir=. + +case "$ac_dir" in +.) ac_dir_suffix= ac_top_builddir_sub=. ac_top_build_prefix= ;; +*) + ac_dir_suffix=/`$as_echo "$ac_dir" | sed 's|^\.[\\/]||'` + # A ".." for each directory in $ac_dir_suffix. + ac_top_builddir_sub=`$as_echo "$ac_dir_suffix" | sed 's|/[^\\/]*|/..|g;s|/||'` + case $ac_top_builddir_sub in + "") ac_top_builddir_sub=. ac_top_build_prefix= ;; + *) ac_top_build_prefix=$ac_top_builddir_sub/ ;; + esac ;; +esac +ac_abs_top_builddir=$ac_pwd +ac_abs_builddir=$ac_pwd$ac_dir_suffix +# for backward compatibility: +ac_top_builddir=$ac_top_build_prefix + +case $srcdir in + .) # We are building in place. + ac_srcdir=. + ac_top_srcdir=$ac_top_builddir_sub + ac_abs_top_srcdir=$ac_pwd ;; + [\\/]* | ?:[\\/]* ) # Absolute name. + ac_srcdir=$srcdir$ac_dir_suffix; + ac_top_srcdir=$srcdir + ac_abs_top_srcdir=$srcdir ;; + *) # Relative name. + ac_srcdir=$ac_top_build_prefix$srcdir$ac_dir_suffix + ac_top_srcdir=$ac_top_build_prefix$srcdir + ac_abs_top_srcdir=$ac_pwd/$srcdir ;; +esac +ac_abs_srcdir=$ac_abs_top_srcdir$ac_dir_suffix + + + case $ac_mode in + :F) + # + # CONFIG_FILE + # + + case $INSTALL in + [\\/$]* | ?:[\\/]* ) ac_INSTALL=$INSTALL ;; + *) ac_INSTALL=$ac_top_build_prefix$INSTALL ;; + esac + ac_MKDIR_P=$MKDIR_P + case $MKDIR_P in + [\\/$]* | ?:[\\/]* ) ;; + */*) ac_MKDIR_P=$ac_top_build_prefix$MKDIR_P ;; + esac +_ACEOF + +cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 +# If the template does not know about datarootdir, expand it. +# FIXME: This hack should be removed a few years after 2.60. +ac_datarootdir_hack=; ac_datarootdir_seen= +ac_sed_dataroot=' +/datarootdir/ { + p + q +} +/@datadir@/p +/@docdir@/p +/@infodir@/p +/@localedir@/p +/@mandir@/p' +case `eval "sed -n \"\$ac_sed_dataroot\" $ac_file_inputs"` in +*datarootdir*) ac_datarootdir_seen=yes;; +*@datadir@*|*@docdir@*|*@infodir@*|*@localedir@*|*@mandir@*) + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $ac_file_inputs seems to ignore the --datarootdir setting" >&5 +$as_echo "$as_me: WARNING: $ac_file_inputs seems to ignore the --datarootdir setting" >&2;} +_ACEOF +cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 + ac_datarootdir_hack=' + s&@datadir@&$datadir&g + s&@docdir@&$docdir&g + s&@infodir@&$infodir&g + s&@localedir@&$localedir&g + s&@mandir@&$mandir&g + s&\\\${datarootdir}&$datarootdir&g' ;; +esac +_ACEOF + +# Neutralize VPATH when `$srcdir' = `.'. +# Shell code in configure.ac might set extrasub. +# FIXME: do we really want to maintain this feature? +cat >>$CONFIG_STATUS <<_ACEOF || ac_write_fail=1 +ac_sed_extra="$ac_vpsub +$extrasub +_ACEOF +cat >>$CONFIG_STATUS <<\_ACEOF || ac_write_fail=1 +:t +/@[a-zA-Z_][a-zA-Z_0-9]*@/!b +s|@configure_input@|$ac_sed_conf_input|;t t +s&@top_builddir@&$ac_top_builddir_sub&;t t +s&@top_build_prefix@&$ac_top_build_prefix&;t t +s&@srcdir@&$ac_srcdir&;t t +s&@abs_srcdir@&$ac_abs_srcdir&;t t +s&@top_srcdir@&$ac_top_srcdir&;t t +s&@abs_top_srcdir@&$ac_abs_top_srcdir&;t t +s&@builddir@&$ac_builddir&;t t +s&@abs_builddir@&$ac_abs_builddir&;t t +s&@abs_top_builddir@&$ac_abs_top_builddir&;t t +s&@INSTALL@&$ac_INSTALL&;t t +s&@MKDIR_P@&$ac_MKDIR_P&;t t +$ac_datarootdir_hack +" +eval sed \"\$ac_sed_extra\" "$ac_file_inputs" | $AWK -f "$ac_tmp/subs.awk" \ + >$ac_tmp/out || as_fn_error $? "could not create $ac_file" "$LINENO" 5 + +test -z "$ac_datarootdir_hack$ac_datarootdir_seen" && + { ac_out=`sed -n '/\${datarootdir}/p' "$ac_tmp/out"`; test -n "$ac_out"; } && + { ac_out=`sed -n '/^[ ]*datarootdir[ ]*:*=/p' \ + "$ac_tmp/out"`; test -z "$ac_out"; } && + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: $ac_file contains a reference to the variable \`datarootdir' +which seems to be undefined. Please make sure it is defined" >&5 +$as_echo "$as_me: WARNING: $ac_file contains a reference to the variable \`datarootdir' +which seems to be undefined. Please make sure it is defined" >&2;} + + rm -f "$ac_tmp/stdin" + case $ac_file in + -) cat "$ac_tmp/out" && rm -f "$ac_tmp/out";; + *) rm -f "$ac_file" && mv "$ac_tmp/out" "$ac_file";; + esac \ + || as_fn_error $? "could not create $ac_file" "$LINENO" 5 + ;; + :H) + # + # CONFIG_HEADER + # + if test x"$ac_file" != x-; then + { + $as_echo "/* $configure_input */" \ + && eval '$AWK -f "$ac_tmp/defines.awk"' "$ac_file_inputs" + } >"$ac_tmp/config.h" \ + || as_fn_error $? "could not create $ac_file" "$LINENO" 5 + if diff "$ac_file" "$ac_tmp/config.h" >/dev/null 2>&1; then + { $as_echo "$as_me:${as_lineno-$LINENO}: $ac_file is unchanged" >&5 +$as_echo "$as_me: $ac_file is unchanged" >&6;} + else + rm -f "$ac_file" + mv "$ac_tmp/config.h" "$ac_file" \ + || as_fn_error $? "could not create $ac_file" "$LINENO" 5 + fi + else + $as_echo "/* $configure_input */" \ + && eval '$AWK -f "$ac_tmp/defines.awk"' "$ac_file_inputs" \ + || as_fn_error $? "could not create -" "$LINENO" 5 + fi +# Compute "$ac_file"'s index in $config_headers. +_am_arg="$ac_file" +_am_stamp_count=1 +for _am_header in $config_headers :; do + case $_am_header in + $_am_arg | $_am_arg:* ) + break ;; + * ) + _am_stamp_count=`expr $_am_stamp_count + 1` ;; + esac +done +echo "timestamp for $_am_arg" >`$as_dirname -- "$_am_arg" || +$as_expr X"$_am_arg" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ + X"$_am_arg" : 'X\(//\)[^/]' \| \ + X"$_am_arg" : 'X\(//\)$' \| \ + X"$_am_arg" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X"$_am_arg" | + sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ + s//\1/ + q + } + /^X\(\/\/\)[^/].*/{ + s//\1/ + q + } + /^X\(\/\/\)$/{ + s//\1/ + q + } + /^X\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'`/stamp-h$_am_stamp_count + ;; + + :C) { $as_echo "$as_me:${as_lineno-$LINENO}: executing $ac_file commands" >&5 +$as_echo "$as_me: executing $ac_file commands" >&6;} + ;; + esac + + + case $ac_file$ac_mode in + "depfiles":C) test x"$AMDEP_TRUE" != x"" || { + # Autoconf 2.62 quotes --file arguments for eval, but not when files + # are listed without --file. Let's play safe and only enable the eval + # if we detect the quoting. + case $CONFIG_FILES in + *\'*) eval set x "$CONFIG_FILES" ;; + *) set x $CONFIG_FILES ;; + esac + shift + for mf + do + # Strip MF so we end up with the name of the file. + mf=`echo "$mf" | sed -e 's/:.*$//'` + # Check whether this is an Automake generated Makefile or not. + # We used to match only the files named `Makefile.in', but + # some people rename them; so instead we look at the file content. + # Grep'ing the first line is not enough: some people post-process + # each Makefile.in and add a new line on top of each file to say so. + # Grep'ing the whole file is not good either: AIX grep has a line + # limit of 2048, but all sed's we know have understand at least 4000. + if sed -n 's,^#.*generated by automake.*,X,p' "$mf" | grep X >/dev/null 2>&1; then + dirpart=`$as_dirname -- "$mf" || +$as_expr X"$mf" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ + X"$mf" : 'X\(//\)[^/]' \| \ + X"$mf" : 'X\(//\)$' \| \ + X"$mf" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X"$mf" | + sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ + s//\1/ + q + } + /^X\(\/\/\)[^/].*/{ + s//\1/ + q + } + /^X\(\/\/\)$/{ + s//\1/ + q + } + /^X\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'` + else + continue + fi + # Extract the definition of DEPDIR, am__include, and am__quote + # from the Makefile without running `make'. + DEPDIR=`sed -n 's/^DEPDIR = //p' < "$mf"` + test -z "$DEPDIR" && continue + am__include=`sed -n 's/^am__include = //p' < "$mf"` + test -z "am__include" && continue + am__quote=`sed -n 's/^am__quote = //p' < "$mf"` + # When using ansi2knr, U may be empty or an underscore; expand it + U=`sed -n 's/^U = //p' < "$mf"` + # Find all dependency output files, they are included files with + # $(DEPDIR) in their names. We invoke sed twice because it is the + # simplest approach to changing $(DEPDIR) to its actual value in the + # expansion. + for file in `sed -n " + s/^$am__include $am__quote\(.*(DEPDIR).*\)$am__quote"'$/\1/p' <"$mf" | \ + sed -e 's/\$(DEPDIR)/'"$DEPDIR"'/g' -e 's/\$U/'"$U"'/g'`; do + # Make sure the directory exists. + test -f "$dirpart/$file" && continue + fdir=`$as_dirname -- "$file" || +$as_expr X"$file" : 'X\(.*[^/]\)//*[^/][^/]*/*$' \| \ + X"$file" : 'X\(//\)[^/]' \| \ + X"$file" : 'X\(//\)$' \| \ + X"$file" : 'X\(/\)' \| . 2>/dev/null || +$as_echo X"$file" | + sed '/^X\(.*[^/]\)\/\/*[^/][^/]*\/*$/{ + s//\1/ + q + } + /^X\(\/\/\)[^/].*/{ + s//\1/ + q + } + /^X\(\/\/\)$/{ + s//\1/ + q + } + /^X\(\/\).*/{ + s//\1/ + q + } + s/.*/./; q'` + as_dir=$dirpart/$fdir; as_fn_mkdir_p + # echo "creating $dirpart/$file" + echo '# dummy' > "$dirpart/$file" + done + done +} + ;; + "libtool":C) + + # See if we are running on zsh, and set the options which allow our + # commands through without removal of \ escapes. + if test -n "${ZSH_VERSION+set}" ; then + setopt NO_GLOB_SUBST + fi + + cfgfile="${ofile}T" + trap "$RM \"$cfgfile\"; exit 1" 1 2 15 + $RM "$cfgfile" + + cat <<_LT_EOF >> "$cfgfile" +#! $SHELL + +# `$ECHO "$ofile" | sed 's%^.*/%%'` - Provide generalized library-building support services. +# Generated automatically by $as_me ($PACKAGE$TIMESTAMP) $VERSION +# Libtool was configured on host `(hostname || uname -n) 2>/dev/null | sed 1q`: +# NOTE: Changes made to this file will be lost: look at ltmain.sh. +# +# Copyright (C) 1996, 1997, 1998, 1999, 2000, 2001, 2003, 2004, 2005, +# 2006, 2007, 2008, 2009, 2010, 2011 Free Software +# Foundation, Inc. +# Written by Gordon Matzigkeit, 1996 +# +# This file is part of GNU Libtool. +# +# GNU Libtool is free software; you can redistribute it and/or +# modify it under the terms of the GNU General Public License as +# published by the Free Software Foundation; either version 2 of +# the License, or (at your option) any later version. +# +# As a special exception to the GNU General Public License, +# if you distribute this file as part of a program or library that +# is built using GNU Libtool, you may include this file under the +# same distribution terms that you use for the rest of that program. +# +# GNU Libtool is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY; without even the implied warranty of +# MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +# GNU General Public License for more details. +# +# You should have received a copy of the GNU General Public License +# along with GNU Libtool; see the file COPYING. If not, a copy +# can be downloaded from http://www.gnu.org/licenses/gpl.html, or +# obtained by writing to the Free Software Foundation, Inc., +# 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301, USA. + + +# The names of the tagged configurations supported by this script. +available_tags="CXX " + +# ### BEGIN LIBTOOL CONFIG + +# Which release of libtool.m4 was used? +macro_version=$macro_version +macro_revision=$macro_revision + +# Whether or not to build shared libraries. +build_libtool_libs=$enable_shared + +# Whether or not to build static libraries. +build_old_libs=$enable_static + +# What type of objects to build. +pic_mode=$pic_mode + +# Whether or not to optimize for fast installation. +fast_install=$enable_fast_install + +# Shell to use when invoking shell scripts. +SHELL=$lt_SHELL + +# An echo program that protects backslashes. +ECHO=$lt_ECHO + +# The PATH separator for the build system. +PATH_SEPARATOR=$lt_PATH_SEPARATOR + +# The host system. +host_alias=$host_alias +host=$host +host_os=$host_os + +# The build system. +build_alias=$build_alias +build=$build +build_os=$build_os + +# A sed program that does not truncate output. +SED=$lt_SED + +# Sed that helps us avoid accidentally triggering echo(1) options like -n. +Xsed="\$SED -e 1s/^X//" + +# A grep program that handles long lines. +GREP=$lt_GREP + +# An ERE matcher. +EGREP=$lt_EGREP + +# A literal string matcher. +FGREP=$lt_FGREP + +# A BSD- or MS-compatible name lister. +NM=$lt_NM + +# Whether we need soft or hard links. +LN_S=$lt_LN_S + +# What is the maximum length of a command? +max_cmd_len=$max_cmd_len + +# Object file suffix (normally "o"). +objext=$ac_objext + +# Executable file suffix (normally ""). +exeext=$exeext + +# whether the shell understands "unset". +lt_unset=$lt_unset + +# turn spaces into newlines. +SP2NL=$lt_lt_SP2NL + +# turn newlines into spaces. +NL2SP=$lt_lt_NL2SP + +# convert \$build file names to \$host format. +to_host_file_cmd=$lt_cv_to_host_file_cmd + +# convert \$build files to toolchain format. +to_tool_file_cmd=$lt_cv_to_tool_file_cmd + +# An object symbol dumper. +OBJDUMP=$lt_OBJDUMP + +# Method to check whether dependent libraries are shared objects. +deplibs_check_method=$lt_deplibs_check_method + +# Command to use when deplibs_check_method = "file_magic". +file_magic_cmd=$lt_file_magic_cmd + +# How to find potential files when deplibs_check_method = "file_magic". +file_magic_glob=$lt_file_magic_glob + +# Find potential files using nocaseglob when deplibs_check_method = "file_magic". +want_nocaseglob=$lt_want_nocaseglob + +# DLL creation program. +DLLTOOL=$lt_DLLTOOL + +# Command to associate shared and link libraries. +sharedlib_from_linklib_cmd=$lt_sharedlib_from_linklib_cmd + +# The archiver. +AR=$lt_AR + +# Flags to create an archive. +AR_FLAGS=$lt_AR_FLAGS + +# How to feed a file listing to the archiver. +archiver_list_spec=$lt_archiver_list_spec + +# A symbol stripping program. +STRIP=$lt_STRIP + +# Commands used to install an old-style archive. +RANLIB=$lt_RANLIB +old_postinstall_cmds=$lt_old_postinstall_cmds +old_postuninstall_cmds=$lt_old_postuninstall_cmds + +# Whether to use a lock for old archive extraction. +lock_old_archive_extraction=$lock_old_archive_extraction + +# A C compiler. +LTCC=$lt_CC + +# LTCC compiler flags. +LTCFLAGS=$lt_CFLAGS + +# Take the output of nm and produce a listing of raw symbols and C names. +global_symbol_pipe=$lt_lt_cv_sys_global_symbol_pipe + +# Transform the output of nm in a proper C declaration. +global_symbol_to_cdecl=$lt_lt_cv_sys_global_symbol_to_cdecl + +# Transform the output of nm in a C name address pair. +global_symbol_to_c_name_address=$lt_lt_cv_sys_global_symbol_to_c_name_address + +# Transform the output of nm in a C name address pair when lib prefix is needed. +global_symbol_to_c_name_address_lib_prefix=$lt_lt_cv_sys_global_symbol_to_c_name_address_lib_prefix + +# Specify filename containing input files for \$NM. +nm_file_list_spec=$lt_nm_file_list_spec + +# The root where to search for dependent libraries,and in which our libraries should be installed. +lt_sysroot=$lt_sysroot + +# The name of the directory that contains temporary libtool files. +objdir=$objdir + +# Used to examine libraries when file_magic_cmd begins with "file". +MAGIC_CMD=$MAGIC_CMD + +# Must we lock files when doing compilation? +need_locks=$lt_need_locks + +# Manifest tool. +MANIFEST_TOOL=$lt_MANIFEST_TOOL + +# Tool to manipulate archived DWARF debug symbol files on Mac OS X. +DSYMUTIL=$lt_DSYMUTIL + +# Tool to change global to local symbols on Mac OS X. +NMEDIT=$lt_NMEDIT + +# Tool to manipulate fat objects and archives on Mac OS X. +LIPO=$lt_LIPO + +# ldd/readelf like tool for Mach-O binaries on Mac OS X. +OTOOL=$lt_OTOOL + +# ldd/readelf like tool for 64 bit Mach-O binaries on Mac OS X 10.4. +OTOOL64=$lt_OTOOL64 + +# Old archive suffix (normally "a"). +libext=$libext + +# Shared library suffix (normally ".so"). +shrext_cmds=$lt_shrext_cmds + +# The commands to extract the exported symbol list from a shared archive. +extract_expsyms_cmds=$lt_extract_expsyms_cmds + +# Variables whose values should be saved in libtool wrapper scripts and +# restored at link time. +variables_saved_for_relink=$lt_variables_saved_for_relink + +# Do we need the "lib" prefix for modules? +need_lib_prefix=$need_lib_prefix + +# Do we need a version for libraries? +need_version=$need_version + +# Library versioning type. +version_type=$version_type + +# Shared library runtime path variable. +runpath_var=$runpath_var + +# Shared library path variable. +shlibpath_var=$shlibpath_var + +# Is shlibpath searched before the hard-coded library search path? +shlibpath_overrides_runpath=$shlibpath_overrides_runpath + +# Format of library name prefix. +libname_spec=$lt_libname_spec + +# List of archive names. First name is the real one, the rest are links. +# The last name is the one that the linker finds with -lNAME +library_names_spec=$lt_library_names_spec + +# The coded name of the library, if different from the real name. +soname_spec=$lt_soname_spec + +# Permission mode override for installation of shared libraries. +install_override_mode=$lt_install_override_mode + +# Command to use after installation of a shared archive. +postinstall_cmds=$lt_postinstall_cmds + +# Command to use after uninstallation of a shared archive. +postuninstall_cmds=$lt_postuninstall_cmds + +# Commands used to finish a libtool library installation in a directory. +finish_cmds=$lt_finish_cmds + +# As "finish_cmds", except a single script fragment to be evaled but +# not shown. +finish_eval=$lt_finish_eval + +# Whether we should hardcode library paths into libraries. +hardcode_into_libs=$hardcode_into_libs + +# Compile-time system search path for libraries. +sys_lib_search_path_spec=$lt_sys_lib_search_path_spec + +# Run-time system search path for libraries. +sys_lib_dlsearch_path_spec=$lt_sys_lib_dlsearch_path_spec + +# Whether dlopen is supported. +dlopen_support=$enable_dlopen + +# Whether dlopen of programs is supported. +dlopen_self=$enable_dlopen_self + +# Whether dlopen of statically linked programs is supported. +dlopen_self_static=$enable_dlopen_self_static + +# Commands to strip libraries. +old_striplib=$lt_old_striplib +striplib=$lt_striplib + +# Assembler program. +AS=$lt_AS + + +# The linker used to build libraries. +LD=$lt_LD + +# How to create reloadable object files. +reload_flag=$lt_reload_flag +reload_cmds=$lt_reload_cmds + +# Commands used to build an old-style archive. +old_archive_cmds=$lt_old_archive_cmds + +# A language specific compiler. +CC=$lt_compiler + +# Is the compiler the GNU compiler? +with_gcc=$GCC + +# Compiler flag to turn off builtin functions. +no_builtin_flag=$lt_lt_prog_compiler_no_builtin_flag + +# Additional compiler flags for building library objects. +pic_flag=$lt_lt_prog_compiler_pic + +# How to pass a linker flag through the compiler. +wl=$lt_lt_prog_compiler_wl + +# Compiler flag to prevent dynamic linking. +link_static_flag=$lt_lt_prog_compiler_static + +# Does compiler simultaneously support -c and -o options? +compiler_c_o=$lt_lt_cv_prog_compiler_c_o + +# Whether or not to add -lc for building shared libraries. +build_libtool_need_lc=$archive_cmds_need_lc + +# Whether or not to disallow shared libs when runtime libs are static. +allow_libtool_libs_with_static_runtimes=$enable_shared_with_static_runtimes + +# Compiler flag to allow reflexive dlopens. +export_dynamic_flag_spec=$lt_export_dynamic_flag_spec + +# Compiler flag to generate shared objects directly from archives. +whole_archive_flag_spec=$lt_whole_archive_flag_spec + +# Whether the compiler copes with passing no objects directly. +compiler_needs_object=$lt_compiler_needs_object + +# Create an old-style archive from a shared archive. +old_archive_from_new_cmds=$lt_old_archive_from_new_cmds + +# Create a temporary old-style archive to link instead of a shared archive. +old_archive_from_expsyms_cmds=$lt_old_archive_from_expsyms_cmds + +# Commands used to build a shared archive. +archive_cmds=$lt_archive_cmds +archive_expsym_cmds=$lt_archive_expsym_cmds + +# Commands used to build a loadable module if different from building +# a shared archive. +module_cmds=$lt_module_cmds +module_expsym_cmds=$lt_module_expsym_cmds + +# Whether we are building with GNU ld or not. +with_gnu_ld=$lt_with_gnu_ld + +# Flag that allows shared libraries with undefined symbols to be built. +allow_undefined_flag=$lt_allow_undefined_flag + +# Flag that enforces no undefined symbols. +no_undefined_flag=$lt_no_undefined_flag + +# Flag to hardcode \$libdir into a binary during linking. +# This must work even if \$libdir does not exist +hardcode_libdir_flag_spec=$lt_hardcode_libdir_flag_spec + +# Whether we need a single "-rpath" flag with a separated argument. +hardcode_libdir_separator=$lt_hardcode_libdir_separator + +# Set to "yes" if using DIR/libNAME\${shared_ext} during linking hardcodes +# DIR into the resulting binary. +hardcode_direct=$hardcode_direct + +# Set to "yes" if using DIR/libNAME\${shared_ext} during linking hardcodes +# DIR into the resulting binary and the resulting library dependency is +# "absolute",i.e impossible to change by setting \${shlibpath_var} if the +# library is relocated. +hardcode_direct_absolute=$hardcode_direct_absolute + +# Set to "yes" if using the -LDIR flag during linking hardcodes DIR +# into the resulting binary. +hardcode_minus_L=$hardcode_minus_L + +# Set to "yes" if using SHLIBPATH_VAR=DIR during linking hardcodes DIR +# into the resulting binary. +hardcode_shlibpath_var=$hardcode_shlibpath_var + +# Set to "yes" if building a shared library automatically hardcodes DIR +# into the library and all subsequent libraries and executables linked +# against it. +hardcode_automatic=$hardcode_automatic + +# Set to yes if linker adds runtime paths of dependent libraries +# to runtime path list. +inherit_rpath=$inherit_rpath + +# Whether libtool must link a program against all its dependency libraries. +link_all_deplibs=$link_all_deplibs + +# Set to "yes" if exported symbols are required. +always_export_symbols=$always_export_symbols + +# The commands to list exported symbols. +export_symbols_cmds=$lt_export_symbols_cmds + +# Symbols that should not be listed in the preloaded symbols. +exclude_expsyms=$lt_exclude_expsyms + +# Symbols that must always be exported. +include_expsyms=$lt_include_expsyms + +# Commands necessary for linking programs (against libraries) with templates. +prelink_cmds=$lt_prelink_cmds + +# Commands necessary for finishing linking programs. +postlink_cmds=$lt_postlink_cmds + +# Specify filename containing input files. +file_list_spec=$lt_file_list_spec + +# How to hardcode a shared library path into an executable. +hardcode_action=$hardcode_action + +# The directories searched by this compiler when creating a shared library. +compiler_lib_search_dirs=$lt_compiler_lib_search_dirs + +# Dependencies to place before and after the objects being linked to +# create a shared library. +predep_objects=$lt_predep_objects +postdep_objects=$lt_postdep_objects +predeps=$lt_predeps +postdeps=$lt_postdeps + +# The library search path used internally by the compiler when linking +# a shared library. +compiler_lib_search_path=$lt_compiler_lib_search_path + +# ### END LIBTOOL CONFIG + +_LT_EOF + + case $host_os in + aix3*) + cat <<\_LT_EOF >> "$cfgfile" +# AIX sometimes has problems with the GCC collect2 program. For some +# reason, if we set the COLLECT_NAMES environment variable, the problems +# vanish in a puff of smoke. +if test "X${COLLECT_NAMES+set}" != Xset; then + COLLECT_NAMES= + export COLLECT_NAMES +fi +_LT_EOF + ;; + esac + + +ltmain="$ac_aux_dir/ltmain.sh" + + + # We use sed instead of cat because bash on DJGPP gets confused if + # if finds mixed CR/LF and LF-only lines. Since sed operates in + # text mode, it properly converts lines to CR/LF. This bash problem + # is reportedly fixed, but why not run on old versions too? + sed '$q' "$ltmain" >> "$cfgfile" \ + || (rm -f "$cfgfile"; exit 1) + + if test x"$xsi_shell" = xyes; then + sed -e '/^func_dirname ()$/,/^} # func_dirname /c\ +func_dirname ()\ +{\ +\ case ${1} in\ +\ */*) func_dirname_result="${1%/*}${2}" ;;\ +\ * ) func_dirname_result="${3}" ;;\ +\ esac\ +} # Extended-shell func_dirname implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_basename ()$/,/^} # func_basename /c\ +func_basename ()\ +{\ +\ func_basename_result="${1##*/}"\ +} # Extended-shell func_basename implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_dirname_and_basename ()$/,/^} # func_dirname_and_basename /c\ +func_dirname_and_basename ()\ +{\ +\ case ${1} in\ +\ */*) func_dirname_result="${1%/*}${2}" ;;\ +\ * ) func_dirname_result="${3}" ;;\ +\ esac\ +\ func_basename_result="${1##*/}"\ +} # Extended-shell func_dirname_and_basename implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_stripname ()$/,/^} # func_stripname /c\ +func_stripname ()\ +{\ +\ # pdksh 5.2.14 does not do ${X%$Y} correctly if both X and Y are\ +\ # positional parameters, so assign one to ordinary parameter first.\ +\ func_stripname_result=${3}\ +\ func_stripname_result=${func_stripname_result#"${1}"}\ +\ func_stripname_result=${func_stripname_result%"${2}"}\ +} # Extended-shell func_stripname implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_split_long_opt ()$/,/^} # func_split_long_opt /c\ +func_split_long_opt ()\ +{\ +\ func_split_long_opt_name=${1%%=*}\ +\ func_split_long_opt_arg=${1#*=}\ +} # Extended-shell func_split_long_opt implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_split_short_opt ()$/,/^} # func_split_short_opt /c\ +func_split_short_opt ()\ +{\ +\ func_split_short_opt_arg=${1#??}\ +\ func_split_short_opt_name=${1%"$func_split_short_opt_arg"}\ +} # Extended-shell func_split_short_opt implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_lo2o ()$/,/^} # func_lo2o /c\ +func_lo2o ()\ +{\ +\ case ${1} in\ +\ *.lo) func_lo2o_result=${1%.lo}.${objext} ;;\ +\ *) func_lo2o_result=${1} ;;\ +\ esac\ +} # Extended-shell func_lo2o implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_xform ()$/,/^} # func_xform /c\ +func_xform ()\ +{\ + func_xform_result=${1%.*}.lo\ +} # Extended-shell func_xform implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_arith ()$/,/^} # func_arith /c\ +func_arith ()\ +{\ + func_arith_result=$(( $* ))\ +} # Extended-shell func_arith implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_len ()$/,/^} # func_len /c\ +func_len ()\ +{\ + func_len_result=${#1}\ +} # Extended-shell func_len implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + +fi + +if test x"$lt_shell_append" = xyes; then + sed -e '/^func_append ()$/,/^} # func_append /c\ +func_append ()\ +{\ + eval "${1}+=\\${2}"\ +} # Extended-shell func_append implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + sed -e '/^func_append_quoted ()$/,/^} # func_append_quoted /c\ +func_append_quoted ()\ +{\ +\ func_quote_for_eval "${2}"\ +\ eval "${1}+=\\\\ \\$func_quote_for_eval_result"\ +} # Extended-shell func_append_quoted implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: + + + # Save a `func_append' function call where possible by direct use of '+=' + sed -e 's%func_append \([a-zA-Z_]\{1,\}\) "%\1+="%g' $cfgfile > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") + test 0 -eq $? || _lt_function_replace_fail=: +else + # Save a `func_append' function call even when '+=' is not available + sed -e 's%func_append \([a-zA-Z_]\{1,\}\) "%\1="$\1%g' $cfgfile > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") + test 0 -eq $? || _lt_function_replace_fail=: +fi + +if test x"$_lt_function_replace_fail" = x":"; then + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: Unable to substitute extended shell functions in $ofile" >&5 +$as_echo "$as_me: WARNING: Unable to substitute extended shell functions in $ofile" >&2;} +fi + + + mv -f "$cfgfile" "$ofile" || + (rm -f "$ofile" && cp "$cfgfile" "$ofile" && rm -f "$cfgfile") + chmod +x "$ofile" + + + cat <<_LT_EOF >> "$ofile" + +# ### BEGIN LIBTOOL TAG CONFIG: CXX + +# The linker used to build libraries. +LD=$lt_LD_CXX + +# How to create reloadable object files. +reload_flag=$lt_reload_flag_CXX +reload_cmds=$lt_reload_cmds_CXX + +# Commands used to build an old-style archive. +old_archive_cmds=$lt_old_archive_cmds_CXX + +# A language specific compiler. +CC=$lt_compiler_CXX + +# Is the compiler the GNU compiler? +with_gcc=$GCC_CXX + +# Compiler flag to turn off builtin functions. +no_builtin_flag=$lt_lt_prog_compiler_no_builtin_flag_CXX + +# Additional compiler flags for building library objects. +pic_flag=$lt_lt_prog_compiler_pic_CXX + +# How to pass a linker flag through the compiler. +wl=$lt_lt_prog_compiler_wl_CXX + +# Compiler flag to prevent dynamic linking. +link_static_flag=$lt_lt_prog_compiler_static_CXX + +# Does compiler simultaneously support -c and -o options? +compiler_c_o=$lt_lt_cv_prog_compiler_c_o_CXX + +# Whether or not to add -lc for building shared libraries. +build_libtool_need_lc=$archive_cmds_need_lc_CXX + +# Whether or not to disallow shared libs when runtime libs are static. +allow_libtool_libs_with_static_runtimes=$enable_shared_with_static_runtimes_CXX + +# Compiler flag to allow reflexive dlopens. +export_dynamic_flag_spec=$lt_export_dynamic_flag_spec_CXX + +# Compiler flag to generate shared objects directly from archives. +whole_archive_flag_spec=$lt_whole_archive_flag_spec_CXX + +# Whether the compiler copes with passing no objects directly. +compiler_needs_object=$lt_compiler_needs_object_CXX + +# Create an old-style archive from a shared archive. +old_archive_from_new_cmds=$lt_old_archive_from_new_cmds_CXX + +# Create a temporary old-style archive to link instead of a shared archive. +old_archive_from_expsyms_cmds=$lt_old_archive_from_expsyms_cmds_CXX + +# Commands used to build a shared archive. +archive_cmds=$lt_archive_cmds_CXX +archive_expsym_cmds=$lt_archive_expsym_cmds_CXX + +# Commands used to build a loadable module if different from building +# a shared archive. +module_cmds=$lt_module_cmds_CXX +module_expsym_cmds=$lt_module_expsym_cmds_CXX + +# Whether we are building with GNU ld or not. +with_gnu_ld=$lt_with_gnu_ld_CXX + +# Flag that allows shared libraries with undefined symbols to be built. +allow_undefined_flag=$lt_allow_undefined_flag_CXX + +# Flag that enforces no undefined symbols. +no_undefined_flag=$lt_no_undefined_flag_CXX + +# Flag to hardcode \$libdir into a binary during linking. +# This must work even if \$libdir does not exist +hardcode_libdir_flag_spec=$lt_hardcode_libdir_flag_spec_CXX + +# Whether we need a single "-rpath" flag with a separated argument. +hardcode_libdir_separator=$lt_hardcode_libdir_separator_CXX + +# Set to "yes" if using DIR/libNAME\${shared_ext} during linking hardcodes +# DIR into the resulting binary. +hardcode_direct=$hardcode_direct_CXX + +# Set to "yes" if using DIR/libNAME\${shared_ext} during linking hardcodes +# DIR into the resulting binary and the resulting library dependency is +# "absolute",i.e impossible to change by setting \${shlibpath_var} if the +# library is relocated. +hardcode_direct_absolute=$hardcode_direct_absolute_CXX + +# Set to "yes" if using the -LDIR flag during linking hardcodes DIR +# into the resulting binary. +hardcode_minus_L=$hardcode_minus_L_CXX + +# Set to "yes" if using SHLIBPATH_VAR=DIR during linking hardcodes DIR +# into the resulting binary. +hardcode_shlibpath_var=$hardcode_shlibpath_var_CXX + +# Set to "yes" if building a shared library automatically hardcodes DIR +# into the library and all subsequent libraries and executables linked +# against it. +hardcode_automatic=$hardcode_automatic_CXX + +# Set to yes if linker adds runtime paths of dependent libraries +# to runtime path list. +inherit_rpath=$inherit_rpath_CXX + +# Whether libtool must link a program against all its dependency libraries. +link_all_deplibs=$link_all_deplibs_CXX + +# Set to "yes" if exported symbols are required. +always_export_symbols=$always_export_symbols_CXX + +# The commands to list exported symbols. +export_symbols_cmds=$lt_export_symbols_cmds_CXX + +# Symbols that should not be listed in the preloaded symbols. +exclude_expsyms=$lt_exclude_expsyms_CXX + +# Symbols that must always be exported. +include_expsyms=$lt_include_expsyms_CXX + +# Commands necessary for linking programs (against libraries) with templates. +prelink_cmds=$lt_prelink_cmds_CXX + +# Commands necessary for finishing linking programs. +postlink_cmds=$lt_postlink_cmds_CXX + +# Specify filename containing input files. +file_list_spec=$lt_file_list_spec_CXX + +# How to hardcode a shared library path into an executable. +hardcode_action=$hardcode_action_CXX + +# The directories searched by this compiler when creating a shared library. +compiler_lib_search_dirs=$lt_compiler_lib_search_dirs_CXX + +# Dependencies to place before and after the objects being linked to +# create a shared library. +predep_objects=$lt_predep_objects_CXX +postdep_objects=$lt_postdep_objects_CXX +predeps=$lt_predeps_CXX +postdeps=$lt_postdeps_CXX + +# The library search path used internally by the compiler when linking +# a shared library. +compiler_lib_search_path=$lt_compiler_lib_search_path_CXX + +# ### END LIBTOOL TAG CONFIG: CXX +_LT_EOF + + ;; + + esac +done # for ac_tag + + +as_fn_exit 0 +_ACEOF +ac_clean_files=$ac_clean_files_save + +test $ac_write_fail = 0 || + as_fn_error $? "write failure creating $CONFIG_STATUS" "$LINENO" 5 + + +# configure is writing to config.log, and then calls config.status. +# config.status does its own redirection, appending to config.log. +# Unfortunately, on DOS this fails, as config.log is still kept open +# by configure, so config.status won't be able to write to it; its +# output is simply discarded. So we exec the FD to /dev/null, +# effectively closing config.log, so it can be properly (re)opened and +# appended to by config.status. When coming back to configure, we +# need to make the FD available again. +if test "$no_create" != yes; then + ac_cs_success=: + ac_config_status_args= + test "$silent" = yes && + ac_config_status_args="$ac_config_status_args --quiet" + exec 5>/dev/null + $SHELL $CONFIG_STATUS $ac_config_status_args || ac_cs_success=false + exec 5>>config.log + # Use ||, not &&, to avoid exiting from the if with $? = 1, which + # would make configure fail if this is the last instruction. + $ac_cs_success || as_fn_exit 1 +fi +if test -n "$ac_unrecognized_opts" && test "$enable_option_checking" != no; then + { $as_echo "$as_me:${as_lineno-$LINENO}: WARNING: unrecognized options: $ac_unrecognized_opts" >&5 +$as_echo "$as_me: WARNING: unrecognized options: $ac_unrecognized_opts" >&2;} +fi + diff --git a/libconfig-1.4.9/configure.ac b/libconfig-1.4.9/configure.ac new file mode 100644 index 0000000000000000000000000000000000000000..e3f64c2154f2032411b0d735c8b80dc53eeff6a6 --- /dev/null +++ b/libconfig-1.4.9/configure.ac @@ -0,0 +1,135 @@ +dnl Process this file with autoconf to produce a configure script. + +AC_INIT(libconfig, 1.4.9, hyperrealm@gmail.com, libconfig, + [http://www.hyperrealm.com/main.php?s=libconfig]) +AC_CONFIG_AUX_DIR([aux-build]) +AC_CONFIG_MACRO_DIR([m4]) +AC_CANONICAL_TARGET +AM_INIT_AUTOMAKE +AM_CONFIG_HEADER(ac_config.h) + +AC_MSG_NOTICE([libconfig - made with pride in California]) +sleep 3 + +AC_DEFINE_UNQUOTED(TARGET, "${target}", [Configured target name.]) + +# Enable GNU extensions. +AC_GNU_SOURCE + +LT_INIT() + +dnl Checks for programs. +AC_PROG_CC +AM_PROG_CC_C_O +AC_PROG_CXX +AC_LIBTOOL_WIN32_DLL +AC_PROG_LIBTOOL + +AM_PROG_LEX +if test Z"$LEX" != Zflex; then +cat <(2BJ&E&>|D$Ju}>9|>OpT-e_E*1m)DopZNG z45h;4ASp7gP#U#W)e>maC_nfSsZvTyg@_zMkWz`XNrlp?qNPZV3=LFHgaqaKJTo`; z+A*c=Z@;J6cb<8ld1rQJc5XfnG_F};7>3Z|6MjKt9u5TSp_fiomU>}|pm;)5iJ77p zNwn2>frB73AX5?20tkNEfa?#!jxYt7fj0VPkixtOx8ab1`9-<1mrfL-^wmI+A%F~} z2rQR&ACw8Z2^+&DUckpeE$db z?th-Gn*`fr1d4oDXud0Dyizhhd1VL_5K0kPu5NqQ&nv+K7zh0Yub~iU-6$nWeeTKn z>UN_KF{xY}GhZx0r%dPy1eVgqbo$vfKJ>@mTzz?esPV(=rHg)8QWyEtjjeq*uAlnG z)pH;H?&|T&&uy*Tb>PSQf8BGd>~uxZ>C&lxJKq0?Pxvas#QP2=EPOvLCL)V9fM$C= zj}Sb8u>>g>72*VR#UQ?w{{_=McrUQ#o8W&3nByG^{>nrL^t&%&+(A!*M+^Er4?YBJ z0&j;V{}pJj|JA@Bz#oQ%w0{r!^darPRICTSg!~Ud)Bm@i%YoU4^tTK86fhJpTGqDP z+EYn8z7!xwS?AHNp^a|-)SNqIbuVeJ#A3iu|z?_v%J^xrt>05t~X<|EfO z=B@|&NNYaWTRUBd?(g5t=kteu?-upVKx*IneEbA?wl-hv&42ASJmstJ;>kSuYI=+@ z`tcQH%U9ELjJA(20n$L3dt>L3zvlja^XW|+V(gx)#d; zkzI0fD%_r_K&c1&r{ekc9bc~BSa>-zqvtL9&z&=VPD+02VVWg<;pKGS`647?RAp# zeC~GMopOe;)?>N;K>kv&Qk`)P1Cv+>lb+jcXMt1 z4wV>=#GCPFw}Xu`CSxry)&gTKFxCQNEil#sV=bUs0BaPv?$es7TzYbS%6%5s@Z588 zZO*;HQS2>0y_Zj!FQ~QqYdNe{k$wo6do3>TxUb^cmTP?q*C_*7;c#EabnXecpL+!1 z4ftpL1T^ zKS$*&S_0({6vdOS@CAzwF)=u9D^;L~#RLN5K<-4Ws0j~a+Dm*E`MI+!=K5L~*bEj= zGA0}T;Pha1a0>T>#w4S{!|ow5md%5xvItT9T13ZYw6HhqzgJ7oVkVa%IZzqopq zzrx(MederhHv6!HGai+$zciX_Y&YYs)dCX^P9D%VnOG|An%QI~-j;NtCYzGo6)Fro zWoGJ#v64t7+f4ZwmUj@e#KLJ^k0CA{2`jU=-3>>e-L%p%9fRFTcL*z)avf{g@}@a% zxUGQNl37c>%ba*rSVXaKCMK-t-X#1fjg7Um>~YeWcq%yz*s!IY1oBK{-Jy$v*urAK0JExs;!? zJQu{M;-J(b2N?iI63>&!ljnCZn22jpvkCU)NYK0(=HVE4Rhk5?d8-iTcSL`juaAPq z^BR4=Mjk^0!e^LM$>V%(A`(S>BySzkIH!|$2)sjxnDEKEKuKSm*S8>Wt|yQG3$Fpl z4L>l2TneW+>ZFKHrYYR3Wa*Wje!d1pWsw&i{cf@Jz(LrEd2<23Im;;bvv`TutshFZk6kVkn5LG${+>l=kf?#mt?XA~2i z!#>f%I#7Oup#Aax_7p0>{}e5{+~Y_fkMGMfyLZ9+swP2e-s^~K-T-(5;AtD_I{s#X z$G(&2&p3V?{Im4%e&ylu;AZN5cxOF49?(>Rr^|wAFy4zeswBsZJl6*A5-|Ih!aS_U zdkB0F){kdnH%IYD?)x4d*Bb-i@o!EGISd~mXn#Bt4Wa`^d*3VIF`eb|WUBl=ylb%2 zUo8TKycH@cpR_Ujqo8FX9$UdPHGtN2_!r{jYv}~9S_5cpn}CRp)BIELJ{g5KZ3OQq z7F_lyyvIlI`oVi)6yCf7ueM-o$HI+cTnp>Ofb6pEbb21Vr)VgMj#6_hYq^3$u4Cw^ zN0G1qfqjNolix1;LQBUCoOydPYJb}9)trBc)lH9@XBAcsIG-x4O5nVyFiRJ5epHw< ztC|ND<_K2vox*DL>UFBW(5sxkl$|q>nx_=zs#&dr73NGkbaw8St8g6p4d&-eh5BF~ zq4vvLk)gA5zr2-D^MbOo<*@$7_pdN}MSbTAqf;RKo)uRAQ2cHcR$q`_Kl=--dVYt> z{xFqX-z&^jJ;pM=7lkV%)^`PdfzI`aUwqMn_&)sC91{Pq8IX3axQ4_pFbF*27hm=u z^37r2NI=}m%Ze3P#C&7UdrUHL`!Ew)w}*j$>>6O*9tLKVCxM?Xw7(DSzX4dDTtgdp zzc4hff%Q_ydE_#?~zHtgk|^1lnL`^&&r^aEgT`9A~hD)cAIKMkyf@5A|$huv5# zqx^F5AvEVhatz-iq93}n&_9N+Lfi)CX}z*f5k>frbbAQjWbyC_JR5kQF5g!smICYX zVfY>rO~AVUdDpZF*n9Wm0DJF#vdmv-AKnG+2i9UD(mevd3hceBdL7t%cXZ0b=jgr& z%pC{&gLhAtfpz_OcXkcfd$;u|upY1FXio!Eg!gW(7}#r{0PMZ{nhfl{`_jwsmb9C3 zv#qVz8Q6Ac)A|kenx>7Lc)4Xa3`46!9#b@Bwb`MT-P9rS+QZ++D2O=7Ng@srO4H`EG4uyyxR$dP*yzQ zq_G=7#pOjBt`&s6a?SeX%huTISFG6BxXIqMZ26i-zDYEbvSZ<7G~wvi(nWBok9BxD zyw{eOXSOFn?z@m7K7YY{tIcukjuzXEWs|$DNT;wHwyj&Xwkae$cXJQE(9M=K zh$Pw?c7X#4A_JuWX(q%E=>+cFZ3Zaiz!ch$ECoskJ z_mvQqOS=y$Fc0!WGe8*wrqIqZC{ggED4Vhdn4)dBoN*(2P~M(>W`M#+q-guCumk=_ z(EdAM_tvijWl@+PO4P(-;hK14Sv;1=3|i@=Rj+KQy0oubf1C8p=b%qKip4WKWAPmgUa?pHYE~ErP|GIBj zKW_-+0h&WxK}sIMSVJfi3&pRYD<|+rxl_Ou9()v7^Ml|&4$Suf z3hiGiz7O4nal>bu50BfR@ABX$fJYxN1Dl}9e*xO-{{i3#>=+i({w#FEg#QvT4EzY} z>@(*74)k^K4+T6=EQdZc!3V&2OS_SttFPu@TOn+_uRocv({3o`+P1K7+F^G%eX+Fb zq*~&kblORiGB{`tIH`0p5sJs$A$vzH-SjIDi1qdK*lD6VruXDMw{3viNGxGz(oO_k zXv!DVABrV(N>4gt_r?-2VfPN$(QhC*5^_U|=;eUo0*BLSZF3TE>yRy4y1JTIx7l^p za_O=r9upUdpwuR?S0KH7+Z|gu`~P| zMc%INS5D-v`4k>=)#LbQo?JCOM;U$ZZDh+;vxF#Z@12sEB}G}i_l^UTs6*WcTMqms z``2@~baq5JMxq>Ox85G*cp7^W@4@W*X71Fm zA4!?>su3o*dK?^EfIfc^Rk;&=&Uw+mm}*1;JV;E7Dn8+@jK2vANOxxhE&2o;}y`{ zw{StoeKR#a^~uwFu%Low-gD5Sz=;0OfqQ11X(!717UW@wPFvT~vMPAxZQ)G9%>)~) z2CHsaLq?*NS1BwmOli~<<*gEm^;Nq>wU1gVvHDvAJObirtQJDoS#x#pS9z?954S&YMef%%*a|c<-b*(V4sVtmtTx|FQ zivrbwa<1!)`9^hVd9lBAQ7J8D7-zmJQC$2rB%!=~6kTYlD7-faf9a~?Ym3{;Zz%C$ zJQiLq+Blr0JEF^B=UVF++n2p<7foeSwcVVgGSqEML-aef3iRg5aH- zmMp!i+lO71ahY`em6==%?)9u5m~cSy1$~o_CR1)OlSs$<5>6z@ret@ukJ|;chOcV zDR;z{6SaF&p?=4XMvzk@VfDDlR2s!8wXFw6xD55jdQe;vZt!PG-^vd*+{l#d?|1O* zR>TQs`s`3Dl<33JKpqZc!f-H&V~O6RwuQpsl(R!49CJB3jy97${9pYo0*ix+ueLlZ z1mFPGK@K5PlaJ=eOZBcuk1wHUN}iC;oXpNFKi}6?k|~_SzqL z#94^u@mo|09=}oK@w=ya46M;;GZ#xKBo)x+aqiaBqxESM(B z{Vn3`3;L61;^2)Tj%v!la#@eJAi7+hah;pNAGv?_@VHhv4<5&X4&+c+hW5wv(h_vk zOwaod@R-i}@f4}z0=$p&{`6QPZ!OYvU|AHNBT?(H6}+GZ(7F!AAbEMaz^nG~v~AHe z-jBiia0cEL(|CulShHu~T{DgMF?jdSz-!L)YV)=X7JYmdbbwjbAK7Kw>GUE@lI=9+ zgN{;j%NT!E->aPGl$|q`n$Hwgw-=nZ6y}UPd9Lo4 zD|pP`6L!vMYAH$Wmp3Mp=j?uYW1;2`WoOH&J0peJE0~ioA1I8@L*RR_u=423WU;fgKX( z)VK5f<3oRR0LxQnXamm|g67#YM-p)ox(VmrP#E{66Yo7S%l{_yr}_40`TK!S<@?LP zP0Dx4%l8M%e+;-RZ>PU!fOVk1Qvf`;X3rUTll}(HgKJFR5_A6IdfNY}?#Dz*UY@nZNc5q-dVJn)_>1?;^yx*ynk zZ*>4zhae({r(v#xy!Tp90(_a3f%n*CDXL;3N*@~#E;-kUW6bNvAmdb336rF~DzO}m-iUhFn(yQOnOhuz+` zv6DAp_L?c^rWTJWlC=Bc$#5uc%Vo43$_xrDkq6?A>qM*-jg7T}20IoRB&ru`B_7H2 z_YdiETGy|U#jNdUzPZ)bh{fpmWGQmZE=y^-IkeruZC49Qi^ZK3_83;rz<{tfwb!lS zy4&_#ATV{MOvD9(u-CP3Sl!%iZ&+kgxxiXK z6&kYTU7PJmkUKqOh^<(;!s>Hed!Wa5qnX5ZD?BLdHFvIWzPYVM%zTxnuKToyFTQ}x lUks{j)9(?RnkH}jrtR_mudBqFt~;BWJQs}W@=|WR{taBBe)9kT literal 0 HcmV?d00001 diff --git a/libconfig-1.4.9/contrib/cmake/CMakeFiles/CMakeOutput.log b/libconfig-1.4.9/contrib/cmake/CMakeFiles/CMakeOutput.log new file mode 100644 index 0000000000000000000000000000000000000000..9314bb2fa57b4a29c8a833336eae0674f2138462 --- /dev/null +++ b/libconfig-1.4.9/contrib/cmake/CMakeFiles/CMakeOutput.log @@ -0,0 +1,89 @@ +The system is: Linux - 2.6.31-20-generic-pae - i686 +Compiling the C compiler identification source file "CMakeCCompilerId.c" succeeded. +Compiler: /usr/bin/gcc +Build flags: +Id flags: + +The output was: +0 + + +Compilation of the C compiler identification source "CMakeCCompilerId.c" produced "a.out" + +The C compiler identification is GNU, found in "/home/markl/download/libconfig_test_app/CMakeFiles/CompilerIdC/a.out" + +Compiling the CXX compiler identification source file "CMakeCXXCompilerId.cpp" succeeded. +Compiler: /usr/bin/c++ +Build flags: +Id flags: + +The output was: +0 +CMakeCXXCompilerId.cpp:67: warning: deprecated conversion from string constant to 'char*' +CMakeCXXCompilerId.cpp:157: warning: deprecated conversion from string constant to 'char*' + + +Compilation of the CXX compiler identification source "CMakeCXXCompilerId.cpp" produced "a.out" + +The CXX compiler identification is GNU, found in "/home/markl/download/libconfig_test_app/CMakeFiles/CompilerIdCXX/a.out" + +Determining if the C compiler works passed with the following output: +Change Dir: /home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp + +Run Build Command:/usr/bin/make "cmTryCompileExec/fast" +/usr/bin/make -f CMakeFiles/cmTryCompileExec.dir/build.make CMakeFiles/cmTryCompileExec.dir/build +make[1]: Entering directory `/home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp' +/usr/bin/cmake -E cmake_progress_report /home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp/CMakeFiles 1 +Building C object CMakeFiles/cmTryCompileExec.dir/testCCompiler.c.o +/usr/bin/gcc -o CMakeFiles/cmTryCompileExec.dir/testCCompiler.c.o -c /home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp/testCCompiler.c +Linking C executable cmTryCompileExec +/usr/bin/cmake -E cmake_link_script CMakeFiles/cmTryCompileExec.dir/link.txt --verbose=1 +/usr/bin/gcc CMakeFiles/cmTryCompileExec.dir/testCCompiler.c.o -o cmTryCompileExec -rdynamic +make[1]: Leaving directory `/home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp' + + +Detecting C compiler ABI info compiled with the following output: +Change Dir: /home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp + +Run Build Command:/usr/bin/make "cmTryCompileExec/fast" +/usr/bin/make -f CMakeFiles/cmTryCompileExec.dir/build.make CMakeFiles/cmTryCompileExec.dir/build +make[1]: Entering directory `/home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp' +/usr/bin/cmake -E cmake_progress_report /home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp/CMakeFiles 1 +Building C object CMakeFiles/cmTryCompileExec.dir/CMakeCCompilerABI.c.o +/usr/bin/gcc -o CMakeFiles/cmTryCompileExec.dir/CMakeCCompilerABI.c.o -c /usr/share/cmake-2.6/Modules/CMakeCCompilerABI.c +Linking C executable cmTryCompileExec +/usr/bin/cmake -E cmake_link_script CMakeFiles/cmTryCompileExec.dir/link.txt --verbose=1 +/usr/bin/gcc CMakeFiles/cmTryCompileExec.dir/CMakeCCompilerABI.c.o -o cmTryCompileExec -rdynamic +make[1]: Leaving directory `/home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp' + + +Determining if the CXX compiler works passed with the following output: +Change Dir: /home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp + +Run Build Command:/usr/bin/make "cmTryCompileExec/fast" +/usr/bin/make -f CMakeFiles/cmTryCompileExec.dir/build.make CMakeFiles/cmTryCompileExec.dir/build +make[1]: Entering directory `/home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp' +/usr/bin/cmake -E cmake_progress_report /home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp/CMakeFiles 1 +Building CXX object CMakeFiles/cmTryCompileExec.dir/testCXXCompiler.cxx.o +/usr/bin/c++ -o CMakeFiles/cmTryCompileExec.dir/testCXXCompiler.cxx.o -c /home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp/testCXXCompiler.cxx +Linking CXX executable cmTryCompileExec +/usr/bin/cmake -E cmake_link_script CMakeFiles/cmTryCompileExec.dir/link.txt --verbose=1 +/usr/bin/c++ CMakeFiles/cmTryCompileExec.dir/testCXXCompiler.cxx.o -o cmTryCompileExec -rdynamic +make[1]: Leaving directory `/home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp' + + +Detecting CXX compiler ABI info compiled with the following output: +Change Dir: /home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp + +Run Build Command:/usr/bin/make "cmTryCompileExec/fast" +/usr/bin/make -f CMakeFiles/cmTryCompileExec.dir/build.make CMakeFiles/cmTryCompileExec.dir/build +make[1]: Entering directory `/home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp' +/usr/bin/cmake -E cmake_progress_report /home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp/CMakeFiles 1 +Building CXX object CMakeFiles/cmTryCompileExec.dir/CMakeCXXCompilerABI.cpp.o +/usr/bin/c++ -o CMakeFiles/cmTryCompileExec.dir/CMakeCXXCompilerABI.cpp.o -c /usr/share/cmake-2.6/Modules/CMakeCXXCompilerABI.cpp +Linking CXX executable cmTryCompileExec +/usr/bin/cmake -E cmake_link_script CMakeFiles/cmTryCompileExec.dir/link.txt --verbose=1 +/usr/bin/c++ CMakeFiles/cmTryCompileExec.dir/CMakeCXXCompilerABI.cpp.o -o cmTryCompileExec -rdynamic +make[1]: Leaving directory `/home/markl/download/libconfig_test_app/CMakeFiles/CMakeTmp' + + diff --git a/libconfig-1.4.9/contrib/cmake/CMakeFiles/CMakeSystem.cmake b/libconfig-1.4.9/contrib/cmake/CMakeFiles/CMakeSystem.cmake new file mode 100644 index 0000000000000000000000000000000000000000..24477a5e0ad93d022ddb024ee48ed4c054085da5 --- /dev/null +++ b/libconfig-1.4.9/contrib/cmake/CMakeFiles/CMakeSystem.cmake @@ -0,0 +1,15 @@ + + +SET(CMAKE_SYSTEM "Linux-2.6.31-20-generic-pae") +SET(CMAKE_SYSTEM_NAME "Linux") +SET(CMAKE_SYSTEM_VERSION "2.6.31-20-generic-pae") +SET(CMAKE_SYSTEM_PROCESSOR "i686") + +SET(CMAKE_HOST_SYSTEM "Linux-2.6.31-20-generic-pae") +SET(CMAKE_HOST_SYSTEM_NAME "Linux") +SET(CMAKE_HOST_SYSTEM_VERSION "2.6.31-20-generic-pae") +SET(CMAKE_HOST_SYSTEM_PROCESSOR "i686") + +SET(CMAKE_CROSSCOMPILING "FALSE") + +SET(CMAKE_SYSTEM_LOADED 1) diff --git a/libconfig-1.4.9/contrib/cmake/CMakeFiles/CompilerIdC/CMakeCCompilerId.c b/libconfig-1.4.9/contrib/cmake/CMakeFiles/CompilerIdC/CMakeCCompilerId.c new file mode 100644 index 0000000000000000000000000000000000000000..7fd008853e62a4a9d2037765aa258bd53527ed1e --- /dev/null +++ b/libconfig-1.4.9/contrib/cmake/CMakeFiles/CompilerIdC/CMakeCCompilerId.c @@ -0,0 +1,182 @@ +#ifdef __cplusplus +# error "A C++ compiler has been selected for C." +#endif + +#if defined(__18CXX) +# define ID_VOID_MAIN +#endif + +#if defined(__INTEL_COMPILER) || defined(__ICC) +# define COMPILER_ID "Intel" + +#elif defined(__BORLANDC__) +# define COMPILER_ID "Borland" + +#elif defined(__WATCOMC__) +# define COMPILER_ID "Watcom" + +#elif defined(__SUNPRO_C) +# define COMPILER_ID "SunPro" + +#elif defined(__HP_cc) +# define COMPILER_ID "HP" + +#elif defined(__DECC) +# define COMPILER_ID "Compaq" + +#elif defined(__IBMC__) +# define COMPILER_ID "VisualAge" + +#elif defined(__PGI) +# define COMPILER_ID "PGI" + +#elif defined(__GNUC__) +# define COMPILER_ID "GNU" + +#elif defined(_MSC_VER) +# define COMPILER_ID "MSVC" + +#elif defined(__ADSPBLACKFIN__) || defined(__ADSPTS__) || defined(__ADSP21000__) +/* Analog Devices C++ compiler for Blackfin, TigerSHARC and + SHARC (21000) DSPs */ +# define COMPILER_ID "ADSP" + +/* IAR Systems compiler for embedded systems. + http://www.iar.com + Not supported yet by CMake +#elif defined(__IAR_SYSTEMS_ICC__) +# define COMPILER_ID "IAR" */ + +/* sdcc, the small devices C compiler for embedded systems, + http://sdcc.sourceforge.net */ +#elif defined(SDCC) +# define COMPILER_ID "SDCC" + +#elif defined(_COMPILER_VERSION) +# define COMPILER_ID "MIPSpro" + +/* This compiler is either not known or is too old to define an + identification macro. Try to identify the platform and guess that + it is the native compiler. */ +#elif defined(__sgi) +# define COMPILER_ID "MIPSpro" + +#elif defined(__hpux) || defined(__hpua) +# define COMPILER_ID "HP" + +#else /* unknown compiler */ +# define COMPILER_ID "" + +#endif + +/* Construct the string literal in pieces to prevent the source from + getting matched. Store it in a pointer rather than an array + because some compilers will just produce instructions to fill the + array rather than assigning a pointer to a static array. */ +char* info_compiler = "INFO" ":" "compiler[" COMPILER_ID "]"; + +/* Identify known platforms by name. */ +#if defined(__linux) || defined(__linux__) || defined(linux) +# define PLATFORM_ID "Linux" + +#elif defined(__CYGWIN__) +# define PLATFORM_ID "Cygwin" + +#elif defined(__MINGW32__) +# define PLATFORM_ID "MinGW" + +#elif defined(__APPLE__) +# define PLATFORM_ID "Darwin" + +#elif defined(_WIN32) || defined(__WIN32__) || defined(WIN32) +# define PLATFORM_ID "Windows" + +#elif defined(__FreeBSD__) || defined(__FreeBSD) +# define PLATFORM_ID "FreeBSD" + +#elif defined(__NetBSD__) || defined(__NetBSD) +# define PLATFORM_ID "NetBSD" + +#elif defined(__OpenBSD__) || defined(__OPENBSD) +# define PLATFORM_ID "OpenBSD" + +#elif defined(__sun) || defined(sun) +# define PLATFORM_ID "SunOS" + +#elif defined(_AIX) || defined(__AIX) || defined(__AIX__) || defined(__aix) || defined(__aix__) +# define PLATFORM_ID "AIX" + +#elif defined(__sgi) || defined(__sgi__) || defined(_SGI) +# define PLATFORM_ID "IRIX" + +#elif defined(__hpux) || defined(__hpux__) +# define PLATFORM_ID "HP-UX" + +#elif defined(__HAIKU) || defined(__HAIKU__) || defined(_HAIKU) +# define PLATFORM_ID "Haiku" +/* Haiku also defines __BEOS__ so we must + put it prior to the check for __BEOS__ +*/ + +#elif defined(__BeOS) || defined(__BEOS__) || defined(_BEOS) +# define PLATFORM_ID "BeOS" + +#elif defined(__QNX__) || defined(__QNXNTO__) +# define PLATFORM_ID "QNX" + +#elif defined(__tru64) || defined(_tru64) || defined(__TRU64__) +# define PLATFORM_ID "Tru64" + +#elif defined(__riscos) || defined(__riscos__) +# define PLATFORM_ID "RISCos" + +#elif defined(__sinix) || defined(__sinix__) || defined(__SINIX__) +# define PLATFORM_ID "SINIX" + +#elif defined(__UNIX_SV__) +# define PLATFORM_ID "UNIX_SV" + +#elif defined(__bsdos__) +# define PLATFORM_ID "BSDOS" + +#elif defined(_MPRAS) || defined(MPRAS) +# define PLATFORM_ID "MP-RAS" + +#elif defined(__osf) || defined(__osf__) +# define PLATFORM_ID "OSF1" + +#elif defined(_SCO_SV) || defined(SCO_SV) || defined(sco_sv) +# define PLATFORM_ID "SCO_SV" + +#elif defined(__ultrix) || defined(__ultrix__) || defined(_ULTRIX) +# define PLATFORM_ID "ULTRIX" + +#elif defined(__XENIX__) || defined(_XENIX) || defined(XENIX) +# define PLATFORM_ID "Xenix" + +#else /* unknown platform */ +# define PLATFORM_ID "" + +#endif + +/* Construct the string literal in pieces to prevent the source from + getting matched. Store it in a pointer rather than an array + because some compilers will just produce instructions to fill the + array rather than assigning a pointer to a static array. */ +char* info_platform = "INFO" ":" "platform[" PLATFORM_ID "]"; + + +/*--------------------------------------------------------------------------*/ + +#ifdef ID_VOID_MAIN +void main() {} +#else +int main(int argc, char* argv[]) +{ + int require = 0; + require += info_compiler[argc]; + require += info_platform[argc]; + (void)argv; + return require; +} +#endif diff --git a/libconfig-1.4.9/contrib/cmake/CMakeFiles/CompilerIdC/a.out b/libconfig-1.4.9/contrib/cmake/CMakeFiles/CompilerIdC/a.out new file mode 100755 index 0000000000000000000000000000000000000000..b18090c853e4fc82112c4e79c35017298219a41b GIT binary patch literal 8337 zcmeHMYiv}<6`p%{ZEtF0{Gu_%O%`G&;Rn|bT!cvz9)5sRgA*G_z=6xI_u9K{Aw%<2% z$6gz!kN-Z}Gc#w-H)rOanS1Wc&hzbE9fn~DO{VY(DP{eEW>oH~QkrHF6an$5s1<8P zA*!fr9t8$08=z4E>il3Ib+LJzKlOs0;u$&%O>{Cgmz(0M_A7H=bbgpd= z4kZ(I+6|>#+ZK4#em>$RVRv?;HWEwNnY0rDjw%l~6pAIp&aTcKt#*^u08=1S`ocg; zzmQ2~vDgag9#f*2#rzd=kU#PVije!6<01E*x!#+-<)0y}@8r}|UlwBQJ9l!q+^OHX z1v3wzcIGOR@1xDLeOIP(U-=Z4a&>o*vQ4gz7NacQ_yEmvb+jC%?#47kDoBlgI(+8C z>>p>J+S?PI#hQ-_IOFO4(VwF{a~Z(flMBcj*XZNbFefrw&($EmP>o(s-mF6U_Gf1H zrqOaO{lLVVw4c3Xyh=!}>J-%y-f}H9^KJnR7}XKXW7VA*B@3Oy^b-C#)QQU}&s8FyS{>zA08-ykxZB8CzAgL}mM( zD^qB@xW8xi_s(>~(#feCYcSwjH8aoO&E+O8RO9IXOO4W4NX>K zgVk8ypU&_Q9^Bp=Y_ggfgfV(X_Q1*T8yk@tCyQ1Buv14Yj=^B1rizrP6J5tIr#kr=CAVp`ziDZG&9Fk#>z zURZ8a7{0)oKwY4cYs)A%>Pjn%eWhzksVT!cGiyb0@e`;*e_j#O>Q_ZrZx+7NEya%& zcUEpKF|i&C9~PZlPS1c%f&VOoVSHA)0;&A}2c9*SaHtU4qtf*SCTGxhNf;Z~Ha}js z&Q~2gaB%Iq=lV>X^o@t4X`I#XH7#O^m}~Vzg+EaK%iN@+$&?$+B+{|LgcAwUm7K0t zZ{aC5YZtARcrq~ui3NfUUCN0QuL{F)S6K9v zuv}*Z=>P<%l97-b5|$IS2U4LSM_B!CGL=RLD*Jjr48cffDAtb-l4yv;lGaqqa2jZw zn}-}ctrc;?nL#_03MB>|T9M*#CJY1fax5{B)VfeOoN|t734eTH2&xslBN-6>qC;!KTB8ajk{$E9E1Z!LraW@KFt<cs>*u|G7vuIo&)7~Jz|Vu)jGCysG_KMD-ex?k3lkAnFvV42^8BPaw>&hHnZ_!js+Fme2zjG~ZlkIzau z3)VP(e@+9(akF23>ojg0Wsa5g{0^Q4t^s9D#F1VCYutOly|)C8*q8Hgj3{&x=R_07 zKspQ7_W0c$M`M0dH0geSfC}Q!op>F%*P&Qye6QuFq({)1T!&{BT64n6HP zfJwx4sG>}%BY*7WvJ%M=;DTB}u5JGdW#ToB0#~O6I3_ZhOW*1GA_TuDsPIS^nR6{`nprKxBqre@ zR5XJ*A9ytR?s6_PjXWU4>b!>9p4R8*jK7q<8y^{Gm8=Xfo+?@Oz__VowHg>7mCVSh z;-Hebf>pdzvRb`*zv}a5mGMjI8G(e1Q%dIUS?!0F%t))^j*__>7lQFc$&6GW#u1QD zU`qsIykPE=H!vzLD4CuUg73eQIVI=p9R>|rO()(zix4Y+isPtcC zCinSD=I$PA8SjgdtEDWj5K!_7Ol}_eY<*&YuM(w@_51}zwP5_w^EO%4CDD8Qq0ETjrBK{)ortxmrKLeoVaFmPl$wOxHQSNQ(9m(+Py3!W*-b~!_TBBa zme`Fh&-WsC+p?F|-JzpSYpZtw)fwTqcXoB}*xqG#cXaf&@3r@C-_h01@$(6>$4-Tg z+fITPrg;_eOeO5L1ADgb?ras@qpPb_z~sFuj;OZW`_EM`xR$k_JZASegRwM@Cav*M zI*o0+JuqxXzln@ThI_7Ow{4rhpIvlpvh4-^N76|<8cIas4y?#Y&<>d!8J`3*IFPjU vy&Ir7Vt9j<8huG8)YCii90Dh7+PujcbXa-lIYmQWj2{E?=lY5PZ&w2@i?QYu8`Gz2MXY1&Gt>IYF9$q3p|)kR2HTz|ir z9dmXarTw?^lit30^M3PY_RZ|<4#2?>cM-$Q97Zv>{tEgb*l84!|Lqs{<|~r5{V~{~ z{s(FQ9k3U+uLO0GSsp^v#A7`*@yP0UERh|sGD)jm+0b-p-?II2>6`CCpLi8nmTh3{ zXb-IaLux$w%K)C2z0*2v-?JbLmi+H@P3mhpllv0f5=k|=e1ByN?cq|WqU+ksPW ze&sLckeotnpQa!ZU(gC9^}zzY9O*US_c2bGP5o)`F~pPgEM!L^4jDHRe&7KHVV$t; zzW!vw&bXnpYumzp^q}40^u;o+lWvZOG8rdB$iRS|a?+V(A{39ggZ9B%y6IOQkm?JE z?F_X#=7&AcZ9CvL5=+?Gj1z$un!JkoL$QQt-o3kNQ=469tr1(=+cq`Z^;RufNm3); zKm-{>#vlm(%})*>RDLmxG>O)yAa#t&VzK!w`)wLQ*D(&~(7{PFFc;FKL?;C(5s=4^ ze%zV6W^$N{?!%*pmJ2cbt%-a-f8;~AXlw;?$3EiY4V2y8ePJ}e_9i^$t0(YenS3=p zN142G8O8F|tRYIE2Hy;qF<{66C0KX+}(YbG2XIp>z2VIC6m&YM-t%U`@OdR$`4 z&bLm`IJ|ff91XVyMoiy=Q)0o{b4KgL@Zu#iWVTLR7)9CX^*ynxb8H7Z9Uh&x3=O`v zd@Ol8pC5T!;O$3peBOWloxJZz-mR*;G2B{qw51C5l|Y!N_NZBvfBC0G<=!(k+)n=~ z_wMrU{r0}m;pJ7M$Jti)>ua2+ayRpC#oJ8v9?xAh^B0Hx$jXkZAWUNQ7c&M0Bbq9KGu@2%5{|HtzNprlTSgGfTLJVVbL$*-X7-->@ELwJD>aK9o9Y@+8ZG|CNsU|FC# zP{A=~EHtW1D~kQ4%Sve}!+7&miQ?jik%juaB)Za6NqBD%{?d)b4;HsoJW}GrxSVsZ zXydSY0_+p@bZXoxosXwH2SQ|x83HPVj;IWMk&h=t{&T`uQ`zuP^-BMe;GQQdSMKfh zVW(_-QM$foCf6dCh`Cl6CLEM}M&D$j$+R2HCNiD ziwKKaG?a-7D>9gXKPBC?vK++WMl6|_qS&ydojCC-k&3&*Vx)xSIsJO=gv(HWER5=saD#^>eJejb8KAM-?04|)R>bMa z_SvCyDA9+b7*9=Qd*I-X9!vBlwJp@slXebj4aZ%MP9tWrhySYwcI9&J<)>0rRd z*pW_vHIDz{I69I47frg}SCK&+-**VOA>d|e-wz9L@=O>w{+Bgre?LQp_V)q&eE^(1 zOYwjjchgXD0;z4wrs3WM z?vojC_f5mSf<>D>18(g!+%4cU#kA~hc?T{+;qt8`TZ z=U1hxUgkWibbLf0&X-E(2v+l=($(nIYhAzBtDNVQoiml1&y>!Uw^~apoinnUpOnrS z6m!UAdCq7;E+r}b0v{oW^9rS3-p;7`L+Om1x;s)jdqoJ&2TDihfp`k6boD3W_pNj_ zv+z4sy4o4&HMw8h#cX+>pzPcks6B(y)fdR`OzBH0banyx1^=#h$UkMKB5pL~D#!j!Vn>yL6@saOM@_g5SztbaXpu0Nnc$M@}RF~Vs# z<7Rt%vD>ii=B^zbc6(cA7jGWzmMPk!%>|}N((a2VdqQzrE~D*Gc0lk#ChoXS#9Fsu zL#?2}jztEj)eE%}k7WD%2X#HI+goHcn>(7ewc1)^H9CE#7P)4ZwKQ)F9dK|{+3a2a zv_-6NDkbbK?K?I#wc9&3Z|-dEvb&l#wYTye_?B3$r$d9bli;OiL5AF`3A<&__NHxZ z&4R0absY+ryc@;V*Oq&V$?VU*o9#{6(XR@x*z_yb#>P7rtJAh)wmqf(NG54VLy1V- zL1Sb`=%7rtjBkQo>`mJG-V0D{R=mbai@qci>g^r5qnYXcxUsR|_7_oFw| +#include +#include + +using namespace std; +using namespace libconfig; + +int main ( int argc, char **argv ) +{ + Config cfg; + + return (0); +} \ No newline at end of file diff --git a/libconfig-1.4.9/contrib/copy_setting.c b/libconfig-1.4.9/contrib/copy_setting.c new file mode 100644 index 0000000000000000000000000000000000000000..1b20e5995f1078db2792d2dad828b75ba4fa4944 --- /dev/null +++ b/libconfig-1.4.9/contrib/copy_setting.c @@ -0,0 +1,161 @@ +void config_setting_copy_simple(config_setting_t * parent, const config_setting_t * src); +void config_setting_copy_elem(config_setting_t * parent, const config_setting_t * src); + +void config_setting_copy_aggregate(config_setting_t * parent, const config_setting_t * src); +int config_setting_copy(config_setting_t * parent, const config_setting_t * src); + +void config_setting_copy_simple(config_setting_t * parent, const config_setting_t * src) +{ + if(config_setting_is_aggregate(src)) + { + config_setting_copy_aggregate(parent, src); + } + else + { + config_setting_t * set; + + set = config_setting_add(parent, config_setting_name(src), config_setting_type(src)); + + if(CONFIG_TYPE_INT == config_setting_type(src)) + { + config_setting_set_int(set, config_setting_get_int(src)); + config_setting_set_format(set, src->format); + } + else if(CONFIG_TYPE_INT64 == config_setting_type(src)) + { + config_setting_set_int64(set, config_setting_get_int64(src)); + config_setting_set_format(set, src->format); + } + else if(CONFIG_TYPE_FLOAT == config_setting_type(src)) + config_setting_set_float(set, config_setting_get_float(src)); + else if(CONFIG_TYPE_STRING == config_setting_type(src)) + config_setting_set_string(set, config_setting_get_string(src)); + else if(CONFIG_TYPE_BOOL == config_setting_type(src)) + config_setting_set_bool(set, config_setting_get_bool(src)); + } +} + +void config_setting_copy_elem(config_setting_t * parent, const config_setting_t * src) +{ + config_setting_t * set; + + set = NULL; + if(config_setting_is_aggregate(src)) + config_setting_copy_aggregate(parent, src); + else if(CONFIG_TYPE_INT == config_setting_type(src)) + { + set = config_setting_set_int_elem(parent, -1, config_setting_get_int(src)); + config_setting_set_format(set, src->format); + } + else if(CONFIG_TYPE_INT64 == config_setting_type(src)) + { + set = config_setting_set_int64_elem(parent, -1, config_setting_get_int64(src)); + config_setting_set_format(set, src->format); + } + else if(CONFIG_TYPE_FLOAT == config_setting_type(src)) + set = config_setting_set_float_elem(parent, -1, config_setting_get_float(src)); + else if(CONFIG_TYPE_STRING == config_setting_type(src)) + set = config_setting_set_string_elem(parent, -1, config_setting_get_string(src)); + else if(CONFIG_TYPE_BOOL == config_setting_type(src)) + set = config_setting_set_bool_elem(parent, -1, config_setting_get_bool(src)); +} + +void config_setting_copy_aggregate(config_setting_t * parent, const config_setting_t * src) +{ + config_setting_t * newAgg; + int i, n; + + newAgg = config_setting_add(parent, config_setting_name(src), config_setting_type(src)); + + n = config_setting_length(src); + for(i = 0; i < n; i++) + { + if(config_setting_is_group(src)) + { + config_setting_copy_simple(newAgg, config_setting_get_elem(src, i)); + } + else + { + config_setting_copy_elem(newAgg, config_setting_get_elem(src, i)); + } + } +} + +int config_setting_copy(config_setting_t * parent, const config_setting_t * src) +{ + if((!config_setting_is_group(parent)) && + (!config_setting_is_list(parent))) + return CONFIG_FALSE; + + if(config_setting_is_aggregate(src)) + { + config_setting_copy_aggregate(parent, src); + } + else + { + config_setting_copy_simple(parent, src); + } + + return CONFIG_TRUE; +} + + +//Some sample code + +//----------------------------------------------------------------------------- +int main(int argc, char *argv[]) +//----------------------------------------------------------------------------- +{ + config_t cfgSrc; + config_t cfgSrcCopy; + config_t cfgDst; + + + config_init(&cfgSrc); + config_init(&cfgSrcCopy); + config_init(&cfgDst); + + if(CONFIG_FALSE == config_read_file(&cfgSrc, "/data/menu/cfgSrc.cfg")) + { + fprintf(stderr, "Failed to open cfgSrc.cfg\n"); + } + if(CONFIG_FALSE == config_read_file(&cfgDst, "/data/menu/cfgDst.cfg")) + { + fprintf(stderr, "Failed to open cfgDst.cfg\n"); + } + + /* + printf("Dump cfgSrc.cfg\n"); + DumpCfgSetting(config_root_setting(&cfgSrc)); + + printf("Dump cfgDst.cfg\n"); + DumpCfgSetting(config_root_setting(&cfgDst)); + */ + + config_setting_t * src; + config_setting_t * dst; + + dst = config_lookup(&cfgDst, "grp1"); + + if((0 != (dst = config_lookup(&cfgDst, "grp1"))) && + (0 != (src = config_lookup(&cfgSrc, "application.window")))) + //(0 != (src = config_lookup(&cfgSrc, "list")))) + + { + if(CONFIG_FALSE == config_setting_copy(dst, src)) + { + printf("Failed to copy src to dst\n"); + } + } + + config_setting_copy(config_root_setting(&cfgSrcCopy), config_root_setting(&cfgSrc)); + + config_write_file(&cfgDst, "/data/menu/cfgDstMod.cfg"); + config_write_file(&cfgSrcCopy, "/data/menu/cfgSrcCpy.cfg"); + config_write_file(&cfgSrc, "/data/menu/cfgSrcOrig.cfg"); + + config_destroy(&cfgSrc); + config_destroy(&cfgDst); + + return 0; +} diff --git a/libconfig-1.4.9/contrib/libconfig-ruby/README b/libconfig-1.4.9/contrib/libconfig-ruby/README new file mode 100644 index 0000000000000000000000000000000000000000..1a45477be1fbe9a9565c5da847353df7dd96c852 --- /dev/null +++ b/libconfig-1.4.9/contrib/libconfig-ruby/README @@ -0,0 +1,76 @@ +# << Usage >> + +# you can feed this README to irb and see the result +# $ irb README + +# IMPORTANT NOTICE: +# be careful with big *fixnum* (plain int) values in configs +# int is 32 bit, but ruby fixnum is only 31! +# For example, 2100000000 will be read as -47483648. + +require 'rconfig' +c = Config.new + +c.read!('test.cfg') +# => IOError +c.read('test.cfg') +# => false + +p c['some_var'] +# => SettingNotFoundError +# note: Config#lookup is alias for Config#[] + +c.append 'fixnum', Config::Fixnum.new(150) +# # + +f1 = Config::Fixnum.new(1) +c.append 'another_fixnum', f1 + +f2 = Config::Fixnum.new(256) +c.append 'next_fixnum', f2 + +p c.size +# => 3 + +c.delete(f1) # by element +c.delete(0) # by index +c.delete('next_fixnum') # by name +# note: (at now) you cannot delete nested elements by Config#delete +# you can do c['nested.element'].parent.delete(c['nested.element']) + +p c.size +# => 0 + +l = Config::List.new +c.append 'the_list', l + +l.append Config::String.new("abcdef") +l << Config::Float.new(3.14) +# note: Config::List#append and Config::Array#append both have +# aliases Config::[Aggregate]#<< + +p l.name +# => "the_list" + +p l.index +# => 0 + +p l.root? +# => false + +p l.size +# => 3 + +l[0].format = Config::FORMAT_HEX + +p l[1].value +# => 3.14 + +l[1].value = 2.71828 + +c.write 'test.cfg' + +# you will get test.cfg with following contents: +# +# the_list = ( "abcdef", 2.71828, 0x2A ); +# diff --git a/libconfig-1.4.9/contrib/libconfig-ruby/Rakefile b/libconfig-1.4.9/contrib/libconfig-ruby/Rakefile new file mode 100644 index 0000000000000000000000000000000000000000..62dc34d43d87ba430c6cca4e72ed0611ac7ec70a --- /dev/null +++ b/libconfig-1.4.9/contrib/libconfig-ruby/Rakefile @@ -0,0 +1,17 @@ +require 'rubygems' +require 'rake/gempackagetask' + +spec = Gem::Specification.new do |s| + s.name = "rconfig" + s.version = "1.0" + s.author = "Peter Zotov" + s.email = "whitequark@whitequark.ru" + s.platform = Gem::Platform::RUBY + s.summary = "libconfig bindings" + s.files = [ File.join('ext', 'extconf.rb'), File.join('ext', 'rconfig.c') ].to_a + s.extensions = 'ext/extconf.rb' +end + +Rake::GemPackageTask.new(spec) do |pkg| +end + diff --git a/libconfig-1.4.9/contrib/libconfig-ruby/ext/extconf.rb b/libconfig-1.4.9/contrib/libconfig-ruby/ext/extconf.rb new file mode 100644 index 0000000000000000000000000000000000000000..e6d65ca69008dd7207aaf2ca2d8f7f66437543c4 --- /dev/null +++ b/libconfig-1.4.9/contrib/libconfig-ruby/ext/extconf.rb @@ -0,0 +1,11 @@ +#!/usr/bin/ruby +require "mkmf" + +unless pkg_config('libconfig') + puts 'failure: need libconfig' + exit 1 +end + +have_func('rb_block_call', 'ruby/ruby.h') + +create_makefile("rconfig") diff --git a/libconfig-1.4.9/contrib/libconfig-ruby/ext/rconfig.c b/libconfig-1.4.9/contrib/libconfig-ruby/ext/rconfig.c new file mode 100644 index 0000000000000000000000000000000000000000..c111cd639dc03d17ee44ab967f2e97c64e7c963b --- /dev/null +++ b/libconfig-1.4.9/contrib/libconfig-ruby/ext/rconfig.c @@ -0,0 +1,700 @@ +#include +#include + +static VALUE cConfig, cConfigBaseSetting, cConfigSetting, cConfigAggregate; +static VALUE cConfigFormatDefault, cConfigFormatHex; +static VALUE cConfigFixnum, cConfigBignum, cConfigFloat, cConfigBoolean, cConfigString; +static VALUE cConfigGroup, cConfigList, cConfigArray; + +static VALUE rSettingNameRegexp; +static VALUE aConfigSettings, aConfigScalars, aConfigAggregates; +static VALUE eConfigParseError, eSettingNotFoundError, eSettingFormatError, eSettingNameError; + +static VALUE rconfig_wrap_value(config_setting_t* setting) +{ + switch(config_setting_type(setting)) { + case CONFIG_TYPE_INT: + return LONG2FIX(config_setting_get_int(setting)); + + case CONFIG_TYPE_INT64: + return rb_ll2inum(config_setting_get_int64(setting)); + + case CONFIG_TYPE_FLOAT: + return rb_float_new(config_setting_get_float(setting)); + + case CONFIG_TYPE_STRING: + return rb_str_new2(config_setting_get_string(setting)); + + case CONFIG_TYPE_BOOL: + return config_setting_get_bool(setting) ? Qtrue : Qfalse; + + default: + rb_bug("unknown value type %d", config_setting_type(setting)); + } +} + +static void rconfig_free_setting(config_setting_t* setting) +{ + // dummy +} + +static VALUE rconfig_prepare_setting(config_setting_t* setting) +{ + VALUE wrapper = Data_Wrap_Struct(rb_cObject, 0, rconfig_free_setting, setting); + config_setting_set_hook(setting, (void*) wrapper); + return wrapper; +} + +static void rconfig_destroy_setting(void* hook) +{ + if(hook != NULL) { + VALUE wrapper = (VALUE) hook; + rb_iv_set(wrapper, "@setting", Qnil); + } +} + +static VALUE rconfig_wrap_setting(config_setting_t* setting) +{ + VALUE rbSetting = rconfig_prepare_setting(setting); + + switch(config_setting_type(setting)) { + case CONFIG_TYPE_INT: + return rb_funcall(cConfigFixnum, rb_intern("new"), 2, LONG2FIX(config_setting_get_int(setting)), rbSetting); + + case CONFIG_TYPE_INT64: + return rb_funcall(cConfigBignum, rb_intern("new"), 2, rb_ll2inum(config_setting_get_int64(setting)), rbSetting); + + case CONFIG_TYPE_FLOAT: + return rb_funcall(cConfigFloat, rb_intern("new"), 2, rb_float_new(config_setting_get_float(setting)), rbSetting); + + case CONFIG_TYPE_STRING: + return rb_funcall(cConfigString, rb_intern("new"), 2, rb_str_new2(config_setting_get_string(setting)), rbSetting); + + case CONFIG_TYPE_BOOL: + return rb_funcall(cConfigBoolean, rb_intern("new"), 2, config_setting_get_bool(setting) ? Qtrue : Qfalse, rbSetting); + + case CONFIG_TYPE_ARRAY: + return rb_funcall(cConfigArray, rb_intern("new"), 2, Qnil, rbSetting); + + case CONFIG_TYPE_LIST: + return rb_funcall(cConfigList, rb_intern("new"), 1, rbSetting); + + case CONFIG_TYPE_GROUP: + return rb_funcall(cConfigGroup, rb_intern("new"), 1, rbSetting); + + default: + rb_bug("[r] unknown setting type %d", config_setting_type(setting)); + } +} + +static void rconfig_update_setting(config_setting_t* setting, VALUE value) +{ + switch(config_setting_type(setting)) { + case CONFIG_TYPE_INT: + config_setting_set_int(setting, FIX2LONG(value)); + break; + + case CONFIG_TYPE_INT64: + if(TYPE(value) == T_BIGNUM) + config_setting_set_int64(setting, rb_big2ll(value)); + else // T_FIXNUM + config_setting_set_int64(setting, FIX2INT(value)); + break; + + case CONFIG_TYPE_FLOAT: +// ruby1.9 check +#if HAVE_RB_BLOCK_CALL + config_setting_set_float(setting, RFLOAT(value)->float_value); +#else + config_setting_set_float(setting, RFLOAT(value)->value); +#endif + break; + + case CONFIG_TYPE_STRING: + config_setting_set_string(setting, RSTRING_PTR(value)); + break; + + case CONFIG_TYPE_BOOL: + config_setting_set_bool(setting, value == Qtrue); + break; + + default: + rb_bug("[w] unknown setting type %d", config_setting_type(setting)); + } +} + +static void rconfig_check_setting_type(VALUE object, VALUE value) +{ + if(rb_obj_class(object) == cConfigFixnum) { + Check_Type(value, T_FIXNUM); + } else if(rb_obj_class(object) == cConfigBignum) { + if(TYPE(value) != T_BIGNUM && TYPE(value) != T_FIXNUM) + rb_raise(rb_eTypeError, "wrong argument type %s (expected Fixnum or Bignum)", rb_obj_classname(value)); + } else if(rb_obj_class(object) == cConfigFloat) { + Check_Type(value, T_FLOAT); + } else if(rb_obj_class(object) == cConfigString) { + Check_Type(value, T_STRING); + } else if(rb_obj_class(object) == cConfigBoolean) { + if(value != Qtrue && value != Qfalse) + rb_raise(rb_eTypeError, "wrong argument type %s (expected boolean)", rb_obj_classname(value)); + } else { + rb_raise(rb_eException, "never use Config::Setting itself"); + } +} + +static int rconfig_do_append(config_setting_t* setting, VALUE target, VALUE name) +{ + int type; + if(rb_obj_class(target) == cConfigFixnum) + type = CONFIG_TYPE_INT; + else if(rb_obj_class(target) == cConfigBignum) + type = CONFIG_TYPE_INT64; + else if(rb_obj_class(target) == cConfigFloat) + type = CONFIG_TYPE_FLOAT; + else if(rb_obj_class(target) == cConfigString) + type = CONFIG_TYPE_STRING; + else if(rb_obj_class(target) == cConfigBoolean) + type = CONFIG_TYPE_BOOL; + else if(rb_obj_class(target) == cConfigGroup) + type = CONFIG_TYPE_GROUP; + else if(rb_obj_class(target) == cConfigList) + type = CONFIG_TYPE_LIST; + else if(rb_obj_class(target) == cConfigArray) + type = CONFIG_TYPE_ARRAY; + else + rb_bug("unknown setting class %s", rb_obj_classname(target)); + + config_setting_t* new_setting; + if(name == Qnil) { + new_setting = config_setting_add(setting, NULL, type); + } else { + Check_Type(name, T_STRING); + new_setting = config_setting_add(setting, RSTRING_PTR(name), type); + } + + if(new_setting == NULL) + return 0; + + VALUE rbNewSetting = rconfig_prepare_setting(new_setting); + rb_iv_set(target, "@setting", rbNewSetting); + + if(rb_ary_includes(aConfigScalars, rb_obj_class(target)) == Qtrue) + rconfig_update_setting(new_setting, rb_iv_get(target, "@value")); + + if(rb_ary_includes(aConfigAggregates, rb_obj_class(target)) == Qtrue) { + if(rb_obj_class(target) == cConfigGroup) { + VALUE hash = rb_iv_get(target, "@hash"); + VALUE children = rb_funcall(hash, rb_intern("keys"), 0); + int i; + for(i = 0; i < RARRAY_LEN(children); i++) { + VALUE key = RARRAY_PTR(children)[i]; + rconfig_do_append(new_setting, rb_hash_aref(hash, key), key); + } + } else { + VALUE children = rb_iv_get(target, "@list"); + int i; + for(i = 0; i < RARRAY_LEN(children); i++) { + rconfig_do_append(new_setting, RARRAY_PTR(children)[i], Qnil); + } + } + } + + return 1; +} + +static VALUE rbConfigBaseSetting_initialize(VALUE self, VALUE setting) +{ + if(setting != Qnil) + Check_Type(setting, T_DATA); + rb_iv_set(self, "@setting", setting); + + return self; +} + +static VALUE rbConfigBaseSetting_name(VALUE self) +{ + if(rb_iv_get(self, "@setting") != Qnil) { + config_setting_t* setting = NULL; + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + return rb_str_new2(config_setting_name(setting)); + } else { + return Qnil; + } +} + +static VALUE rbConfigBaseSetting_parent(VALUE self) +{ + if(rb_iv_get(self, "@setting") != Qnil) { + config_setting_t* setting = NULL; + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + return rconfig_wrap_setting(config_setting_parent(setting)); + } else { + return Qnil; + } +} + +static VALUE rbConfigBaseSetting_is_root(VALUE self) +{ + if(rb_iv_get(self, "@setting") != Qnil) { + config_setting_t* setting = NULL; + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + return config_setting_is_root(setting) ? Qtrue : Qfalse; + } else { + return Qnil; + } +} + +static VALUE rbConfigBaseSetting_index(VALUE self) +{ + if(rb_iv_get(self, "@setting") != Qnil) { + config_setting_t* setting = NULL; + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + return INT2FIX(config_setting_index(setting)); + } else { + return Qnil; + } +} + +static VALUE rbConfigBaseSetting_line(VALUE self) +{ + if(rb_iv_get(self, "@setting") != Qnil) { + config_setting_t* setting = NULL; + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + return INT2FIX(config_setting_source_line(setting)); + } else { + return Qnil; + } +} + +static VALUE rbConfigSetting_initialize(int argc, VALUE* argv, VALUE self) +{ + VALUE value, setting; + rb_scan_args(argc, argv, "11", &value, &setting); + + rb_call_super(1, &setting); + + rconfig_check_setting_type(self, value); + rb_iv_set(self, "@value", value); + + if(rb_iv_get(self, "@setting") != Qnil) { + config_setting_t* c_setting = NULL; + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, c_setting); + rb_iv_set(self, "@format", INT2FIX(config_setting_get_format(c_setting))); + } else { + rb_iv_set(self, "@format", cConfigFormatDefault); + } + + return self; +} + +static VALUE rbConfigSetting_get_value(VALUE self) +{ + if(rb_iv_get(self, "@setting") != Qnil) { + config_setting_t* setting; + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + return rconfig_wrap_value(setting); + } else { + return rb_iv_get(self, "@value"); + } +} + +static VALUE rbConfigSetting_set_value(VALUE self, VALUE new_value) +{ + rconfig_check_setting_type(self, new_value); + + if(rb_iv_get(self, "@setting") != Qnil) { + config_setting_t* setting; + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + rconfig_update_setting(setting, new_value); + } + + rb_iv_set(self, "@value", new_value); + + return new_value; +} + +static VALUE rbConfigSetting_get_format(VALUE self) +{ + if(rb_iv_get(self, "@setting") != Qnil) { + config_setting_t* setting; + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + return INT2FIX(config_setting_get_format(setting)); + } else { + return rb_iv_get(self, "format"); + } +} + +static VALUE rbConfigSetting_set_format(VALUE self, VALUE new_format) +{ + if(rb_iv_get(self, "@setting") != Qnil) { + config_setting_t* setting; + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + if(!config_setting_set_format(setting, FIX2INT(new_format))) + rb_raise(eSettingFormatError, "invalid setting format %d", FIX2INT(new_format)); + } + + rb_iv_set(self, "@format", new_format); + + return new_format; +} + +static VALUE rbConfigAggregate_get(VALUE self, VALUE index); + +static VALUE rbConfigAggregate_initialize(int argc, VALUE* argv, VALUE self) +{ + VALUE setting = Qnil; + if(rb_obj_class(self) == cConfigGroup || rb_obj_class(self) == cConfigList) { + rb_scan_args(argc, argv, "01", &setting); + } else if(rb_obj_class(self) == cConfigArray) { + VALUE type = Qnil; + rb_scan_args(argc, argv, "02", &type, &setting); + + if(type != Qnil && rb_ary_includes(aConfigScalars, type) != Qtrue) + rb_raise(rb_eTypeError, "invalid setting array type %s", rb_class2name(type)); + + rb_iv_set(self, "@type", type); + } else { + rb_raise(rb_eException, "never create Config::Aggregate itself"); + } + + rb_call_super(1, &setting); + + rb_iv_set(self, "@list", rb_ary_new()); + if(rb_obj_class(self) == cConfigGroup) + rb_iv_set(self, "@hash", rb_hash_new()); + + if(setting != Qnil && rb_obj_class(self) == cConfigArray) { + config_setting_t* c_setting; + Data_Get_Struct(setting, config_setting_t, c_setting); + if(config_setting_length(c_setting) > 0) + rb_iv_set(self, "@type", rb_obj_class(rbConfigAggregate_get(self, INT2FIX(0)))); + } + + return self; +} + +static VALUE rbConfigAggregate_size(VALUE self) +{ + config_setting_t* setting = NULL; + if(rb_iv_get(self, "@setting") != Qnil) + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + + if(setting) + return INT2FIX(config_setting_length(setting)); + else + return INT2FIX(RARRAY_LEN(rb_iv_get(self, "@list"))); +} + +static VALUE rbConfigAggregate_get(VALUE self, VALUE index) +{ + config_setting_t* setting = NULL; + if(rb_iv_get(self, "@setting") != Qnil) + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + + VALUE rbTarget = Qnil; + + if(TYPE(index) == T_STRING && rb_obj_class(self) == cConfigGroup) { + if(setting) { + config_setting_t* target = config_setting_get_member(setting, RSTRING_PTR(index)); + if(target) + rbTarget = rconfig_wrap_setting(target); + } else { + rbTarget = rb_hash_aref(rb_iv_get(self, "@hash"), index); + } + } else if(TYPE(index) == T_FIXNUM) { + if(setting) { + config_setting_t* target = config_setting_get_elem(setting, FIX2INT(index)); + if(target) + rbTarget = rconfig_wrap_setting(target); + } else { + rbTarget = rb_ary_entry(rb_iv_get(self, "@list"), FIX2INT(index)); + } + } else { + rb_raise(rb_eTypeError, "wrong argument type %s (expected String or Fixnum)", rb_obj_classname(index)); + } + + if(rbTarget == Qnil) + if(TYPE(index) == T_STRING) + rb_raise(eSettingNotFoundError, "setting `%s' not found", RSTRING_PTR(index)); + else + rb_raise(eSettingNotFoundError, "setting [%d] not found", FIX2INT(index)); + + return rbTarget; +} + +static VALUE rbConfigAggregate_append(VALUE self, VALUE target) +{ + config_setting_t* setting = NULL; + if(rb_iv_get(self, "@setting") != Qnil) + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + + Check_Type(target, T_OBJECT); + + VALUE type = rb_iv_get(self, "@type"); + if(rb_obj_class(self) == cConfigArray) { + if(type != Qnil && type != rb_obj_class(target)) + rb_raise(rb_eTypeError, "wrong argument type %s (expected %s)", rb_obj_classname(target), rb_class2name(type)); + if(type == Qnil && rb_ary_includes(aConfigScalars, rb_obj_class(target)) != Qtrue) + rb_raise(rb_eTypeError, "invalid setting array type %s", rb_obj_classname(target)); + } + + if(rb_ary_includes(aConfigSettings, rb_obj_class(target)) == Qtrue) { + if(setting) + rconfig_do_append(setting, target, Qnil); + rb_ary_push(rb_iv_get(self, "@list"), target); + } else { + rb_raise(rb_eTypeError, "wrong argument type %s (expected Config::BaseSetting)", rb_obj_classname(target)); + } + + if(rb_obj_class(self) == cConfigArray && type == Qnil) + rb_iv_set(self, "@type", rb_obj_class(target)); + + return target; +} + +static VALUE rbConfigGroup_append(VALUE self, VALUE name, VALUE target) +{ + Check_Type(name, T_STRING); + Check_Type(target, T_OBJECT); + + config_setting_t* setting = NULL; + if(rb_iv_get(self, "@setting") != Qnil) + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + + if(rb_ary_includes(aConfigSettings, rb_obj_class(target)) == Qtrue) { + if(rb_reg_match(rSettingNameRegexp, name) == Qnil) + rb_raise(eSettingNameError, "setting name `%s' contains invalid characters", RSTRING_PTR(name)); + if(setting) { + if(!rconfig_do_append(setting, target, name)) + rb_raise(eSettingNameError, "setting `%s' already exists", RSTRING_PTR(name)); + } else if(rb_hash_aref(rb_iv_get(self, "@hash"), name) != Qnil) { + rb_raise(eSettingNameError, "setting `%s' already exists", RSTRING_PTR(name)); + } + rb_ary_push(rb_iv_get(self, "@list"), target); + rb_hash_aset(rb_iv_get(self, "@hash"), name, target); + } else { + rb_raise(rb_eTypeError, "wrong argument type %s (expected Config::BaseSetting)", rb_obj_classname(target)); + } + + return target; +} + +static VALUE rbConfigAggregate_delete(VALUE self, VALUE target) +{ + config_setting_t* setting = NULL; + if(rb_iv_get(self, "@setting") != Qnil) + Data_Get_Struct(rb_iv_get(self, "@setting"), config_setting_t, setting); + + VALUE hash = rb_iv_get(self, "@hash"), list = rb_iv_get(self, "@list"); + + if(TYPE(target) == T_STRING && rb_obj_class(self) == cConfigGroup) { + if(setting) + config_setting_remove(setting, RSTRING_PTR(target)); + + rb_ary_delete_at(list, rb_hash_aref(hash, target)); + rb_hash_delete(hash, target); + } else if(TYPE(target) == T_FIXNUM) { + int index = FIX2INT(target); + if(setting) + config_setting_remove_elem(setting, index); + + if(rb_obj_class(self) == cConfigGroup) + rb_hash_delete(hash, rbConfigBaseSetting_name(rb_ary_entry(list, index))); + rb_ary_delete_at(list, index); + } else if(rb_ary_includes(aConfigSettings, rb_obj_class(target)) == Qtrue) { + VALUE name = rbConfigBaseSetting_name(target); + if(setting) + config_setting_remove(setting, RSTRING_PTR(name)); + + if(rb_obj_class(self) == cConfigGroup) + rb_hash_delete(hash, name); + rb_ary_delete(list, target); + } else { + if(rb_obj_class(self) == cConfigGroup) + rb_raise(rb_eTypeError, "wrong argument type %s (expected String, Fixnum or Config::BaseSetting)", rb_obj_classname(target)); + else + rb_raise(rb_eTypeError, "wrong argument type %s (expected Fixnum or Config::BaseSetting)", rb_obj_classname(target)); + } + + return Qnil; +} + +static VALUE rbConfig_initialize(VALUE self) +{ + config_t* config = (config_t*) malloc(sizeof(config_t)); + config_init(config); + config_set_destructor(config, &rconfig_destroy_setting); + + VALUE rbConfig = Data_Wrap_Struct(rb_cObject, 0, config_destroy, config); + rb_iv_set(self, "@config", rbConfig); + + return self; +} + +static VALUE rbConfig_read_bang(VALUE self, VALUE path) +{ + Check_Type(path, T_STRING); + + config_t* config; + Data_Get_Struct(rb_iv_get(self, "@config"), config_t, config); + + if(!config_read_file(config, RSTRING_PTR(path))) { + if(config_error_line(config) == 0) + rb_raise(rb_eIOError, "cannot load config: I/O error"); + else + rb_raise(eConfigParseError, "cannot parse config on line %d: `%s'", + config_error_line(config), config_error_text(config)); + } + + return Qtrue; +} + +static VALUE rbConfig_write_bang(VALUE self, VALUE path) +{ + Check_Type(path, T_STRING); + + config_t* config; + Data_Get_Struct(rb_iv_get(self, "@config"), config_t, config); + + if(!config_write_file(config, RSTRING_PTR(path))) + rb_raise(rb_eIOError, "cannot save config: I/O error"); + + return Qtrue; +} + +static VALUE rbConfig_read(VALUE self, VALUE path) +{ + Check_Type(path, T_STRING); + + config_t* config; + Data_Get_Struct(rb_iv_get(self, "@config"), config_t, config); + + return config_read_file(config, RSTRING_PTR(path)) ? Qtrue : Qfalse; +} + +static VALUE rbConfig_write(VALUE self, VALUE path) +{ + Check_Type(path, T_STRING); + + config_t* config; + Data_Get_Struct(rb_iv_get(self, "@config"), config_t, config); + + return config_write_file(config, RSTRING_PTR(path)) ? Qtrue : Qfalse; +} + +static VALUE rbConfig_root(VALUE self) +{ + config_t* config; + Data_Get_Struct(rb_iv_get(self, "@config"), config_t, config); + + return rconfig_wrap_setting(config_root_setting(config)); +} + +static VALUE rbConfig_lookup(VALUE self, VALUE handle) +{ + if(TYPE(handle) == T_STRING) { + config_t* config; + Data_Get_Struct(rb_iv_get(self, "@config"), config_t, config); + + config_setting_t* setting; + setting = config_lookup(config, RSTRING_PTR(handle)); + + if(setting == NULL) + rb_raise(eSettingNotFoundError, "setting `%s' not found", RSTRING_PTR(handle)); + + return rconfig_wrap_setting(setting); + } else if(TYPE(handle) == T_FIXNUM) { + return rbConfigAggregate_get(rbConfig_root(self), handle); + } else { + rb_raise(rb_eTypeError, "wrong argument type %s (expected String or Fixnum)", rb_obj_classname(handle)); + } +} + +static VALUE rbConfig_append(VALUE self, VALUE name, VALUE target) +{ + return rbConfigGroup_append(rbConfig_root(self), name, target); +} + +static VALUE rbConfig_delete(VALUE self, VALUE name) +{ + return rbConfigAggregate_delete(rbConfig_root(self), name); +} + +static VALUE rbConfig_size(VALUE self) +{ + return rbConfigAggregate_size(rbConfig_root(self)); +} + +void Init_rconfig() +{ + cConfig = rb_define_class("Config", rb_cObject); + rb_define_method(cConfig, "initialize", rbConfig_initialize, 0); + rb_define_method(cConfig, "read!", rbConfig_read_bang, 1); + rb_define_method(cConfig, "write!", rbConfig_write_bang, 1); + rb_define_method(cConfig, "read", rbConfig_read, 1); + rb_define_method(cConfig, "write", rbConfig_write, 1); + rb_define_method(cConfig, "root", rbConfig_root, 0); + rb_define_method(cConfig, "lookup", rbConfig_lookup, 1); + rb_define_method(cConfig, "[]", rbConfig_lookup, 1); + rb_define_method(cConfig, "append", rbConfig_append, 2); + rb_define_method(cConfig, "delete", rbConfig_delete, 1); + rb_define_method(cConfig, "size", rbConfig_size, 0); + + cConfigBaseSetting = rb_define_class_under(cConfig, "BaseSetting", rb_cObject); + rb_define_method(cConfigBaseSetting, "initialize", rbConfigBaseSetting_initialize, 1); + rb_define_method(cConfigBaseSetting, "name", rbConfigBaseSetting_name, 0); + rb_define_method(cConfigBaseSetting, "parent", rbConfigBaseSetting_parent, 0); + rb_define_method(cConfigBaseSetting, "root?", rbConfigBaseSetting_is_root, 0); + rb_define_method(cConfigBaseSetting, "index", rbConfigBaseSetting_index, 0); + rb_define_method(cConfigBaseSetting, "line", rbConfigBaseSetting_line, 0); + + cConfigSetting = rb_define_class_under(cConfig, "Setting", cConfigBaseSetting); + rb_define_method(cConfigSetting, "initialize", rbConfigSetting_initialize, -1); + rb_define_method(cConfigSetting, "value", rbConfigSetting_get_value, 0); + rb_define_method(cConfigSetting, "value=", rbConfigSetting_set_value, 1); + rb_define_method(cConfigSetting, "format", rbConfigSetting_get_format, 0); + rb_define_method(cConfigSetting, "format=", rbConfigSetting_set_format, 1); + + cConfigFormatDefault = INT2FIX(CONFIG_FORMAT_DEFAULT); + rb_define_const(cConfig, "FORMAT_DEFAULT", cConfigFormatDefault); + cConfigFormatHex = INT2FIX(CONFIG_FORMAT_HEX); + rb_define_const(cConfig, "FORMAT_HEX", cConfigFormatHex); + + cConfigFixnum = rb_define_class_under(cConfig, "Fixnum", cConfigSetting); + cConfigBignum = rb_define_class_under(cConfig, "Bignum", cConfigSetting); + cConfigFloat = rb_define_class_under(cConfig, "Float", cConfigSetting); + cConfigBoolean = rb_define_class_under(cConfig, "Boolean", cConfigSetting); + cConfigString = rb_define_class_under(cConfig, "String", cConfigSetting); + + cConfigAggregate = rb_define_class_under(cConfig, "Aggregate", cConfigBaseSetting); + rb_define_method(cConfigAggregate, "initialize", rbConfigAggregate_initialize, -1); + rb_define_method(cConfigAggregate, "size", rbConfigAggregate_size, 0); + rb_define_method(cConfigAggregate, "get", rbConfigAggregate_get, 1); + rb_define_method(cConfigAggregate, "[]", rbConfigAggregate_get, 1); + rb_define_method(cConfigAggregate, "delete", rbConfigAggregate_delete, 1); + + cConfigGroup = rb_define_class_under(cConfig, "Group", cConfigAggregate); + rb_define_method(cConfigGroup, "append", rbConfigGroup_append, 2); + cConfigArray = rb_define_class_under(cConfig, "Array", cConfigAggregate); + rb_define_method(cConfigArray, "append", rbConfigAggregate_append, 1); + rb_define_method(cConfigArray, "<<", rbConfigAggregate_append, 1); + cConfigList = rb_define_class_under(cConfig, "List", cConfigAggregate); + rb_define_method(cConfigList, "append", rbConfigAggregate_append, 1); + rb_define_method(cConfigList, "<<", rbConfigAggregate_append, 1); + + aConfigScalars = rb_ary_new3(5, cConfigFixnum, cConfigBignum, cConfigFloat, cConfigBoolean, cConfigString); + aConfigAggregates = rb_ary_new3(3, cConfigGroup, cConfigArray, cConfigList); + aConfigSettings = rb_ary_plus(aConfigScalars, aConfigAggregates); + + rb_define_const(cConfig, "SCALARS", aConfigScalars); + rb_define_const(cConfig, "AGGREGATES", aConfigAggregates); + rb_define_const(cConfig, "SETTINGS", aConfigSettings); + + char* settingNameRegexp = "^[A-Za-z*][A-Za-z\\-_*]*$"; + rSettingNameRegexp = rb_reg_new(settingNameRegexp, strlen(settingNameRegexp), 0); + + eConfigParseError = rb_define_class("ConfigParseError", rb_eException); + eSettingNotFoundError = rb_define_class("SettingNotFoundError", rb_eException); + eSettingFormatError = rb_define_class("SettingFormatError", rb_eException); + eSettingNameError = rb_define_class("SettingNameError", rb_eException); +} diff --git a/libconfig-1.4.9/debian/changelog b/libconfig-1.4.9/debian/changelog new file mode 100644 index 0000000000000000000000000000000000000000..7e9e00a7d1f1cefdf87f1181e67eed6e073a3255 --- /dev/null +++ b/libconfig-1.4.9/debian/changelog @@ -0,0 +1,77 @@ +libconfig (1.4.8) unstable; urgency=low + + * New upstream release + * Update debian/control to reflect current Debian packages + * Add texlive-latex-base to Build-Depends + + -- Jonathan McCrohan Sun, 06 Nov 2011 01:16:39 +0000 + +libconfig (1.4) unstable; urgency=low + + * new upstream release + * libconfig++9-dev no longer depends on libconfig9-dev + + -- Mark Lindner Fri, 21 Aug 2009 00:00:00 +0800 + +libconfig (1.3.2) unstable; urgency=low + + * new upstream release + * use official Debian files as basis + * libconfig++8-dev depends on libconfig8-dev because libconfig.h++ + includes libconfig.h which is in libconfig8-dev + + -- Klaus Schneider Wed, 18 Feb 2009 15:26:32 +0100 + +libconfig (1.3.1-1) unstable; urgency=low + + * First upload to Debian (Closes: #438683) + + * New upstream release + - soname bump to 6.1 + + -- Jose Luis Tallon Fri, 31 Oct 2008 22:13:47 +0100 + +libconfig (1.3-1) unstable; urgency=low + + * New upstream release + + * Packaging + - Updated to S-V 3.8.0 with no changes + + -- Jose Luis Tallon Mon, 20 Jul 2008 19:55:23 +0200 + +libconfig (1.1-1) unstable; urgency=low + + * New upstream release + + -- Jose Luis Tallon Mon, 2 Jul 2007 02:01:40 +0200 + +libconfig (0.9-1) unstable; urgency=low + + * Initial packaging + + -- Jose Luis Tallon Tue, 10 Oct 2006 01:42:09 +0200 + +libconfigduo (1.3.1) unstable; urgency=low + + * Release 1.3.1 + + -- Klaus Schneider Thu, 13 Nov 2008 17:05:12 +0100 + +libconfigduo (1.3) unstable; urgency=low + + * Release 1.3 + + -- Klaus Schneider Fri, 4 Apr 2008 09:36:42 +0200 + +libconfigduo (1.2.1-1) unstable; urgency=low + + * Release 1.2.1 + + -- Klaus Schneider Thu, 31 Jan 2008 11:25:21 +0100 + +libconfigduo (1.1.1-1) unstable; urgency=low + + * Initial release + + -- Klaus Schneider Mon, 25 Jun 2007 16:21:56 +0200 diff --git a/libconfig-1.4.9/debian/compat b/libconfig-1.4.9/debian/compat new file mode 100644 index 0000000000000000000000000000000000000000..7ed6ff82de6bcc2a78243fc9c54d3ef5ac14da69 --- /dev/null +++ b/libconfig-1.4.9/debian/compat @@ -0,0 +1 @@ +5 diff --git a/libconfig-1.4.9/debian/control b/libconfig-1.4.9/debian/control new file mode 100644 index 0000000000000000000000000000000000000000..5ac5e834d6a66eda01a793452cba02185aa19344 --- /dev/null +++ b/libconfig-1.4.9/debian/control @@ -0,0 +1,98 @@ +Source: libconfig +Priority: optional +Maintainer: Klaus Schneider +Uploaders: Julien Danjou +Build-Depends: debhelper (>= 5), autotools-dev, texinfo, texlive-latex-base +Standards-Version: 3.8.0 +Homepage: http://www.hyperrealm.com/libconfig/ +Section: libs + +Package: libconfig9 +Section: libs +Architecture: any +Depends: ${shlibs:Depends}, ${misc:Depends} +Description: processing of structured configuration files + This library features a fully reentrant parser and includes bindings for + both the C and C++ programming languages. It runs on modern POSIX-compliant + systems such as Linux, Solaris, and Mac OS X (Darwin), as well as on + Microsoft Windows 2000/XP and later (Visual Studio or MinGW). + . + This library allows parsing, manipulating and writing structured configuration + files. + +Package: libconfig++9 +Section: libs +Architecture: any +Depends: ${shlibs:Depends}, ${misc:Depends} +Description: processing of structured configuration files (C++ binding) + This library features a fully reentrant parser and includes bindings for + both the C and C++ programming languages. It runs on modern POSIX-compliant + systems such as Linux, Solaris, and Mac OS X (Darwin), as well as on + Microsoft Windows 2000/XP and later (Visual Studio or MinGW). + . + This library allows parsing, manipulating and writing structured configuration + files. + . + This is the C++ binding. + +Package: libconfig9-dev +Section: libdevel +Architecture: any +Provides: libconfig-dev +Depends: libconfig9 (= ${binary:Version}), pkg-config (>= 0.20) +Conflicts: libconfig8-dev +Description: processing of structured config files (development) + This library features a fully reentrant parser and includes bindings for + both the C and C++ programming languages. It runs on modern POSIX-compliant + systems such as Linux, Solaris, and Mac OS X (Darwin), as well as on + Microsoft Windows 2000/XP and later (Visual Studio or MinGW). + . + This library allows parsing, manipulating and writing structured configuration + files. Its main features are: + - A fully reentrant parser: Multiple configurations can be parsed in + concurrent threads at the same time. + - A simple, structured configuration file format: more readable and compact + than XML and more flexible than Windows' "INI" file format. + - A low-footprint implementation + - Proper documentation. + . + This package contains the files needed in order to use libconfig + in your own programs. + +Package: libconfig++9-dev +Section: libdevel +Architecture: any +Provides: libconfig++-dev +Depends: libconfig++9 (= ${binary:Version}), libconfig9 (= ${binary:Version}), pkg-config (>= 0.20) +Conflicts: libconfig++8-dev +Description: processing of structured config files (C++ development) + This library features a fully reentrant parser and includes bindings for + both the C and C++ programming languages. It runs on modern POSIX-compliant + systems such as Linux, Solaris, and Mac OS X (Darwin), as well as on + Microsoft Windows 2000/XP and later (Visual Studio or MinGW). + . + This library allows parsing, manipulating and writing structured configuration + files. Its main features are: + - A fully reentrant parser: Multiple configurations can be parsed in + concurrent threads at the same time. + - A simple, structured configuration file format: more readable and compact + than XML and more flexible than Windows' "INI" file format. + - A low-footprint implementation + - Proper documentation. + . + This package contains the files needed in order to use libconfig + in your own C++ programs. + +Package: libconfig9-dbg +Section: debug +Architecture: any +Depends: libconfig9 (= ${binary:Version}) +Description: debug symbols for libconfig9 + This package provides debugging information for libconfig library + +Package: libconfig++9-dbg +Section: debug +Architecture: any +Depends: libconfig++9 (= ${binary:Version}) +Description: debug symbols for libconfig++9 + This package provides debugging information for C++ API of libconfig library diff --git a/libconfig-1.4.9/debian/copyright b/libconfig-1.4.9/debian/copyright new file mode 100644 index 0000000000000000000000000000000000000000..e6e57d078d69971026ea7c0b40635dc36e5f1f76 --- /dev/null +++ b/libconfig-1.4.9/debian/copyright @@ -0,0 +1,65 @@ +This package was debianized by Jose Luis Tallon on +Tue, 10 Oct 2006 01:42:09 +0200. + +It was downloaded from http://www.hyperrealm.com/libconfig + +Upstream Author: Mark A Lindner + Mark Lindner - Lead developer & maintainer. + Daniel Marjamdki - Enhancements & bugfixes. + Andrew Tytula - Windows Port. + Glenn Herteg - Enhancements, bugfixes, documentation corrections. + + +Copyright: Copyright (C) 2005-2009 Mark A Lindner + +License: (LGPL-2.1) + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + + +On Debian systems, the full text of GNU's Lesser General Public License can +be found at /usr/share/common-licenses/LGPL-2.1 + + +The Debian packaging is (C) 2006-2008, Jose Luis Tallon +and is licensed under the GPL, see `/usr/share/common-licenses/GPL'. +This package was debianized by Klaus Schneider on +Mon, 25 Jun 2007 16:21:56 +0200. + +It was downloaded from http://www.hyperrealm.com/libconfig/libconfig.html + +Upstream Author: Mark A. Lindner + +Copyright: (c) 2005-2009 Mark A. Lindner + +License: + + This package is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public + License as published by the Free Software Foundation; either + version 2 of the License, or (at your option) any later version. + + This package is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Lesser General Public + License along with this package; if not, write to the Free Software + Foundation, Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA + +On Debian systems, the complete text of the GNU Lesser General +Public License can be found in `/usr/share/common-licenses/LGPL'. + + +The Debian packaging is (C) 2007, Klaus Schneider and +is licensed under the GPL, see `/usr/share/common-licenses/GPL'. diff --git a/libconfig-1.4.9/debian/docs b/libconfig-1.4.9/debian/docs new file mode 100644 index 0000000000000000000000000000000000000000..5502ed8f40fc4c37d8385e57c16b8d2642ecff18 --- /dev/null +++ b/libconfig-1.4.9/debian/docs @@ -0,0 +1,3 @@ +NEWS +README +TODO diff --git a/libconfig-1.4.9/debian/libconfig++9-dev.install b/libconfig-1.4.9/debian/libconfig++9-dev.install new file mode 100644 index 0000000000000000000000000000000000000000..642348add3f617054c03d07dad9c7281b3746649 --- /dev/null +++ b/libconfig-1.4.9/debian/libconfig++9-dev.install @@ -0,0 +1,5 @@ +debian/tmp/usr/include/libconfig.h++ +debian/tmp/usr/lib/libconfig++.a +debian/tmp/usr/lib/libconfig++.so +debian/tmp/usr/lib/libconfig++.la +debian/tmp/usr/lib/pkgconfig/libconfig++.pc diff --git a/libconfig-1.4.9/debian/libconfig++9.install b/libconfig-1.4.9/debian/libconfig++9.install new file mode 100644 index 0000000000000000000000000000000000000000..35c586e053bb91705d30154e431bd3aa4ee78a56 --- /dev/null +++ b/libconfig-1.4.9/debian/libconfig++9.install @@ -0,0 +1 @@ +debian/tmp/usr/lib/libconfig++.so.9* diff --git a/libconfig-1.4.9/debian/libconfig9-dev.docs b/libconfig-1.4.9/debian/libconfig9-dev.docs new file mode 100644 index 0000000000000000000000000000000000000000..49e707d545060f59aafd4f93362aa072b25e2bd7 --- /dev/null +++ b/libconfig-1.4.9/debian/libconfig9-dev.docs @@ -0,0 +1 @@ +doc/libconfig.pdf diff --git a/libconfig-1.4.9/debian/libconfig9-dev.install b/libconfig-1.4.9/debian/libconfig9-dev.install new file mode 100644 index 0000000000000000000000000000000000000000..5b5ce021d19e49c1c3ffa4448142d6db5fa60f56 --- /dev/null +++ b/libconfig-1.4.9/debian/libconfig9-dev.install @@ -0,0 +1,5 @@ +debian/tmp/usr/include/libconfig.h +debian/tmp/usr/lib/libconfig.a +debian/tmp/usr/lib/libconfig.so +debian/tmp/usr/lib/libconfig.la +debian/tmp/usr/lib/pkgconfig/libconfig.pc diff --git a/libconfig-1.4.9/debian/libconfig9.info b/libconfig-1.4.9/debian/libconfig9.info new file mode 100644 index 0000000000000000000000000000000000000000..628d7f3e8da85db395f9bd3b1dfb50134c80ed08 --- /dev/null +++ b/libconfig-1.4.9/debian/libconfig9.info @@ -0,0 +1 @@ +debian/tmp/usr/share/info/libconfig.info diff --git a/libconfig-1.4.9/debian/libconfig9.install b/libconfig-1.4.9/debian/libconfig9.install new file mode 100644 index 0000000000000000000000000000000000000000..aba7b377e70060d99be9712e35139d3b4530923c --- /dev/null +++ b/libconfig-1.4.9/debian/libconfig9.install @@ -0,0 +1,2 @@ +debian/tmp/usr/lib/libconfig.so.9* + diff --git a/libconfig-1.4.9/debian/rules b/libconfig-1.4.9/debian/rules new file mode 100755 index 0000000000000000000000000000000000000000..d758c24431cfe0a0d7ffb3204eb1fb62a9259fd9 --- /dev/null +++ b/libconfig-1.4.9/debian/rules @@ -0,0 +1,105 @@ +#!/usr/bin/make -f +# -*- makefile -*- +# Sample debian/rules that uses debhelper. +# This file was originally written by Joey Hess and Craig Small. +# As a special exception, when this file is copied by dh-make into a +# dh-make output file, you may use that output file without restriction. +# This special exception was added by Craig Small in version 0.37 of dh-make. + +# Uncomment this to turn on verbose mode. +#export DH_VERBOSE=1 + + +# These are used for cross-compiling and for saving the configure script +# from having to guess our platform (since we know it already) +DEB_HOST_GNU_TYPE ?= $(shell dpkg-architecture -qDEB_HOST_GNU_TYPE) +DEB_BUILD_GNU_TYPE ?= $(shell dpkg-architecture -qDEB_BUILD_GNU_TYPE) + + +CFLAGS = -Wall -g + +ifneq (,$(findstring noopt,$(DEB_BUILD_OPTIONS))) + CFLAGS += -O0 +else + CFLAGS += -O2 +endif + +# shared library versions +version=`ls lib/.libs/lib*.so.* | \ + awk '{if (match($$0,/[0-9]+\.[0-9]+\.[0-9]+$$/)) print substr($$0,RSTART)}'` +major=`ls lib/.libs/lib*.so.* | \ + awk '{if (match($$0,/\.so\.[0-9]+$$/)) print substr($$0,RSTART+4)}'` + +config.status: configure + dh_testdir + ./configure --host=$(DEB_HOST_GNU_TYPE) --build=$(DEB_BUILD_GNU_TYPE) \ + --prefix=/usr --mandir=\$${prefix}/share/man \ + --infodir=\$${prefix}/share/info \ + CFLAGS="$(CFLAGS)" LDFLAGS="-Wl,-z,defs" + +build: build-stamp +build-stamp: config.status + dh_testdir + $(MAKE) + $(MAKE) pdf + touch $@ + +clean: + dh_testdir + dh_testroot + rm -f build-stamp + -$(MAKE) distclean +ifneq "$(wildcard /usr/share/misc/config.sub)" "" + cp -f /usr/share/misc/config.sub config.sub +endif +ifneq "$(wildcard /usr/share/misc/config.guess)" "" + cp -f /usr/share/misc/config.guess config.guess +endif + dh_clean + +install: build + dh_testdir + dh_testroot + dh_clean -k + dh_installdirs + $(MAKE) DESTDIR=$(CURDIR)/debian/tmp install + +# Build architecture-independent files here. +binary-indep: build install +# We have nothing to do by default. + +# Build architecture-dependent files here. +binary-arch: build install + dh_testdir + dh_testroot + dh_installchangelogs ChangeLog + dh_installdocs + dh_installexamples + dh_install + dh_strip -v --package=libconfig9 --dbg-package=libconfig9-dbg + dh_strip -v --package=libconfig++9 --dbg-package=libconfig++9-dbg +# dh_installmenu +# dh_installdebconf +# dh_installlogrotate +# dh_installemacsen +# dh_installpam +# dh_installmime +# dh_installinit +# dh_installcron +# dh_installinfo + dh_installman + dh_link + dh_strip + dh_compress + dh_fixperms +# dh_perl +# dh_python + dh_makeshlibs + dh_installdeb + dh_shlibdeps + dh_gencontrol + dh_md5sums + dh_builddeb + +binary: binary-indep binary-arch +.PHONY: build clean binary-indep binary-arch binary install diff --git a/libconfig-1.4.9/debian/shlibs b/libconfig-1.4.9/debian/shlibs new file mode 100644 index 0000000000000000000000000000000000000000..cb75f1282bb86f1e1158e0cbd2d51ce8cbbf89b2 --- /dev/null +++ b/libconfig-1.4.9/debian/shlibs @@ -0,0 +1,2 @@ +libconfig 9 libconfig9 +libconfig++ 9 libconfig++9 diff --git a/libconfig-1.4.9/debian/watch b/libconfig-1.4.9/debian/watch new file mode 100644 index 0000000000000000000000000000000000000000..cf03ff99bc15a7d40421a0131106b17b97164201 --- /dev/null +++ b/libconfig-1.4.9/debian/watch @@ -0,0 +1,5 @@ +version=3 + +# Full-site-with-pattern [Version [Action]] +http://www.hyperrealm.com/libconfig/index.html \ + libconfig-(.+)\.tar\.gz diff --git a/libconfig-1.4.9/doc/LGPL.texi b/libconfig-1.4.9/doc/LGPL.texi new file mode 100644 index 0000000000000000000000000000000000000000..e371ac0d0f2cad561ee9e6542162d66446cd9812 --- /dev/null +++ b/libconfig-1.4.9/doc/LGPL.texi @@ -0,0 +1,590 @@ +@c \input texinfo.tex @c -*-texinfo-*- +@c +@c %**start of header + +@c All text is ignored before the setfilename. +@setfilename LGPL.info + +@center GNU LESSER GENERAL PUBLIC LICENSE +@center Version 2.1, February 1999 + +@sp 1 + +Copyright @copyright{} 1991, 1999 Free Software Foundation, Inc., +59 Temple Place, Suite 330, Boston, MA 02111-1307 USA + +Everyone is permitted to copy and distribute verbatim copies of this +license document, but changing it is not allowed. + +[This is the first released version of the Lesser GPL. It also counts +as the successor of the GNU Library Public License, version 2, hence the +version number 2.1.] + +@sp 1 +@center Preamble +@sp 1 + +The licenses for most software are designed to take away your freedom to +share and change it. By contrast, the GNU General Public Licenses are +intended to guarantee your freedom to share and change free software--to +make sure the software is free for all its users. + +This license, the Lesser General Public License, applies to some +specially designated software packages--typically libraries--of the Free +Software Foundation and other authors who decide to use it. You can use +it too, but we suggest you first think carefully about whether this +license or the ordinary General Public License is the better strategy to +use in any particular case, based on the explanations below. + +When we speak of free software, we are referring to freedom of use, not +price. Our General Public Licenses are designed to make sure that you +have the freedom to distribute copies of free software (and charge for +this service if you wish); that you receive source code or can get it if +you want it; that you can change the software and use pieces of it in +new free programs; and that you are informed that you can do these +things. + +To protect your rights, we need to make restrictions that forbid +distributors to deny you these rights or to ask you to surrender these +rights. These restrictions translate to certain responsibilities for +you if you distribute copies of the library or if you modify it. + +For example, if you distribute copies of the library, whether gratis or +for a fee, you must give the recipients all the rights that we gave you. +You must make sure that they, too, receive or can get the source code. +If you link other code with the library, you must provide complete +object files to the recipients, so that they can relink them with the +library after making changes to the library and recompiling it. And you +must show them these terms so they know their rights. + +We protect your rights with a two-step method: (1) we copyright the +library, and (2) we offer you this license, which gives you legal +permission to copy, distribute and/or modify the library. + +To protect each distributor, we want to make it very clear that there is +no warranty for the free library. Also, if the library is modified by +someone else and passed on, the recipients should know that what they +have is not the original version, so that the original author's +reputation will not be affected by problems that might be introduced by +others. + +Finally, software patents pose a constant threat to the existence of any +free program. We wish to make sure that a company cannot effectively +restrict the users of a free program by obtaining a restrictive license +from a patent holder. Therefore, we insist that any patent license +obtained for a version of the library must be consistent with the full +freedom of use specified in this license. + +Most GNU software, including some libraries, is covered by the ordinary +GNU General Public License. This license, the GNU Lesser General Public +License, applies to certain designated libraries, and is quite different +from the ordinary General Public License. We use this license for +certain libraries in order to permit linking those libraries into +non-free programs. + +When a program is linked with a library, whether statically or using a +shared library, the combination of the two is legally speaking a +combined work, a derivative of the original library. The ordinary +General Public License therefore permits such linking only if the entire +combination fits its criteria of freedom. The Lesser General Public +License permits more lax criteria for linking other code with the +library. + +We call this license the ``Lesser'' General Public License because it does +Less to protect the user's freedom than the ordinary General Public +License. It also provides other free software developers Less of an +advantage over competing non-free programs. These disadvantages are the +reason we use the ordinary General Public License for many libraries. +However, the Lesser license provides advantages in certain special +circumstances. + +For example, on rare occasions, there may be a special need to encourage +the widest possible use of a certain library, so that it becomes a +de-facto standard. To achieve this, non-free programs must be allowed +to use the library. A more frequent case is that a free library does +the same job as widely used non-free libraries. In this case, there is +little to gain by limiting the free library to free software only, so we +use the Lesser General Public License. + +In other cases, permission to use a particular library in non-free +programs enables a greater number of people to use a large body of free +software. For example, permission to use the GNU C Library in non-free +programs enables many more people to use the whole GNU operating system, +as well as its variant, the GNU/Linux operating system. + +Although the Lesser General Public License is Less protective of the +users' freedom, it does ensure that the user of a program that is linked +with the Library has the freedom and the wherewithal to run that program +using a modified version of the Library. + +The precise terms and conditions for copying, distribution and +modification follow. Pay close attention to the difference between a +``work based on the library'' and a ``work that uses the library''. The +former contains code derived from the library, whereas the latter must +be combined with the library in order to run. + +@page + +@center GNU LESSER GENERAL PUBLIC LICENSE +@center TERMS AND CONDITIONS FOR COPYING, DISTRIBUTION AND MODIFICATION + +@enumerate 0 + +@sp 1 +@item +This License Agreement applies to any software library or other program +which contains a notice placed by the copyright holder or other +authorized party saying it may be distributed under the terms of this +Lesser General Public License (also called ``this License''). Each +licensee is addressed as ``you''. + +A ``library'' means a collection of software functions and/or data +prepared so as to be conveniently linked with application programs +(which use some of those functions and data) to form executables. + +The ``Library'', below, refers to any such software library or work which +has been distributed under these terms. A ``work based on the Library'' +means either the Library or any derivative work under copyright law: +that is to say, a work containing the Library or a portion of it, either +verbatim or with modifications and/or translated straightforwardly into +another language. (Hereinafter, translation is included without +limitation in the term ``modification''.) + +``Source code'' for a work means the preferred form of the work for making +modifications to it. For a library, complete source code means all the +source code for all modules it contains, plus any associated interface +definition files, plus the scripts used to control compilation and +installation of the library. + +Activities other than copying, distribution and modification are not +covered by this License; they are outside its scope. The act of running +a program using the Library is not restricted, and output from such a +program is covered only if its contents constitute a work based on the +Library (independent of the use of the Library in a tool for writing +it). Whether that is true depends on what the Library does and what the +program that uses the Library does. + +@sp 1 +@item +You may copy and distribute verbatim copies of the Library's complete +source code as you receive it, in any medium, provided that you +conspicuously and appropriately publish on each copy an appropriate +copyright notice and disclaimer of warranty; keep intact all the notices +that refer to this License and to the absence of any warranty; and +distribute a copy of this License along with the Library. + +You may charge a fee for the physical act of transferring a copy, and +you may at your option offer warranty protection in exchange for a fee. + +@sp 1 +@item +You may modify your copy or copies of the Library or any portion of it, +thus forming a work based on the Library, and copy and distribute such +modifications or work under the terms of Section 1 above, provided that +you also meet all of these conditions: + +@enumerate a + +@item +The modified work must itself be a software library. + +@sp 1 +@item +You must cause the files modified to carry prominent notices stating +that you changed the files and the date of any change. + +@sp 1 +@item +You must cause the whole of the work to be licensed at no charge to all +third parties under the terms of this License. + +@sp 1 +@item +If a facility in the modified Library refers to a function or a table of +data to be supplied by an application program that uses the facility, +other than as an argument passed when the facility is invoked, then you +must make a good faith effort to ensure that, in the event an +application does not supply such function or table, the facility still +operates, and performs whatever part of its purpose remains meaningful. + +(For example, a function in a library to compute square roots has a +purpose that is entirely well-defined independent of the application. +Therefore, Subsection 2d requires that any application-supplied function +or table used by this function must be optional: if the application does +not supply it, the square root function must still compute square +roots.) + +@end enumerate + +These requirements apply to the modified work as a whole. If +identifiable sections of that work are not derived from the Library, and +can be reasonably considered independent and separate works in +themselves, then this License, and its terms, do not apply to those +sections when you distribute them as separate works. But when you +distribute the same sections as part of a whole which is a work based on +the Library, the distribution of the whole must be on the terms of this +License, whose permissions for other licensees extend to the entire +whole, and thus to each and every part regardless of who wrote it. + +Thus, it is not the intent of this section to claim rights or contest +your rights to work written entirely by you; rather, the intent is to +exercise the right to control the distribution of derivative or +collective works based on the Library. + +In addition, mere aggregation of another work not based on the Library +with the Library (or with a work based on the Library) on a volume of a +storage or distribution medium does not bring the other work under the +scope of this License. + +@sp 1 +@item +You may opt to apply the terms of the ordinary GNU General Public +License instead of this License to a given copy of the Library. To do +this, you must alter all the notices that refer to this License, so that +they refer to the ordinary GNU General Public License, version 2, +instead of to this License. (If a newer version than version 2 of the +ordinary GNU General Public License has appeared, then you can specify +that version instead if you wish.) Do not make any other change in +these notices. + +Once this change is made in a given copy, it is irreversible for that +copy, so the ordinary GNU General Public License applies to all +subsequent copies and derivative works made from that copy. + +This option is useful when you wish to copy part of the code of the +Library into a program that is not a library. + +@sp 1 +@item +You may copy and distribute the Library (or a portion or derivative of +it, under Section 2) in object code or executable form under the terms +of Sections 1 and 2 above provided that you accompany it with the +complete corresponding machine-readable source code, which must be +distributed under the terms of Sections 1 and 2 above on a medium +customarily used for software interchange. + +If distribution of object code is made by offering access to copy from a +designated place, then offering equivalent access to copy the source +code from the same place satisfies the requirement to distribute the +source code, even though third parties are not compelled to copy the +source along with the object code. + +@sp 1 +@item +A program that contains no derivative of any portion of the Library, but +is designed to work with the Library by being compiled or linked with +it, is called a ``work that uses the Library''. Such a work, in +isolation, is not a derivative work of the Library, and therefore falls +outside the scope of this License. + +However, linking a ``work that uses the Library'' with the Library creates +an executable that is a derivative of the Library (because it contains +portions of the Library), rather than a ``work that uses the library''. +The executable is therefore covered by this License. Section 6 states +terms for distribution of such executables. + +When a ``work that uses the Library'' uses material from a header file +that is part of the Library, the object code for the work may be a +derivative work of the Library even though the source code is not. +Whether this is true is especially significant if the work can be linked +without the Library, or if the work is itself a library. The threshold +for this to be true is not precisely defined by law. + +If such an object file uses only numerical parameters, data structure +layouts and accessors, and small macros and small inline functions (ten +lines or less in length), then the use of the object file is +unrestricted, regardless of whether it is legally a derivative work. +(Executables containing this object code plus portions of the Library +will still fall under Section 6.) + +Otherwise, if the work is a derivative of the Library, you may +distribute the object code for the work under the terms of Section 6. +Any executables containing that work also fall under Section 6, whether +or not they are linked directly with the Library itself. + +@sp 1 +@item +As an exception to the Sections above, you may also combine or link a +``work that uses the Library'' with the Library to produce a work +containing portions of the Library, and distribute that work under terms +of your choice, provided that the terms permit modification of the work +for the customer's own use and reverse engineering for debugging such +modifications. + +You must give prominent notice with each copy of the work that the +Library is used in it and that the Library and its use are covered by +this License. You must supply a copy of this License. If the work +during execution displays copyright notices, you must include the +copyright notice for the Library among them, as well as a reference +directing the user to the copy of this License. Also, you must do one +of these things: + +@enumerate a + +@sp 1 +@item +Accompany the work with the complete corresponding machine-readable +source code for the Library including whatever changes were used in the +work (which must be distributed under Sections 1 and 2 above); and, if +the work is an executable linked with the Library, with the complete +machine-readable ``work that uses the Library'', as object code and/or +source code, so that the user can modify the Library and then relink to +produce a modified executable containing the modified Library. (It is +understood that the user who changes the contents of definitions files +in the Library will not necessarily be able to recompile the application +to use the modified definitions.) + +@sp 1 +@item +Use a suitable shared library mechanism for linking with the Library. A +suitable mechanism is one that (1) uses at run time a copy of the +library already present on the user's computer system, rather than +copying library functions into the executable, and (2) will operate +properly with a modified version of the library, if the user installs +one, as long as the modified version is interface-compatible with the +version that the work was made with. + +@sp 1 +@item +Accompany the work with a written offer, valid for at least three years, +to give the same user the materials specified in Subsection 6a, above, +for a charge no more than the cost of performing this distribution. + +@sp 1 +@item +If distribution of the work is made by offering access to copy from a +designated place, offer equivalent access to copy the above specified +materials from the same place. + +@sp 1 +@item +Verify that the user has already received a copy of these materials or +that you have already sent this user a copy. + +@end enumerate + +For an executable, the required form of the ``work that uses the Library'' +must include any data and utility programs needed for reproducing the +executable from it. However, as a special exception, the materials to +be distributed need not include anything that is normally distributed +(in either source or binary form) with the major components (compiler, +kernel, and so on) of the operating system on which the executable runs, +unless that component itself accompanies the executable. + +It may happen that this requirement contradicts the license restrictions +of other proprietary libraries that do not normally accompany the +operating system. Such a contradiction means you cannot use both them +and the Library together in an executable that you distribute. + +@sp 1 +@item +You may place library facilities that are a work based on the Library +side-by-side in a single library together with other library facilities +not covered by this License, and distribute such a combined library, +provided that the separate distribution of the work based on the Library +and of the other library facilities is otherwise permitted, and provided +that you do these two things: + +@enumerate a + +@sp 1 +@item +Accompany the combined library with a copy of the same work based on the +Library, uncombined with any other library facilities. This must be +distributed under the terms of the Sections above. + +@sp 1 +@item +Give prominent notice with the combined library of the fact that part of +it is a work based on the Library, and explaining where to find the +accompanying uncombined form of the same work. + +@end enumerate + +@sp 1 +@item +You may not copy, modify, sublicense, link with, or distribute the +Library except as expressly provided under this License. Any attempt +otherwise to copy, modify, sublicense, link with, or distribute the +Library is void, and will automatically terminate your rights under this +License. However, parties who have received copies, or rights, from you +under this License will not have their licenses terminated so long as +such parties remain in full compliance. + +@sp 1 +@item +You are not required to accept this License, since you have not signed +it. However, nothing else grants you permission to modify or distribute +the Library or its derivative works. These actions are prohibited by +law if you do not accept this License. Therefore, by modifying or +distributing the Library (or any work based on the Library), you +indicate your acceptance of this License to do so, and all its terms and +conditions for copying, distributing or modifying the Library or works +based on it. + +@sp 1 +@item +Each time you redistribute the Library (or any work based on the +Library), the recipient automatically receives a license from the +original licensor to copy, distribute, link with or modify the Library +subject to these terms and conditions. You may not impose any further +restrictions on the recipients' exercise of the rights granted herein. +You are not responsible for enforcing compliance by third parties with +this License. + +@sp 1 +@item +If, as a consequence of a court judgment or allegation of patent +infringement or for any other reason (not limited to patent issues), +conditions are imposed on you (whether by court order, agreement or +otherwise) that contradict the conditions of this License, they do not +excuse you from the conditions of this License. If you cannot +distribute so as to satisfy simultaneously your obligations under this +License and any other pertinent obligations, then as a consequence you +may not distribute the Library at all. For example, if a patent license +would not permit royalty-free redistribution of the Library by all those +who receive copies directly or indirectly through you, then the only way +you could satisfy both it and this License would be to refrain entirely +from distribution of the Library. + +If any portion of this section is held invalid or unenforceable under +any particular circumstance, the balance of the section is intended to +apply, and the section as a whole is intended to apply in other +circumstances. + +It is not the purpose of this section to induce you to infringe any +patents or other property right claims or to contest validity of any +such claims; this section has the sole purpose of protecting the +integrity of the free software distribution system which is implemented +by public license practices. Many people have made generous +contributions to the wide range of software distributed through that +system in reliance on consistent application of that system; it is up to +the author/donor to decide if he or she is willing to distribute +software through any other system and a licensee cannot impose that +choice. + +This section is intended to make thoroughly clear what is believed to be +a consequence of the rest of this License. + +@sp 1 +@item +If the distribution and/or use of the Library is restricted in certain +countries either by patents or by copyrighted interfaces, the original +copyright holder who places the Library under this License may add an +explicit geographical distribution limitation excluding those countries, +so that distribution is permitted only in or among countries not thus +excluded. In such case, this License incorporates the limitation as if +written in the body of this License. + +@sp 1 +@item +The Free Software Foundation may publish revised and/or new versions of +the Lesser General Public License from time to time. Such new versions +will be similar in spirit to the present version, but may differ in +detail to address new problems or concerns. + +Each version is given a distinguishing version number. If the Library +specifies a version number of this License which applies to it and ``any +later version'', you have the option of following the terms and +conditions either of that version or of any later version published by +the Free Software Foundation. If the Library does not specify a license +version number, you may choose any version ever published by the Free +Software Foundation. + +@sp 1 +@item +If you wish to incorporate parts of the Library into other free programs +whose distribution conditions are incompatible with these, write to the +author to ask for permission. For software which is copyrighted by the +Free Software Foundation, write to the Free Software Foundation; we +sometimes make exceptions for this. Our decision will be guided by the +two goals of preserving the free status of all derivatives of our free +software and of promoting the sharing and reuse of software generally. + +@sp 1 +@center NO WARRANTY +@sp 1 + +@item +BECAUSE THE LIBRARY IS LICENSED FREE OF CHARGE, THERE IS NO WARRANTY FOR +THE LIBRARY, TO THE EXTENT PERMITTED BY APPLICABLE LAW. EXCEPT WHEN +OTHERWISE STATED IN WRITING THE COPYRIGHT HOLDERS AND/OR OTHER PARTIES +PROVIDE THE LIBRARY ``AS IS'' WITHOUT WARRANTY OF ANY KIND, EITHER +EXPRESSED OR IMPLIED, INCLUDING, BUT NOT LIMITED TO, THE IMPLIED +WARRANTIES OF MERCHANTABILITY AND FITNESS FOR A PARTICULAR PURPOSE. THE +ENTIRE RISK AS TO THE QUALITY AND PERFORMANCE OF THE LIBRARY IS WITH +YOU. SHOULD THE LIBRARY PROVE DEFECTIVE, YOU ASSUME THE COST OF ALL +NECESSARY SERVICING, REPAIR OR CORRECTION. + +@sp 1 +@item +IN NO EVENT UNLESS REQUIRED BY APPLICABLE LAW OR AGREED TO IN WRITING +WILL ANY COPYRIGHT HOLDER, OR ANY OTHER PARTY WHO MAY MODIFY AND/OR +REDISTRIBUTE THE LIBRARY AS PERMITTED ABOVE, BE LIABLE TO YOU FOR +DAMAGES, INCLUDING ANY GENERAL, SPECIAL, INCIDENTAL OR CONSEQUENTIAL +DAMAGES ARISING OUT OF THE USE OR INABILITY TO USE THE LIBRARY +(INCLUDING BUT NOT LIMITED TO LOSS OF DATA OR DATA BEING RENDERED +INACCURATE OR LOSSES SUSTAINED BY YOU OR THIRD PARTIES OR A FAILURE OF +THE LIBRARY TO OPERATE WITH ANY OTHER SOFTWARE), EVEN IF SUCH HOLDER OR +OTHER PARTY HAS BEEN ADVISED OF THE POSSIBILITY OF SUCH DAMAGES. + +@end enumerate + +@sp 1 +@center END OF TERMS AND CONDITIONS +@sp 1 +@page +@center How to Apply These Terms to Your New Libraries + +If you develop a new library, and you want it to be of the greatest +possible use to the public, we recommend making it free software that +everyone can redistribute and change. You can do so by permitting +redistribution under these terms (or, alternatively, under the terms of +the ordinary General Public License). + +To apply these terms, attach the following notices to the library. It +is safest to attach them to the start of each source file to most +effectively convey the exclusion of warranty; and each file should have +at least the ``copyright'' line and a pointer to where the full notice is +found. + +@format +@t{ + +Copyright (C) + +This library is free software; you can redistribute it and/or +modify it under the terms of the GNU Lesser General Public +License as published by the Free Software Foundation; either +version 2 of the License, or (at your option) any later version. + +This library is distributed in the hope that it will be useful, +but WITHOUT ANY WARRANTY; without even the implied warranty of +MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU +Lesser General Public License for more details. + +You should have received a copy of the GNU Lesser General Public +License along with this library; if not, write to the Free Software +Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA +} +@end format + +Also add information on how to contact you by electronic and paper mail. + +You should also get your employer (if you work as a programmer) or your +school, if any, to sign a ``copyright disclaimer'' for the library, if +necessary. Here is a sample; alter the names: + +@format +@t{ +Yoyodyne, Inc., hereby disclaims all copyright interest in the +library `Frob' (a library for tweaking knobs) written by James Random Hacker. + +, 1 April 1990 +Ty Coon, President of Vice +} +@end format + +That's all there is to it! + +@c @bye diff --git a/libconfig-1.4.9/doc/Makefile b/libconfig-1.4.9/doc/Makefile new file mode 100644 index 0000000000000000000000000000000000000000..82a1dfa9f947729ec9b6991a84f1b21513bac0c8 --- /dev/null +++ b/libconfig-1.4.9/doc/Makefile @@ -0,0 +1,641 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# doc/Makefile. Generated from Makefile.in by configure. + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + + + +pkgdatadir = $(datadir)/libconfig +pkgincludedir = $(includedir)/libconfig +pkglibdir = $(libdir)/libconfig +pkglibexecdir = $(libexecdir)/libconfig +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = x86_64-unknown-linux-gnu +host_triplet = x86_64-unknown-linux-gnu +target_triplet = x86_64-unknown-linux-gnu +subdir = doc +DIST_COMMON = $(libconfig_TEXINFOS) $(srcdir)/Makefile.am \ + $(srcdir)/Makefile.in +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = +CONFIG_CLEAN_VPATH_FILES = +SOURCES = +DIST_SOURCES = +INFO_DEPS = $(srcdir)/libconfig.info +TEXINFO_TEX = $(top_srcdir)/aux-build/texinfo.tex +am__TEXINFO_TEX_DIR = $(top_srcdir)/aux-build +DVIS = libconfig.dvi +PDFS = libconfig.pdf +PSS = libconfig.ps +HTMLS = libconfig.html +TEXINFOS = libconfig.texi +TEXI2DVI = texi2dvi +TEXI2PDF = $(TEXI2DVI) --pdf --batch +MAKEINFOHTML = $(MAKEINFO) --html +AM_MAKEINFOHTMLFLAGS = $(AM_MAKEINFOFLAGS) +DVIPS = dvips +am__installdirs = "$(DESTDIR)$(infodir)" +am__vpath_adj_setup = srcdirstrip=`echo "$(srcdir)" | sed 's|.|.|g'`; +am__vpath_adj = case $$p in \ + $(srcdir)/*) f=`echo "$$p" | sed "s|^$$srcdirstrip/||"`;; \ + *) f=$$p;; \ + esac; +am__strip_dir = f=`echo $$p | sed -e 's|^.*/||'`; +am__install_max = 40 +am__nobase_strip_setup = \ + srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*|]/\\\\&/g'` +am__nobase_strip = \ + for p in $$list; do echo "$$p"; done | sed -e "s|$$srcdirstrip/||" +am__nobase_list = $(am__nobase_strip_setup); \ + for p in $$list; do echo "$$p $$p"; done | \ + sed "s| $$srcdirstrip/| |;"' / .*\//!s/ .*/ ./; s,\( .*\)/[^/]*$$,\1,' | \ + $(AWK) 'BEGIN { files["."] = "" } { files[$$2] = files[$$2] " " $$1; \ + if (++n[$$2] == $(am__install_max)) \ + { print $$2, files[$$2]; n[$$2] = 0; files[$$2] = "" } } \ + END { for (dir in files) print dir, files[dir] }' +am__base_list = \ + sed '$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;s/\n/ /g' | \ + sed '$$!N;$$!N;$$!N;$$!N;s/\n/ /g' +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +ACLOCAL = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run aclocal-1.11 +AMTAR = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run tar +AR = ar +AS = as +AUTOCONF = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoconf +AUTOHEADER = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoheader +AUTOMAKE = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run automake-1.11 +AWK = gawk +CC = gcc +CCDEPMODE = depmode=gcc3 +CFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter +CPP = gcc -E +CPPFLAGS = +CXX = g++ +CXXCPP = g++ -E +CXXDEPMODE = depmode=gcc3 +CXXFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wno-unused-parameter +CYGPATH_W = echo +DEFS = -DHAVE_CONFIG_H +DEPDIR = .deps +DLLTOOL = false +DSYMUTIL = +DUMPBIN = +ECHO_C = +ECHO_N = -n +ECHO_T = +EGREP = /usr/bin/grep -E +EXEEXT = +FGREP = /usr/bin/grep -F +GREP = /usr/bin/grep +INSTALL = /usr/bin/install -c +INSTALL_DATA = ${INSTALL} -m 644 +INSTALL_PROGRAM = ${INSTALL} +INSTALL_SCRIPT = ${INSTALL} +INSTALL_STRIP_PROGRAM = $(install_sh) -c -s +LD = /usr/bin/ld -m elf_x86_64 +LDFLAGS = +LEX = flex +LEXLIB = +LEX_OUTPUT_ROOT = lex.yy +LIBOBJS = +LIBS = +LIBTOOL = $(SHELL) $(top_builddir)/libtool +LIPO = +LN_S = ln -s +LTLIBOBJS = +MAKEINFO = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run makeinfo +MANIFEST_TOOL = : +MKDIR_P = /usr/bin/mkdir -p +NM = /usr/bin/nm -B +NMEDIT = +OBJDUMP = objdump +OBJEXT = o +OTOOL = +OTOOL64 = +PACKAGE = libconfig +PACKAGE_BUGREPORT = hyperrealm@gmail.com +PACKAGE_NAME = libconfig +PACKAGE_STRING = libconfig 1.4.9 +PACKAGE_TARNAME = libconfig +PACKAGE_URL = http://www.hyperrealm.com/main.php?s=libconfig +PACKAGE_VERSION = 1.4.9 +PATH_SEPARATOR = : +RANLIB = ranlib +SED = /usr/bin/sed +SET_MAKE = +SHELL = /bin/sh +STRIP = strip +VERSION = 1.4.9 +YACC = bison -y +YFLAGS = +abs_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/doc +abs_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/doc +abs_top_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +abs_top_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +ac_ct_AR = ar +ac_ct_CC = gcc +ac_ct_CXX = g++ +ac_ct_DUMPBIN = +am__include = include +am__leading_dot = . +am__quote = +am__tar = ${AMTAR} chof - "$$tardir" +am__untar = ${AMTAR} xf - +bindir = ${exec_prefix}/bin +build = x86_64-unknown-linux-gnu +build_alias = +build_cpu = x86_64 +build_os = linux-gnu +build_vendor = unknown +builddir = . +datadir = ${datarootdir} +datarootdir = ${prefix}/share +docdir = ${datarootdir}/doc/${PACKAGE_TARNAME} +dvidir = ${docdir} +exec_prefix = ${prefix} +host = x86_64-unknown-linux-gnu +host_alias = +host_cpu = x86_64 +host_os = linux-gnu +host_vendor = unknown +htmldir = ${docdir} +includedir = ${prefix}/include +infodir = ${datarootdir}/info +install_sh = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/install-sh +libdir = ${exec_prefix}/lib +libexecdir = ${exec_prefix}/libexec +localedir = ${datarootdir}/locale +localstatedir = ${prefix}/var +mandir = ${datarootdir}/man +mkdir_p = /usr/bin/mkdir -p +oldincludedir = /usr/include +pdfdir = ${docdir} +prefix = /usr/local +program_transform_name = s,x,x, +psdir = ${docdir} +sbindir = ${exec_prefix}/sbin +sharedstatedir = ${prefix}/com +srcdir = . +sysconfdir = ${prefix}/etc +target = x86_64-unknown-linux-gnu +target_alias = +target_cpu = x86_64 +target_os = linux-gnu +target_vendor = unknown +top_build_prefix = ../ +top_builddir = .. +top_srcdir = .. +info_TEXINFOS = libconfig.texi +libconfig_TEXINFOS = LGPL.texi +all: all-am + +.SUFFIXES: +.SUFFIXES: .dvi .html .info .pdf .ps .texi +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu doc/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu doc/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +.texi.info: + restore=: && backupdir="$(am__leading_dot)am$$$$" && \ + am__cwd=`pwd` && $(am__cd) $(srcdir) && \ + rm -rf $$backupdir && mkdir $$backupdir && \ + if ($(MAKEINFO) --version) >/dev/null 2>&1; then \ + for f in $@ $@-[0-9] $@-[0-9][0-9] $(@:.info=).i[0-9] $(@:.info=).i[0-9][0-9]; do \ + if test -f $$f; then mv $$f $$backupdir; restore=mv; else :; fi; \ + done; \ + else :; fi && \ + cd "$$am__cwd"; \ + if $(MAKEINFO) $(AM_MAKEINFOFLAGS) $(MAKEINFOFLAGS) -I $(srcdir) \ + -o $@ $<; \ + then \ + rc=0; \ + $(am__cd) $(srcdir); \ + else \ + rc=$$?; \ + $(am__cd) $(srcdir) && \ + $$restore $$backupdir/* `echo "./$@" | sed 's|[^/]*$$||'`; \ + fi; \ + rm -rf $$backupdir; exit $$rc + +.texi.dvi: + TEXINPUTS="$(am__TEXINFO_TEX_DIR)$(PATH_SEPARATOR)$$TEXINPUTS" \ + MAKEINFO='$(MAKEINFO) $(AM_MAKEINFOFLAGS) $(MAKEINFOFLAGS) -I $(srcdir)' \ + $(TEXI2DVI) $< + +.texi.pdf: + TEXINPUTS="$(am__TEXINFO_TEX_DIR)$(PATH_SEPARATOR)$$TEXINPUTS" \ + MAKEINFO='$(MAKEINFO) $(AM_MAKEINFOFLAGS) $(MAKEINFOFLAGS) -I $(srcdir)' \ + $(TEXI2PDF) $< + +.texi.html: + rm -rf $(@:.html=.htp) + if $(MAKEINFOHTML) $(AM_MAKEINFOHTMLFLAGS) $(MAKEINFOFLAGS) -I $(srcdir) \ + -o $(@:.html=.htp) $<; \ + then \ + rm -rf $@; \ + if test ! -d $(@:.html=.htp) && test -d $(@:.html=); then \ + mv $(@:.html=) $@; else mv $(@:.html=.htp) $@; fi; \ + else \ + if test ! -d $(@:.html=.htp) && test -d $(@:.html=); then \ + rm -rf $(@:.html=); else rm -Rf $(@:.html=.htp) $@; fi; \ + exit 1; \ + fi +$(srcdir)/libconfig.info: libconfig.texi $(libconfig_TEXINFOS) +libconfig.dvi: libconfig.texi $(libconfig_TEXINFOS) +libconfig.pdf: libconfig.texi $(libconfig_TEXINFOS) +libconfig.html: libconfig.texi $(libconfig_TEXINFOS) +.dvi.ps: + TEXINPUTS="$(am__TEXINFO_TEX_DIR)$(PATH_SEPARATOR)$$TEXINPUTS" \ + $(DVIPS) -o $@ $< + +uninstall-dvi-am: + @$(NORMAL_UNINSTALL) + @list='$(DVIS)'; test -n "$(dvidir)" || list=; \ + for p in $$list; do \ + $(am__strip_dir) \ + echo " rm -f '$(DESTDIR)$(dvidir)/$$f'"; \ + rm -f "$(DESTDIR)$(dvidir)/$$f"; \ + done + +uninstall-html-am: + @$(NORMAL_UNINSTALL) + @list='$(HTMLS)'; test -n "$(htmldir)" || list=; \ + for p in $$list; do \ + $(am__strip_dir) \ + echo " rm -rf '$(DESTDIR)$(htmldir)/$$f'"; \ + rm -rf "$(DESTDIR)$(htmldir)/$$f"; \ + done + +uninstall-info-am: + @$(PRE_UNINSTALL) + @if test -d '$(DESTDIR)$(infodir)' && \ + (install-info --version && \ + install-info --version 2>&1 | sed 1q | grep -i -v debian) >/dev/null 2>&1; then \ + list='$(INFO_DEPS)'; \ + for file in $$list; do \ + relfile=`echo "$$file" | sed 's|^.*/||'`; \ + echo " install-info --info-dir='$(DESTDIR)$(infodir)' --remove '$(DESTDIR)$(infodir)/$$relfile'"; \ + if install-info --info-dir="$(DESTDIR)$(infodir)" --remove "$(DESTDIR)$(infodir)/$$relfile"; \ + then :; else test ! -f "$(DESTDIR)$(infodir)/$$relfile" || exit 1; fi; \ + done; \ + else :; fi + @$(NORMAL_UNINSTALL) + @list='$(INFO_DEPS)'; \ + for file in $$list; do \ + relfile=`echo "$$file" | sed 's|^.*/||'`; \ + relfile_i=`echo "$$relfile" | sed 's|\.info$$||;s|$$|.i|'`; \ + (if test -d "$(DESTDIR)$(infodir)" && cd "$(DESTDIR)$(infodir)"; then \ + echo " cd '$(DESTDIR)$(infodir)' && rm -f $$relfile $$relfile-[0-9] $$relfile-[0-9][0-9] $$relfile_i[0-9] $$relfile_i[0-9][0-9]"; \ + rm -f $$relfile $$relfile-[0-9] $$relfile-[0-9][0-9] $$relfile_i[0-9] $$relfile_i[0-9][0-9]; \ + else :; fi); \ + done + +uninstall-pdf-am: + @$(NORMAL_UNINSTALL) + @list='$(PDFS)'; test -n "$(pdfdir)" || list=; \ + for p in $$list; do \ + $(am__strip_dir) \ + echo " rm -f '$(DESTDIR)$(pdfdir)/$$f'"; \ + rm -f "$(DESTDIR)$(pdfdir)/$$f"; \ + done + +uninstall-ps-am: + @$(NORMAL_UNINSTALL) + @list='$(PSS)'; test -n "$(psdir)" || list=; \ + for p in $$list; do \ + $(am__strip_dir) \ + echo " rm -f '$(DESTDIR)$(psdir)/$$f'"; \ + rm -f "$(DESTDIR)$(psdir)/$$f"; \ + done + +dist-info: $(INFO_DEPS) + @srcdirstrip=`echo "$(srcdir)" | sed 's|.|.|g'`; \ + list='$(INFO_DEPS)'; \ + for base in $$list; do \ + case $$base in \ + $(srcdir)/*) base=`echo "$$base" | sed "s|^$$srcdirstrip/||"`;; \ + esac; \ + if test -f $$base; then d=.; else d=$(srcdir); fi; \ + base_i=`echo "$$base" | sed 's|\.info$$||;s|$$|.i|'`; \ + for file in $$d/$$base $$d/$$base-[0-9] $$d/$$base-[0-9][0-9] $$d/$$base_i[0-9] $$d/$$base_i[0-9][0-9]; do \ + if test -f $$file; then \ + relfile=`expr "$$file" : "$$d/\(.*\)"`; \ + test -f "$(distdir)/$$relfile" || \ + cp -p $$file "$(distdir)/$$relfile"; \ + else :; fi; \ + done; \ + done + +mostlyclean-aminfo: + -rm -rf libconfig.aux libconfig.cp libconfig.cps libconfig.fn libconfig.fns \ + libconfig.ky libconfig.kys libconfig.log libconfig.pg \ + libconfig.pgs libconfig.tmp libconfig.toc libconfig.tp \ + libconfig.tps libconfig.vr libconfig.vrs + +clean-aminfo: + -test -z "libconfig.dvi libconfig.pdf libconfig.ps libconfig.html" \ + || rm -rf libconfig.dvi libconfig.pdf libconfig.ps libconfig.html + +maintainer-clean-aminfo: + @list='$(INFO_DEPS)'; for i in $$list; do \ + i_i=`echo "$$i" | sed 's|\.info$$||;s|$$|.i|'`; \ + echo " rm -f $$i $$i-[0-9] $$i-[0-9][0-9] $$i_i[0-9] $$i_i[0-9][0-9]"; \ + rm -f $$i $$i-[0-9] $$i-[0-9][0-9] $$i_i[0-9] $$i_i[0-9][0-9]; \ + done +tags: TAGS +TAGS: + +ctags: CTAGS +CTAGS: + + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done + $(MAKE) $(AM_MAKEFLAGS) \ + top_distdir="$(top_distdir)" distdir="$(distdir)" \ + dist-info +check-am: all-am +check: check-am +all-am: Makefile $(INFO_DEPS) +installdirs: + for dir in "$(DESTDIR)$(infodir)"; do \ + test -z "$$dir" || $(MKDIR_P) "$$dir"; \ + done +install: install-am +install-exec: install-exec-am +install-data: install-data-am +uninstall: uninstall-am + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-am +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-am + +clean-am: clean-aminfo clean-generic clean-libtool mostlyclean-am + +distclean: distclean-am + -rm -f Makefile +distclean-am: clean-am distclean-generic + +dvi: dvi-am + +dvi-am: $(DVIS) + +html-am: $(HTMLS) + +info: info-am + +info-am: $(INFO_DEPS) + +install-data-am: install-info-am + +install-dvi: install-dvi-am + +install-dvi-am: $(DVIS) + @$(NORMAL_INSTALL) + test -z "$(dvidir)" || $(MKDIR_P) "$(DESTDIR)$(dvidir)" + @list='$(DVIS)'; test -n "$(dvidir)" || list=; \ + for p in $$list; do \ + if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \ + echo "$$d$$p"; \ + done | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_DATA) $$files '$(DESTDIR)$(dvidir)'"; \ + $(INSTALL_DATA) $$files "$(DESTDIR)$(dvidir)" || exit $$?; \ + done +install-exec-am: + +install-html: install-html-am + +install-html-am: $(HTMLS) + @$(NORMAL_INSTALL) + test -z "$(htmldir)" || $(MKDIR_P) "$(DESTDIR)$(htmldir)" + @list='$(HTMLS)'; list2=; test -n "$(htmldir)" || list=; \ + for p in $$list; do \ + if test -f "$$p" || test -d "$$p"; then d=; else d="$(srcdir)/"; fi; \ + $(am__strip_dir) \ + if test -d "$$d$$p"; then \ + echo " $(MKDIR_P) '$(DESTDIR)$(htmldir)/$$f'"; \ + $(MKDIR_P) "$(DESTDIR)$(htmldir)/$$f" || exit 1; \ + echo " $(INSTALL_DATA) '$$d$$p'/* '$(DESTDIR)$(htmldir)/$$f'"; \ + $(INSTALL_DATA) "$$d$$p"/* "$(DESTDIR)$(htmldir)/$$f" || exit $$?; \ + else \ + list2="$$list2 $$d$$p"; \ + fi; \ + done; \ + test -z "$$list2" || { echo "$$list2" | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_DATA) $$files '$(DESTDIR)$(htmldir)'"; \ + $(INSTALL_DATA) $$files "$(DESTDIR)$(htmldir)" || exit $$?; \ + done; } +install-info: install-info-am + +install-info-am: $(INFO_DEPS) + @$(NORMAL_INSTALL) + test -z "$(infodir)" || $(MKDIR_P) "$(DESTDIR)$(infodir)" + @srcdirstrip=`echo "$(srcdir)" | sed 's|.|.|g'`; \ + list='$(INFO_DEPS)'; test -n "$(infodir)" || list=; \ + for file in $$list; do \ + case $$file in \ + $(srcdir)/*) file=`echo "$$file" | sed "s|^$$srcdirstrip/||"`;; \ + esac; \ + if test -f $$file; then d=.; else d=$(srcdir); fi; \ + file_i=`echo "$$file" | sed 's|\.info$$||;s|$$|.i|'`; \ + for ifile in $$d/$$file $$d/$$file-[0-9] $$d/$$file-[0-9][0-9] \ + $$d/$$file_i[0-9] $$d/$$file_i[0-9][0-9] ; do \ + if test -f $$ifile; then \ + echo "$$ifile"; \ + else : ; fi; \ + done; \ + done | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_DATA) $$files '$(DESTDIR)$(infodir)'"; \ + $(INSTALL_DATA) $$files "$(DESTDIR)$(infodir)" || exit $$?; done + @$(POST_INSTALL) + @if (install-info --version && \ + install-info --version 2>&1 | sed 1q | grep -i -v debian) >/dev/null 2>&1; then \ + list='$(INFO_DEPS)'; test -n "$(infodir)" || list=; \ + for file in $$list; do \ + relfile=`echo "$$file" | sed 's|^.*/||'`; \ + echo " install-info --info-dir='$(DESTDIR)$(infodir)' '$(DESTDIR)$(infodir)/$$relfile'";\ + install-info --info-dir="$(DESTDIR)$(infodir)" "$(DESTDIR)$(infodir)/$$relfile" || :;\ + done; \ + else : ; fi +install-man: + +install-pdf: install-pdf-am + +install-pdf-am: $(PDFS) + @$(NORMAL_INSTALL) + test -z "$(pdfdir)" || $(MKDIR_P) "$(DESTDIR)$(pdfdir)" + @list='$(PDFS)'; test -n "$(pdfdir)" || list=; \ + for p in $$list; do \ + if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \ + echo "$$d$$p"; \ + done | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_DATA) $$files '$(DESTDIR)$(pdfdir)'"; \ + $(INSTALL_DATA) $$files "$(DESTDIR)$(pdfdir)" || exit $$?; done +install-ps: install-ps-am + +install-ps-am: $(PSS) + @$(NORMAL_INSTALL) + test -z "$(psdir)" || $(MKDIR_P) "$(DESTDIR)$(psdir)" + @list='$(PSS)'; test -n "$(psdir)" || list=; \ + for p in $$list; do \ + if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \ + echo "$$d$$p"; \ + done | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_DATA) $$files '$(DESTDIR)$(psdir)'"; \ + $(INSTALL_DATA) $$files "$(DESTDIR)$(psdir)" || exit $$?; done +installcheck-am: + +maintainer-clean: maintainer-clean-am + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-aminfo \ + maintainer-clean-generic + +mostlyclean: mostlyclean-am + +mostlyclean-am: mostlyclean-aminfo mostlyclean-generic \ + mostlyclean-libtool + +pdf: pdf-am + +pdf-am: $(PDFS) + +ps: ps-am + +ps-am: $(PSS) + +uninstall-am: uninstall-dvi-am uninstall-html-am uninstall-info-am \ + uninstall-pdf-am uninstall-ps-am + +.MAKE: install-am install-strip + +.PHONY: all all-am check check-am clean clean-aminfo clean-generic \ + clean-libtool dist-info distclean distclean-generic \ + distclean-libtool distdir dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-info install-info-am install-man \ + install-pdf install-pdf-am install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + maintainer-clean maintainer-clean-aminfo \ + maintainer-clean-generic mostlyclean mostlyclean-aminfo \ + mostlyclean-generic mostlyclean-libtool pdf pdf-am ps ps-am \ + uninstall uninstall-am uninstall-dvi-am uninstall-html-am \ + uninstall-info-am uninstall-pdf-am uninstall-ps-am + + +html: + $(MAKEINFO) --html --no-split $(info_TEXINFOS) + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/doc/Makefile.am b/libconfig-1.4.9/doc/Makefile.am new file mode 100644 index 0000000000000000000000000000000000000000..0a4383e9df1a52983376613889e4ba609c1c1db2 --- /dev/null +++ b/libconfig-1.4.9/doc/Makefile.am @@ -0,0 +1,7 @@ + + +info_TEXINFOS = libconfig.texi +libconfig_TEXINFOS = LGPL.texi + +html: + $(MAKEINFO) --html --no-split $(info_TEXINFOS) diff --git a/libconfig-1.4.9/doc/Makefile.in b/libconfig-1.4.9/doc/Makefile.in new file mode 100644 index 0000000000000000000000000000000000000000..49fa6e95a1559c82b2091effe380ff9303547b8f --- /dev/null +++ b/libconfig-1.4.9/doc/Makefile.in @@ -0,0 +1,641 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# @configure_input@ + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + +@SET_MAKE@ +VPATH = @srcdir@ +pkgdatadir = $(datadir)/@PACKAGE@ +pkgincludedir = $(includedir)/@PACKAGE@ +pkglibdir = $(libdir)/@PACKAGE@ +pkglibexecdir = $(libexecdir)/@PACKAGE@ +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = @build@ +host_triplet = @host@ +target_triplet = @target@ +subdir = doc +DIST_COMMON = $(libconfig_TEXINFOS) $(srcdir)/Makefile.am \ + $(srcdir)/Makefile.in +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = +CONFIG_CLEAN_VPATH_FILES = +SOURCES = +DIST_SOURCES = +INFO_DEPS = $(srcdir)/libconfig.info +TEXINFO_TEX = $(top_srcdir)/aux-build/texinfo.tex +am__TEXINFO_TEX_DIR = $(top_srcdir)/aux-build +DVIS = libconfig.dvi +PDFS = libconfig.pdf +PSS = libconfig.ps +HTMLS = libconfig.html +TEXINFOS = libconfig.texi +TEXI2DVI = texi2dvi +TEXI2PDF = $(TEXI2DVI) --pdf --batch +MAKEINFOHTML = $(MAKEINFO) --html +AM_MAKEINFOHTMLFLAGS = $(AM_MAKEINFOFLAGS) +DVIPS = dvips +am__installdirs = "$(DESTDIR)$(infodir)" +am__vpath_adj_setup = srcdirstrip=`echo "$(srcdir)" | sed 's|.|.|g'`; +am__vpath_adj = case $$p in \ + $(srcdir)/*) f=`echo "$$p" | sed "s|^$$srcdirstrip/||"`;; \ + *) f=$$p;; \ + esac; +am__strip_dir = f=`echo $$p | sed -e 's|^.*/||'`; +am__install_max = 40 +am__nobase_strip_setup = \ + srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*|]/\\\\&/g'` +am__nobase_strip = \ + for p in $$list; do echo "$$p"; done | sed -e "s|$$srcdirstrip/||" +am__nobase_list = $(am__nobase_strip_setup); \ + for p in $$list; do echo "$$p $$p"; done | \ + sed "s| $$srcdirstrip/| |;"' / .*\//!s/ .*/ ./; s,\( .*\)/[^/]*$$,\1,' | \ + $(AWK) 'BEGIN { files["."] = "" } { files[$$2] = files[$$2] " " $$1; \ + if (++n[$$2] == $(am__install_max)) \ + { print $$2, files[$$2]; n[$$2] = 0; files[$$2] = "" } } \ + END { for (dir in files) print dir, files[dir] }' +am__base_list = \ + sed '$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;s/\n/ /g' | \ + sed '$$!N;$$!N;$$!N;$$!N;s/\n/ /g' +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +ACLOCAL = @ACLOCAL@ +AMTAR = @AMTAR@ +AR = @AR@ +AS = @AS@ +AUTOCONF = @AUTOCONF@ +AUTOHEADER = @AUTOHEADER@ +AUTOMAKE = @AUTOMAKE@ +AWK = @AWK@ +CC = @CC@ +CCDEPMODE = @CCDEPMODE@ +CFLAGS = @CFLAGS@ +CPP = @CPP@ +CPPFLAGS = @CPPFLAGS@ +CXX = @CXX@ +CXXCPP = @CXXCPP@ +CXXDEPMODE = @CXXDEPMODE@ +CXXFLAGS = @CXXFLAGS@ +CYGPATH_W = @CYGPATH_W@ +DEFS = @DEFS@ +DEPDIR = @DEPDIR@ +DLLTOOL = @DLLTOOL@ +DSYMUTIL = @DSYMUTIL@ +DUMPBIN = @DUMPBIN@ +ECHO_C = @ECHO_C@ +ECHO_N = @ECHO_N@ +ECHO_T = @ECHO_T@ +EGREP = @EGREP@ +EXEEXT = @EXEEXT@ +FGREP = @FGREP@ +GREP = @GREP@ +INSTALL = @INSTALL@ +INSTALL_DATA = @INSTALL_DATA@ +INSTALL_PROGRAM = @INSTALL_PROGRAM@ +INSTALL_SCRIPT = @INSTALL_SCRIPT@ +INSTALL_STRIP_PROGRAM = @INSTALL_STRIP_PROGRAM@ +LD = @LD@ +LDFLAGS = @LDFLAGS@ +LEX = @LEX@ +LEXLIB = @LEXLIB@ +LEX_OUTPUT_ROOT = @LEX_OUTPUT_ROOT@ +LIBOBJS = @LIBOBJS@ +LIBS = @LIBS@ +LIBTOOL = @LIBTOOL@ +LIPO = @LIPO@ +LN_S = @LN_S@ +LTLIBOBJS = @LTLIBOBJS@ +MAKEINFO = @MAKEINFO@ +MANIFEST_TOOL = @MANIFEST_TOOL@ +MKDIR_P = @MKDIR_P@ +NM = @NM@ +NMEDIT = @NMEDIT@ +OBJDUMP = @OBJDUMP@ +OBJEXT = @OBJEXT@ +OTOOL = @OTOOL@ +OTOOL64 = @OTOOL64@ +PACKAGE = @PACKAGE@ +PACKAGE_BUGREPORT = @PACKAGE_BUGREPORT@ +PACKAGE_NAME = @PACKAGE_NAME@ +PACKAGE_STRING = @PACKAGE_STRING@ +PACKAGE_TARNAME = @PACKAGE_TARNAME@ +PACKAGE_URL = @PACKAGE_URL@ +PACKAGE_VERSION = @PACKAGE_VERSION@ +PATH_SEPARATOR = @PATH_SEPARATOR@ +RANLIB = @RANLIB@ +SED = @SED@ +SET_MAKE = @SET_MAKE@ +SHELL = @SHELL@ +STRIP = @STRIP@ +VERSION = @VERSION@ +YACC = @YACC@ +YFLAGS = @YFLAGS@ +abs_builddir = @abs_builddir@ +abs_srcdir = @abs_srcdir@ +abs_top_builddir = @abs_top_builddir@ +abs_top_srcdir = @abs_top_srcdir@ +ac_ct_AR = @ac_ct_AR@ +ac_ct_CC = @ac_ct_CC@ +ac_ct_CXX = @ac_ct_CXX@ +ac_ct_DUMPBIN = @ac_ct_DUMPBIN@ +am__include = @am__include@ +am__leading_dot = @am__leading_dot@ +am__quote = @am__quote@ +am__tar = @am__tar@ +am__untar = @am__untar@ +bindir = @bindir@ +build = @build@ +build_alias = @build_alias@ +build_cpu = @build_cpu@ +build_os = @build_os@ +build_vendor = @build_vendor@ +builddir = @builddir@ +datadir = @datadir@ +datarootdir = @datarootdir@ +docdir = @docdir@ +dvidir = @dvidir@ +exec_prefix = @exec_prefix@ +host = @host@ +host_alias = @host_alias@ +host_cpu = @host_cpu@ +host_os = @host_os@ +host_vendor = @host_vendor@ +htmldir = @htmldir@ +includedir = @includedir@ +infodir = @infodir@ +install_sh = @install_sh@ +libdir = @libdir@ +libexecdir = @libexecdir@ +localedir = @localedir@ +localstatedir = @localstatedir@ +mandir = @mandir@ +mkdir_p = @mkdir_p@ +oldincludedir = @oldincludedir@ +pdfdir = @pdfdir@ +prefix = @prefix@ +program_transform_name = @program_transform_name@ +psdir = @psdir@ +sbindir = @sbindir@ +sharedstatedir = @sharedstatedir@ +srcdir = @srcdir@ +sysconfdir = @sysconfdir@ +target = @target@ +target_alias = @target_alias@ +target_cpu = @target_cpu@ +target_os = @target_os@ +target_vendor = @target_vendor@ +top_build_prefix = @top_build_prefix@ +top_builddir = @top_builddir@ +top_srcdir = @top_srcdir@ +info_TEXINFOS = libconfig.texi +libconfig_TEXINFOS = LGPL.texi +all: all-am + +.SUFFIXES: +.SUFFIXES: .dvi .html .info .pdf .ps .texi +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu doc/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu doc/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +.texi.info: + restore=: && backupdir="$(am__leading_dot)am$$$$" && \ + am__cwd=`pwd` && $(am__cd) $(srcdir) && \ + rm -rf $$backupdir && mkdir $$backupdir && \ + if ($(MAKEINFO) --version) >/dev/null 2>&1; then \ + for f in $@ $@-[0-9] $@-[0-9][0-9] $(@:.info=).i[0-9] $(@:.info=).i[0-9][0-9]; do \ + if test -f $$f; then mv $$f $$backupdir; restore=mv; else :; fi; \ + done; \ + else :; fi && \ + cd "$$am__cwd"; \ + if $(MAKEINFO) $(AM_MAKEINFOFLAGS) $(MAKEINFOFLAGS) -I $(srcdir) \ + -o $@ $<; \ + then \ + rc=0; \ + $(am__cd) $(srcdir); \ + else \ + rc=$$?; \ + $(am__cd) $(srcdir) && \ + $$restore $$backupdir/* `echo "./$@" | sed 's|[^/]*$$||'`; \ + fi; \ + rm -rf $$backupdir; exit $$rc + +.texi.dvi: + TEXINPUTS="$(am__TEXINFO_TEX_DIR)$(PATH_SEPARATOR)$$TEXINPUTS" \ + MAKEINFO='$(MAKEINFO) $(AM_MAKEINFOFLAGS) $(MAKEINFOFLAGS) -I $(srcdir)' \ + $(TEXI2DVI) $< + +.texi.pdf: + TEXINPUTS="$(am__TEXINFO_TEX_DIR)$(PATH_SEPARATOR)$$TEXINPUTS" \ + MAKEINFO='$(MAKEINFO) $(AM_MAKEINFOFLAGS) $(MAKEINFOFLAGS) -I $(srcdir)' \ + $(TEXI2PDF) $< + +.texi.html: + rm -rf $(@:.html=.htp) + if $(MAKEINFOHTML) $(AM_MAKEINFOHTMLFLAGS) $(MAKEINFOFLAGS) -I $(srcdir) \ + -o $(@:.html=.htp) $<; \ + then \ + rm -rf $@; \ + if test ! -d $(@:.html=.htp) && test -d $(@:.html=); then \ + mv $(@:.html=) $@; else mv $(@:.html=.htp) $@; fi; \ + else \ + if test ! -d $(@:.html=.htp) && test -d $(@:.html=); then \ + rm -rf $(@:.html=); else rm -Rf $(@:.html=.htp) $@; fi; \ + exit 1; \ + fi +$(srcdir)/libconfig.info: libconfig.texi $(libconfig_TEXINFOS) +libconfig.dvi: libconfig.texi $(libconfig_TEXINFOS) +libconfig.pdf: libconfig.texi $(libconfig_TEXINFOS) +libconfig.html: libconfig.texi $(libconfig_TEXINFOS) +.dvi.ps: + TEXINPUTS="$(am__TEXINFO_TEX_DIR)$(PATH_SEPARATOR)$$TEXINPUTS" \ + $(DVIPS) -o $@ $< + +uninstall-dvi-am: + @$(NORMAL_UNINSTALL) + @list='$(DVIS)'; test -n "$(dvidir)" || list=; \ + for p in $$list; do \ + $(am__strip_dir) \ + echo " rm -f '$(DESTDIR)$(dvidir)/$$f'"; \ + rm -f "$(DESTDIR)$(dvidir)/$$f"; \ + done + +uninstall-html-am: + @$(NORMAL_UNINSTALL) + @list='$(HTMLS)'; test -n "$(htmldir)" || list=; \ + for p in $$list; do \ + $(am__strip_dir) \ + echo " rm -rf '$(DESTDIR)$(htmldir)/$$f'"; \ + rm -rf "$(DESTDIR)$(htmldir)/$$f"; \ + done + +uninstall-info-am: + @$(PRE_UNINSTALL) + @if test -d '$(DESTDIR)$(infodir)' && \ + (install-info --version && \ + install-info --version 2>&1 | sed 1q | grep -i -v debian) >/dev/null 2>&1; then \ + list='$(INFO_DEPS)'; \ + for file in $$list; do \ + relfile=`echo "$$file" | sed 's|^.*/||'`; \ + echo " install-info --info-dir='$(DESTDIR)$(infodir)' --remove '$(DESTDIR)$(infodir)/$$relfile'"; \ + if install-info --info-dir="$(DESTDIR)$(infodir)" --remove "$(DESTDIR)$(infodir)/$$relfile"; \ + then :; else test ! -f "$(DESTDIR)$(infodir)/$$relfile" || exit 1; fi; \ + done; \ + else :; fi + @$(NORMAL_UNINSTALL) + @list='$(INFO_DEPS)'; \ + for file in $$list; do \ + relfile=`echo "$$file" | sed 's|^.*/||'`; \ + relfile_i=`echo "$$relfile" | sed 's|\.info$$||;s|$$|.i|'`; \ + (if test -d "$(DESTDIR)$(infodir)" && cd "$(DESTDIR)$(infodir)"; then \ + echo " cd '$(DESTDIR)$(infodir)' && rm -f $$relfile $$relfile-[0-9] $$relfile-[0-9][0-9] $$relfile_i[0-9] $$relfile_i[0-9][0-9]"; \ + rm -f $$relfile $$relfile-[0-9] $$relfile-[0-9][0-9] $$relfile_i[0-9] $$relfile_i[0-9][0-9]; \ + else :; fi); \ + done + +uninstall-pdf-am: + @$(NORMAL_UNINSTALL) + @list='$(PDFS)'; test -n "$(pdfdir)" || list=; \ + for p in $$list; do \ + $(am__strip_dir) \ + echo " rm -f '$(DESTDIR)$(pdfdir)/$$f'"; \ + rm -f "$(DESTDIR)$(pdfdir)/$$f"; \ + done + +uninstall-ps-am: + @$(NORMAL_UNINSTALL) + @list='$(PSS)'; test -n "$(psdir)" || list=; \ + for p in $$list; do \ + $(am__strip_dir) \ + echo " rm -f '$(DESTDIR)$(psdir)/$$f'"; \ + rm -f "$(DESTDIR)$(psdir)/$$f"; \ + done + +dist-info: $(INFO_DEPS) + @srcdirstrip=`echo "$(srcdir)" | sed 's|.|.|g'`; \ + list='$(INFO_DEPS)'; \ + for base in $$list; do \ + case $$base in \ + $(srcdir)/*) base=`echo "$$base" | sed "s|^$$srcdirstrip/||"`;; \ + esac; \ + if test -f $$base; then d=.; else d=$(srcdir); fi; \ + base_i=`echo "$$base" | sed 's|\.info$$||;s|$$|.i|'`; \ + for file in $$d/$$base $$d/$$base-[0-9] $$d/$$base-[0-9][0-9] $$d/$$base_i[0-9] $$d/$$base_i[0-9][0-9]; do \ + if test -f $$file; then \ + relfile=`expr "$$file" : "$$d/\(.*\)"`; \ + test -f "$(distdir)/$$relfile" || \ + cp -p $$file "$(distdir)/$$relfile"; \ + else :; fi; \ + done; \ + done + +mostlyclean-aminfo: + -rm -rf libconfig.aux libconfig.cp libconfig.cps libconfig.fn libconfig.fns \ + libconfig.ky libconfig.kys libconfig.log libconfig.pg \ + libconfig.pgs libconfig.tmp libconfig.toc libconfig.tp \ + libconfig.tps libconfig.vr libconfig.vrs + +clean-aminfo: + -test -z "libconfig.dvi libconfig.pdf libconfig.ps libconfig.html" \ + || rm -rf libconfig.dvi libconfig.pdf libconfig.ps libconfig.html + +maintainer-clean-aminfo: + @list='$(INFO_DEPS)'; for i in $$list; do \ + i_i=`echo "$$i" | sed 's|\.info$$||;s|$$|.i|'`; \ + echo " rm -f $$i $$i-[0-9] $$i-[0-9][0-9] $$i_i[0-9] $$i_i[0-9][0-9]"; \ + rm -f $$i $$i-[0-9] $$i-[0-9][0-9] $$i_i[0-9] $$i_i[0-9][0-9]; \ + done +tags: TAGS +TAGS: + +ctags: CTAGS +CTAGS: + + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done + $(MAKE) $(AM_MAKEFLAGS) \ + top_distdir="$(top_distdir)" distdir="$(distdir)" \ + dist-info +check-am: all-am +check: check-am +all-am: Makefile $(INFO_DEPS) +installdirs: + for dir in "$(DESTDIR)$(infodir)"; do \ + test -z "$$dir" || $(MKDIR_P) "$$dir"; \ + done +install: install-am +install-exec: install-exec-am +install-data: install-data-am +uninstall: uninstall-am + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-am +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-am + +clean-am: clean-aminfo clean-generic clean-libtool mostlyclean-am + +distclean: distclean-am + -rm -f Makefile +distclean-am: clean-am distclean-generic + +dvi: dvi-am + +dvi-am: $(DVIS) + +html-am: $(HTMLS) + +info: info-am + +info-am: $(INFO_DEPS) + +install-data-am: install-info-am + +install-dvi: install-dvi-am + +install-dvi-am: $(DVIS) + @$(NORMAL_INSTALL) + test -z "$(dvidir)" || $(MKDIR_P) "$(DESTDIR)$(dvidir)" + @list='$(DVIS)'; test -n "$(dvidir)" || list=; \ + for p in $$list; do \ + if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \ + echo "$$d$$p"; \ + done | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_DATA) $$files '$(DESTDIR)$(dvidir)'"; \ + $(INSTALL_DATA) $$files "$(DESTDIR)$(dvidir)" || exit $$?; \ + done +install-exec-am: + +install-html: install-html-am + +install-html-am: $(HTMLS) + @$(NORMAL_INSTALL) + test -z "$(htmldir)" || $(MKDIR_P) "$(DESTDIR)$(htmldir)" + @list='$(HTMLS)'; list2=; test -n "$(htmldir)" || list=; \ + for p in $$list; do \ + if test -f "$$p" || test -d "$$p"; then d=; else d="$(srcdir)/"; fi; \ + $(am__strip_dir) \ + if test -d "$$d$$p"; then \ + echo " $(MKDIR_P) '$(DESTDIR)$(htmldir)/$$f'"; \ + $(MKDIR_P) "$(DESTDIR)$(htmldir)/$$f" || exit 1; \ + echo " $(INSTALL_DATA) '$$d$$p'/* '$(DESTDIR)$(htmldir)/$$f'"; \ + $(INSTALL_DATA) "$$d$$p"/* "$(DESTDIR)$(htmldir)/$$f" || exit $$?; \ + else \ + list2="$$list2 $$d$$p"; \ + fi; \ + done; \ + test -z "$$list2" || { echo "$$list2" | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_DATA) $$files '$(DESTDIR)$(htmldir)'"; \ + $(INSTALL_DATA) $$files "$(DESTDIR)$(htmldir)" || exit $$?; \ + done; } +install-info: install-info-am + +install-info-am: $(INFO_DEPS) + @$(NORMAL_INSTALL) + test -z "$(infodir)" || $(MKDIR_P) "$(DESTDIR)$(infodir)" + @srcdirstrip=`echo "$(srcdir)" | sed 's|.|.|g'`; \ + list='$(INFO_DEPS)'; test -n "$(infodir)" || list=; \ + for file in $$list; do \ + case $$file in \ + $(srcdir)/*) file=`echo "$$file" | sed "s|^$$srcdirstrip/||"`;; \ + esac; \ + if test -f $$file; then d=.; else d=$(srcdir); fi; \ + file_i=`echo "$$file" | sed 's|\.info$$||;s|$$|.i|'`; \ + for ifile in $$d/$$file $$d/$$file-[0-9] $$d/$$file-[0-9][0-9] \ + $$d/$$file_i[0-9] $$d/$$file_i[0-9][0-9] ; do \ + if test -f $$ifile; then \ + echo "$$ifile"; \ + else : ; fi; \ + done; \ + done | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_DATA) $$files '$(DESTDIR)$(infodir)'"; \ + $(INSTALL_DATA) $$files "$(DESTDIR)$(infodir)" || exit $$?; done + @$(POST_INSTALL) + @if (install-info --version && \ + install-info --version 2>&1 | sed 1q | grep -i -v debian) >/dev/null 2>&1; then \ + list='$(INFO_DEPS)'; test -n "$(infodir)" || list=; \ + for file in $$list; do \ + relfile=`echo "$$file" | sed 's|^.*/||'`; \ + echo " install-info --info-dir='$(DESTDIR)$(infodir)' '$(DESTDIR)$(infodir)/$$relfile'";\ + install-info --info-dir="$(DESTDIR)$(infodir)" "$(DESTDIR)$(infodir)/$$relfile" || :;\ + done; \ + else : ; fi +install-man: + +install-pdf: install-pdf-am + +install-pdf-am: $(PDFS) + @$(NORMAL_INSTALL) + test -z "$(pdfdir)" || $(MKDIR_P) "$(DESTDIR)$(pdfdir)" + @list='$(PDFS)'; test -n "$(pdfdir)" || list=; \ + for p in $$list; do \ + if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \ + echo "$$d$$p"; \ + done | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_DATA) $$files '$(DESTDIR)$(pdfdir)'"; \ + $(INSTALL_DATA) $$files "$(DESTDIR)$(pdfdir)" || exit $$?; done +install-ps: install-ps-am + +install-ps-am: $(PSS) + @$(NORMAL_INSTALL) + test -z "$(psdir)" || $(MKDIR_P) "$(DESTDIR)$(psdir)" + @list='$(PSS)'; test -n "$(psdir)" || list=; \ + for p in $$list; do \ + if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \ + echo "$$d$$p"; \ + done | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_DATA) $$files '$(DESTDIR)$(psdir)'"; \ + $(INSTALL_DATA) $$files "$(DESTDIR)$(psdir)" || exit $$?; done +installcheck-am: + +maintainer-clean: maintainer-clean-am + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-aminfo \ + maintainer-clean-generic + +mostlyclean: mostlyclean-am + +mostlyclean-am: mostlyclean-aminfo mostlyclean-generic \ + mostlyclean-libtool + +pdf: pdf-am + +pdf-am: $(PDFS) + +ps: ps-am + +ps-am: $(PSS) + +uninstall-am: uninstall-dvi-am uninstall-html-am uninstall-info-am \ + uninstall-pdf-am uninstall-ps-am + +.MAKE: install-am install-strip + +.PHONY: all all-am check check-am clean clean-aminfo clean-generic \ + clean-libtool dist-info distclean distclean-generic \ + distclean-libtool distdir dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-info install-info-am install-man \ + install-pdf install-pdf-am install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + maintainer-clean maintainer-clean-aminfo \ + maintainer-clean-generic mostlyclean mostlyclean-aminfo \ + mostlyclean-generic mostlyclean-libtool pdf pdf-am ps ps-am \ + uninstall uninstall-am uninstall-dvi-am uninstall-html-am \ + uninstall-info-am uninstall-pdf-am uninstall-ps-am + + +html: + $(MAKEINFO) --html --no-split $(info_TEXINFOS) + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/doc/libconfig.info b/libconfig-1.4.9/doc/libconfig.info new file mode 100644 index 0000000000000000000000000000000000000000..0a0e8136221906e40a458a934b062a98ef1c70fe --- /dev/null +++ b/libconfig-1.4.9/doc/libconfig.info @@ -0,0 +1,2490 @@ +This is libconfig.info, produced by makeinfo version 4.13 from +libconfig.texi. + +INFO-DIR-SECTION Software libraries +START-INFO-DIR-ENTRY +* libconfig: (libconfig). A Library For Processing Structured Configuration Files +END-INFO-DIR-ENTRY + + +File: libconfig.info, Node: Top, Next: Introduction, Up: (dir) + +libconfig +********* + +* Menu: + +* Introduction:: +* Configuration Files:: +* The C API:: +* The C++ API:: +* Example Programs:: +* Configuration File Grammar:: +* License:: +* Function Index:: +* Type Index:: +* Concept Index:: + + +File: libconfig.info, Node: Introduction, Next: Configuration Files, Prev: Top, Up: Top + +* Menu: + +* Why Another Configuration File Library?:: +* Using the Library from a C Program:: +* Using the Library from a C++ Program:: +* Multithreading Issues:: +* Internationalization Issues:: +* Compiling Using pkg-config:: +* Version Test Macros:: + +1 Introduction +************** + +Libconfig is a library for reading, manipulating, and writing +structured configuration files. The library features a fully reentrant +parser and includes bindings for both the C and C++ programming +languages. + + The library runs on modern POSIX-compilant systems, such as Linux, +Solaris, and Mac OS X (Darwin), as well as on Microsoft Windows 2000/XP +and later (with either Microsoft Visual Studio 2005 or later, or the +GNU toolchain via the MinGW environment). + + +File: libconfig.info, Node: Why Another Configuration File Library?, Next: Using the Library from a C Program, Up: Introduction + +1.1 Why Another Configuration File Library? +=========================================== + +There are several open-source configuration file libraries available as +of this writing. This library was written because each of those +libraries falls short in one or more ways. The main features of +libconfig that set it apart from the other libraries are: + + * A fully reentrant parser. Independent configurations can be parsed + in concurrent threads at the same time. + + * Both C and C++ bindings, as well as hooks to allow for the + creation of wrappers in other languages. + + * A simple, structured configuration file format that is more + readable and compact than XML and more flexible than the obsolete + but prevalent Windows "INI" file format. + + * A low-footprint implementation (just 37K for the C library and 76K + for the C++ library) that is suitable for memory-constrained + systems. + + * Proper documentation. + + + +File: libconfig.info, Node: Using the Library from a C Program, Next: Using the Library from a C++ Program, Prev: Why Another Configuration File Library?, Up: Introduction + +1.2 Using the Library from a C Program +====================================== + +To use the library from C code, include the following preprocessor +directive in your source files: + + + #include + + + To link with the library, specify `-lconfig' as an argument to the +linker. + + +File: libconfig.info, Node: Using the Library from a C++ Program, Next: Multithreading Issues, Prev: Using the Library from a C Program, Up: Introduction + +1.3 Using the Library from a C++ Program +======================================== + +To use the library from C++, include the following preprocessor +directive in your source files: + + + #include + + + Or, alternatively: + + + #include + + + The C++ API classes are defined in the namespace `libconfig', hence +the following statement may optionally be used: + + + using namespace libconfig; + + + To link with the library, specify `-lconfig++' as an argument to the +linker. + + +File: libconfig.info, Node: Multithreading Issues, Next: Internationalization Issues, Prev: Using the Library from a C++ Program, Up: Introduction + +1.4 Multithreading Issues +========================= + +Libconfig is fully "reentrant"; the functions in the library do not +make use of global variables and do not maintain state between +successive calls. Therefore two independent configurations may be safely +manipulated concurrently by two distinct threads. + + Libconfig is not "thread-safe". The library is not aware of the +presence of threads and knows nothing about the host system's threading +model. Therefore, if an instance of a configuration is to be accessed +from multiple threads, it must be suitably protected by synchronization +mechanisms like read-write locks or mutexes; the standard rules for +safe multithreaded access to shared data must be observed. + + Libconfig is not "async-safe". Calls should not be made into the +library from signal handlers, because some of the C library routines +that it uses may not be async-safe. + + Libconfig is not guaranteed to be "cancel-safe". Since it is not +aware of the host system's threading model, the library does not +contain any thread cancellation points. In most cases this will not be +an issue for multithreaded programs. However, be aware that some of the +routines in the library (namely those that read/write configurations +from/to files or streams) perform I/O using C library routines which +may potentially block; whether or not these C library routines are +cancel-safe depends on the host system. + + +File: libconfig.info, Node: Internationalization Issues, Next: Compiling Using pkg-config, Prev: Multithreading Issues, Up: Introduction + +1.5 Internationalization Issues +=============================== + +Libconfig does not natively support Unicode configuration files, but +string values may contain Unicode text encoded in UTF-8; such strings +will be treated as ordinary 8-bit ASCII text by the library. It is the +responsibility of the calling program to perform the necessary +conversions to/from wide (wchar_t) strings using the wide string +conversion functions such as mbsrtowcs() and wcsrtombs() or the iconv() +function of the libiconv library. + + The textual representation of a floating point value varies by +locale. However, the libconfig grammar specifies that floating point +values are represented using a period (`.') as the radix symbol; this +is consistent with the grammar of most programming languages. When a +configuration is read in or written out, libconfig temporarily changes +the LC_NUMERIC category of the locale of the calling thread to the "C" +locale to ensure consistent handling of floating point values +regardless of the locale(s) in use by the calling program. + + Note that the MinGW environment does not (as of this writing) provide +functions for changing the locale of the calling thread. Therefore, +when using libconfig in that environment, the calling program is +responsible for changing the LC_NUMERIC category of the locale to the +"C" locale before reading or writing a configuration. + + +File: libconfig.info, Node: Compiling Using pkg-config, Next: Version Test Macros, Prev: Internationalization Issues, Up: Introduction + +1.6 Compiling Using pkg-config +============================== + +On UNIX systems you can use the pkg-config utility (version 0.20 or +later) to automatically select the appropriate compiler and linker +switches for libconfig. Ensure that the environment variable +`PKG_CONFIG_PATH' contains the absolute path to the `lib/pkgconfig' +subdirectory of the libconfig installation. Then, you can compile and +link C programs with libconfig as follows: + + gcc `pkg-config --cflags libconfig` myprogram.c -o myprogram \ + `pkg-config --libs libconfig` + + + And similarly, for C++ programs: + + g++ `pkg-config --cflags libconfig++` myprogram.cpp -o myprogram \ + `pkg-config --libs libconfig++` + + + Note the backticks in the above examples. + + When using autoconf, the `PKG_CHECK_MODULES' m4 macro may be used to +check for the presence of a given version of libconfig, and set the +appropriate Makefile variables automatically. For example: + + PKG_CHECK_MODULES([LIBCONFIGXX], [libconfig++ >= 1.4],, + AC_MSG_ERROR([libconfig++ 1.4 or newer not found.]) + ) + + In the above example, if libconfig++ version 1.4 or newer is found, +the Makefile variables `LIBCONFIGXX_LIBS' and `LIBCONFIGXX_CFLAGS' will +be set to the appropriate compiler and linker flags for compiling with +libconfig, and if it is not found, the configure script will abort with +an error to that effect. + + +File: libconfig.info, Node: Version Test Macros, Prev: Compiling Using pkg-config, Up: Introduction + +1.7 Version Test Macros +======================= + +The `libconfig.h' header declares the following macros: + + -- Macro: LIBCONFIG_VER_MAJOR + -- Macro: LIBCONFIG_VER_MINOR + -- Macro: LIBCONFIG_VER_REVISION + These macros represent the major version, minor version, and + revision of the libconfig library. For example, in libconfig 1.4 + these are defined as `1', `4', and `0', respectively. These macros + can be used in preprocessor directives to determine which + libconfig features and/or APIs are present. For example: + + #if (((LIBCONFIG_VER_MAJOR == 1) && (LIBCONFIG_VER_MINOR >= 4)) \ + || (LIBCONFIG_VER_MAJOR > 1)) + /* use features present in libconfig 1.4 and later */ + #endif + + These macros were introduced in libconfig 1.4. + + + Similarly, the `libconfig.h++' header declares the following macros: + + -- Macro: LIBCONFIGXX_VER_MAJOR + -- Macro: LIBCONFIGXX_VER_MINOR + -- Macro: LIBCONFIGXX_VER_REVISION + These macros represent the major version, minor version, and + revision of the libconfig++ library. + + + +File: libconfig.info, Node: Configuration Files, Next: The C API, Prev: Introduction, Up: Top + +* Menu: + +* Settings:: +* Groups:: +* Arrays:: +* Lists:: +* Integer Values:: +* 64-bit Integer Values:: +* Floating Point Values:: +* Boolean Values:: +* String Values:: +* Comments:: +* Include Directives:: + +2 Configuration Files +********************* + +Libconfig supports structured, hierarchical configurations. These +configurations can be read from and written to files and manipulated in +memory. + + A "configuration" consists of a group of "settings", which associate +names with values. A "value" can be one of the following: + + * A "scalar value": integer, 64-bit integer, floating-point number, + boolean, or string + + * An "array", which is a sequence of scalar values, all of which + must have the same type + + * A "group", which is a collection of settings + + * A "list", which is a sequence of values of any type, including + other lists + + Consider the following configuration file for a hypothetical GUI +application, which illustrates all of the elements of the configuration +file grammar. + + + # Example application configuration file + + version = "1.0"; + + application: + { + window: + { + title = "My Application"; + size = { w = 640; h = 480; }; + pos = { x = 350; y = 250; }; + }; + + list = ( ( "abc", 123, true ), 1.234, ( /* an empty list */) ); + + books = ( { title = "Treasure Island"; + author = "Robert Louis Stevenson"; + price = 29.95; + qty = 5; }, + { title = "Snow Crash"; + author = "Neal Stephenson"; + price = 9.99; + qty = 8; } ); + + misc: + { + pi = 3.141592654; + bigint = 9223372036854775807L; + columns = [ "Last Name", "First Name", "MI" ]; + bitmask = 0x1FC3; + }; + }; + + + Settings can be uniquely identified within the configuration by a +"path". The path is a dot-separated sequence of names, beginning at a +top-level group and ending at the setting itself. Each name in the path +is the name of a setting; if the setting has no name because it is an +element in a list or array, an integer index in square brackets can be +used as the name. + + For example, in our hypothetical configuration file, the path to the +`x' setting is `application.window.pos.x'; the path to the `version' +setting is simply `version'; and the path to the `title' setting of the +second book in the `books' list is `application.books.[1].title'. + + The datatype of a value is determined from the format of the value +itself. If the value is enclosed in double quotes, it is treated as a +string. If it looks like an integer or floating point number, it is +treated as such. If it is one of the values `TRUE', `true', `FALSE', or +`false' (or any other mixed-case version of those tokens, e.g., `True' +or `FaLsE'), it is treated as a boolean. If it consists of a +comma-separated list of values enclosed in square brackets, it is +treated as an array. And if it consists of a comma-separated list of +values enclosed in parentheses, it is treated as a list. Any value +which does not meet any of these criteria is considered invalid and +results in a parse error. + + All names are case-sensitive. They may consist only of alphanumeric +characters, dashes (`-'), underscores (`_'), and asterisks (`*'), and +must begin with a letter or asterisk. No other characters are allowed. + + In C and C++, integer, 64-bit integer, floating point, and string +values are mapped to the types `int', `long long', `double', and `const +char *', respectively. The boolean type is mapped to `int' in C and +`bool' in C++. + + The following sections describe the elements of the configuration +file grammar in additional detail. + + +File: libconfig.info, Node: Settings, Next: Groups, Up: Configuration Files + +2.1 Settings +============ + +A setting has the form: + + name = value ; + + or: + + name : value ; + + The trailing semicolon is optional. Whitespace is not significant. + + The value may be a scalar value, an array, a group, or a list. + + +File: libconfig.info, Node: Groups, Next: Arrays, Prev: Settings, Up: Configuration Files + +2.2 Groups +========== + +A group has the form: + + { settings ... } + + Groups can contain any number of settings, but each setting must have +a unique name within the group. + + +File: libconfig.info, Node: Arrays, Next: Lists, Prev: Groups, Up: Configuration Files + +2.3 Arrays +========== + +An array has the form: + + [ value, value ... ] + + An array may have zero or more elements, but the elements must all be +scalar values of the same type. + + +File: libconfig.info, Node: Lists, Next: Integer Values, Prev: Arrays, Up: Configuration Files + +2.4 Lists +========= + +A list has the form: + + ( value, value ... ) + + A list may have zero or more elements, each of which can be a scalar +value, an array, a group, or another list. + + +File: libconfig.info, Node: Integer Values, Next: 64-bit Integer Values, Prev: Lists, Up: Configuration Files + +2.5 Integer Values +================== + +Integers can be represented in one of two ways: as a series of one or +more decimal digits (`0' - `9'), with an optional leading sign +character (`+' or `-'); or as a hexadecimal value consisting of the +characters `0x' followed by a series of one or more hexadecimal digits +(`0' - `9', `A' - `F', `a' - `f'). + + +File: libconfig.info, Node: 64-bit Integer Values, Next: Floating Point Values, Prev: Integer Values, Up: Configuration Files + +2.6 64-bit Integer Values +========================= + +Long long (64-bit) integers are represented identically to integers, +except that an 'L' character is appended to indicate a 64-bit value. +For example, `0L' indicates a 64-bit integer value 0. + + +File: libconfig.info, Node: Floating Point Values, Next: Boolean Values, Prev: 64-bit Integer Values, Up: Configuration Files + +2.7 Floating Point Values +========================= + +Floating point values consist of a series of one or more digits, one +decimal point, an optional leading sign character (`+' or `-'), and an +optional exponent. An exponent consists of the letter `E' or `e', an +optional sign character, and a series of one or more digits. + + +File: libconfig.info, Node: Boolean Values, Next: String Values, Prev: Floating Point Values, Up: Configuration Files + +2.8 Boolean Values +================== + +Boolean values may have one of the following values: `true', `false', +or any mixed-case variation thereof. + + +File: libconfig.info, Node: String Values, Next: Comments, Prev: Boolean Values, Up: Configuration Files + +2.9 String Values +================= + +String values consist of arbitrary text delimited by double quotes. +Literal double quotes can be escaped by preceding them with a +backslash: `\"'. The escape sequences `\\', `\f', `\n', `\r', and `\t' +are also recognized, and have the usual meaning. + + In addition, the `\x' escape sequence is supported; this sequence +must be followed by exactly two hexadecimal digits, which represent an +8-bit ASCII value. For example, `\xFF' represents the character with +ASCII code 0xFF. + + No other escape sequences are currently supported. + + Adjacent strings are automatically concatenated, as in C/C++ source +code. This is useful for formatting very long strings as sequences of +shorter strings. For example, the following constructs are equivalent: + + * `"The quick brown fox jumped over the lazy dog."' + + * `"The quick brown fox"' + `" jumped over the lazy dog."' + + * `"The quick" /* comment */ " brown fox " // another comment' + `"jumped over the lazy dog."' + + + +File: libconfig.info, Node: Comments, Next: Include Directives, Prev: String Values, Up: Configuration Files + +2.10 Comments +============= + +Three types of comments are allowed within a configuration: + + * Script-style comments. All text beginning with a `#' character to + the end of the line is ignored. + + * C-style comments. All text, including line breaks, between a + starting `/*' sequence and an ending `*/' sequence is ignored. + + * C++-style comments. All text beginning with a `//' sequence to the + end of the line is ignored. + + + As expected, comment delimiters appearing within quoted strings are +treated as literal text. + + Comments are ignored when the configuration is read in, so they are +not treated as part of the configuration. Therefore if the +configuration is written back out to a stream, any comments that were +present in the original configuration will be lost. + + +File: libconfig.info, Node: Include Directives, Prev: Comments, Up: Configuration Files + +2.11 Include Directives +======================= + +A configuration file may "include" the contents of another file using +an include directive. This directive has the effect of inlining the +contents of the named file at the point of inclusion. + + An include directive must appear on its own line in the input. It has +the form: + + @include "filename" + + Any backslashes or double quotes in the filename must be escaped as +`\\' and `\"', respectively. + + For example, consider the following two configuration files: + + # file: quote.cfg + quote = "Criticism may not be agreeable, but it is necessary." + " It fulfils the same function as pain in the human" + " body. It calls attention to an unhealthy state of" + " things.\n" + "\t--Winston Churchill"; + + # file: test.cfg + info: { + name = "Winston Churchill"; + @include "quote.cfg" + country = "UK"; + }; + + Include files may be nested to a maximum of 10 levels; exceeding this +limit results in a parse error. + + Like comments, include directives are not part of the configuration +file syntax. They are processed before the configuration itself is +parsed. Therefore, they are not preserved when the configuration is +written back out to a stream. There is presently no support for +programmatically inserting include directives into a configuration. + + +File: libconfig.info, Node: The C API, Next: The C++ API, Prev: Configuration Files, Up: Top + +3 The C API +*********** + +This chapter describes the C library API. The type config_t represents +a configuration, and the type config_setting_t represents a +configuration setting. + + The boolean values `CONFIG_TRUE' and `CONFIG_FALSE' are macros +defined as `(1)' and `(0)', respectively. + + -- Function: void config_init (config_t * CONFIG) + -- Function: void config_destroy (config_t * CONFIG) + These functions initialize and destroy the configuration object + CONFIG. + + `config_init()' initializes the config_t structure pointed to by + CONFIG as a new, empty configuration. + + `config_destroy()' destroys the configuration CONFIG, deallocating + all memory associated with the configuration, but does not attempt + to deallocate the config_t structure itself. + + + -- Function: int config_read (config_t * CONFIG, FILE * STREAM) + This function reads and parses a configuration from the given + STREAM into the configuration object CONFIG. It returns + `CONFIG_TRUE' on success, or `CONFIG_FALSE' on failure; the + `config_error_text()', `config_error_file()', + `config_error_line()', and `config_error_type()' functions, + described below, can be used to obtain information about the error. + + + -- Function: int config_read_file (config_t * CONFIG, + const char * FILENAME) + This function reads and parses a configuration from the file named + FILENAME into the configuration object CONFIG. It returns + `CONFIG_TRUE' on success, or `CONFIG_FALSE' on failure; the + `config_error_text()' and `config_error_line()' functions, + described below, can be used to obtain information about the error. + + + -- Function: int config_read_string (config_t * CONFIG, + const char * STR) + This function reads and parses a configuration from the string STR + into the configuration object CONFIG. It returns `CONFIG_TRUE' on + success, or `CONFIG_FALSE' on failure; the `config_error_text()' + and `config_error_line()' functions, described below, can be used + to obtain information about the error. + + + -- Function: void config_write (const config_t * CONFIG, FILE * STREAM) + This function writes the configuration CONFIG to the given STREAM. + + + -- Function: int config_write_file (config_t * CONFIG, + const char * FILENAME) + This function writes the configuration CONFIG to the file named + FILENAME. It returns `CONFIG_TRUE' on success, or `CONFIG_FALSE' + on failure. + + + -- Function: const char * config_error_text (const config_t * CONFIG) + -- Function: const char * config_error_file (const config_t * CONFIG) + -- Function: int config_error_line (const config_t * CONFIG) + These functions, which are implemented as macros, return the text, + filename, and line number of the parse error, if one occurred + during a call to `config_read()', `config_read_string()', or + `config_read_file()'. Storage for the strings returned by + `config_error_text()' and `config_error_file()' are managed by the + library and released automatically when the configuration is + destroyed; these strings must not be freed by the caller. If the + error occurred in text that was read from a string or stream, + `config_error_file()' will return NULL. + + + -- Function: config_error_t config_error_type (const config_t * CONFIG) + This function, which is implemented as a macro, returns the type of + error that occurred during the last call to one of the read or + write functions. The CONFIG_ERROR_T type is an enumeration with the + following values: `CONFIG_ERR_NONE', `CONFIG_ERR_FILE_IO', + `CONFIG_ERR_PARSE'. These represent success, a file I/O error, and + a parsing error, respectively. + + + -- Function: void config_set_include_dir (config_t *CONFIG, + const char *INCLUDE_DIR) + -- Function: const char * config_get_include_dir + (const config_t *CONFIG) + `config_set_include_dir()' specifies the include directory, + INCLUDE_DIR, relative to which the files specified in `@include' + directives will be located for the configuration CONFIG. By + default, there is no include directory, and all include files are + expected to be relative to the current working directory. If + INCLUDE_DIR is `NULL', the default behavior is reinstated. + + For example, if the include directory is set to `/usr/local/etc', + the include directive `@include "configs/extra.cfg"' would include + the file `/usr/local/etc/configs/extra.cfg'. + + `config_get_include_dir()' returns the current include directory + for the configuration CONFIG, or `NULL' if none is set. + + + -- Function: void config_set_auto_convert (config_t *CONFIG, int FLAG) + -- Function: int config_get_auto_convert (const config_t *CONFIG) + `config_set_auto_convert()' enables number auto-conversion for the + configuration CONFIG if FLAG is non-zero, and disables it + otherwise. When this feature is enabled, an attempt to retrieve a + floating point setting's value into an integer (or vice versa), or + store an integer to a floating point setting's value (or vice + versa) will cause the library to silently perform the necessary + conversion (possibly leading to loss of data), rather than + reporting failure. By default this feature is disabled. + + `config_get_auto_convert()' returns `CONFIG_TRUE' if number + auto-conversion is currently enabled for CONFIG; otherwise it + returns `CONFIG_FALSE'. + + + -- Function: void config_set_default_format (config_t * CONFIG, + short FORMAT) + -- Function: short config_get_default_format (config_t * CONFIG) + These functions, which are implemented as macros, set and get the + default external format for settings in the configuration CONFIG. + If a non-default format has not been set for a setting with + `config_setting_set_format()', this configuration-wide default + format will be used instead when that setting is written to a file + or stream. + + + -- Function: void config_set_tab_width (config_t * CONFIG, + unsigned short WIDTH) + -- Function: unsigned short config_get_tab_width + (const config_t * CONFIG) + These functions, which are implemented as macros, set and get the + tab width for the configuration CONFIG. The tab width affects the + formatting of the configuration when it is written to a file or + stream: each level of nesting is indented by WIDTH spaces, or by a + single tab character if WIDTH is 0. The tab width has no effect on + parsing. + + Valid tab widths range from 0 to 15. The default tab width is 2. + + + -- Function: int config_lookup_int (const config_t * CONFIG, + const char * PATH, int * VALUE) + -- Function: int config_lookup_int64 (const config_t * CONFIG, + const char * PATH, long long * VALUE) + -- Function: int config_lookup_float (const config_t * CONFIG, + const char * PATH, double * VALUE) + -- Function: int config_lookup_bool (const config_t * CONFIG, + const char * PATH, int * VALUE) + -- Function: int config_lookup_string (const config_t * CONFIG, + const char * PATH, const char ** VALUE) + These functions look up the value of the setting in the + configuration CONFIG specified by the path PATH. They store the + value of the setting at VALUE and return `CONFIG_TRUE' on success. + If the setting was not found or if the type of the value did not + match the type requested, they leave the data pointed to by VALUE + unmodified and return `CONFIG_FALSE'. + + Storage for the string returned by `config_lookup_string()' is + managed by the library and released automatically when the setting + is destroyed or when the setting's value is changed; the string + must not be freed by the caller. + + + -- Function: config_setting_t * config_lookup + (const config_t * CONFIG, const char * PATH) + This function locates the setting in the configuration CONFIG + specified by the path PATH. It returns a pointer to the + `config_setting_t' structure on success, or `NULL' if the setting + was not found. + + + -- Function: int config_setting_get_int + (const config_setting_t * SETTING) + -- Function: long long config_setting_get_int64 + (const config_setting_t * SETTING) + -- Function: double config_setting_get_float + (const config_setting_t * SETTING) + -- Function: int config_setting_get_bool + (const config_setting_t * SETTING) + -- Function: const char * config_setting_get_string + (const config_setting_t * SETTING) + These functions return the value of the given SETTING. If the type + of the setting does not match the type requested, a 0 or `NULL' + value is returned. Storage for the string returned by + `config_setting_get_string()' is managed by the library and + released automatically when the setting is destroyed or when the + setting's value is changed; the string must not be freed by the + caller. + + + -- Function: int config_setting_set_int (config_setting_t * SETTING, + int VALUE) + -- Function: int config_setting_set_int64 (config_setting_t * SETTING, + long long VALUE) + -- Function: int config_setting_set_float (config_setting_t * SETTING, + double VALUE) + -- Function: int config_setting_set_bool (config_setting_t * SETTING, + int VALUE) + -- Function: int config_setting_set_string + (config_setting_t * SETTING, const char * VALUE) + These functions set the value of the given SETTING to VALUE. On + success, they return `CONFIG_TRUE'. If the setting does not match + the type of the value, they return `CONFIG_FALSE'. + `config_setting_set_string()' makes a copy of the passed string + VALUE, so it may be subsequently freed or modified by the caller + without affecting the value of the setting. + + + -- Function: int config_setting_lookup_int + (const config_setting_t * SETTING, const char * NAME, + int * VALUE) + -- Function: int config_setting_lookup_int64 + (const config_setting_t * SETTING, const char * NAME, + long long * VALUE) + -- Function: int config_setting_lookup_float + (const config_setting_t * SETTING, const char * NAME, + double * VALUE) + -- Function: int config_setting_lookup_bool + (const config_setting_t * SETTING, const char * NAME, + int * VALUE) + -- Function: int config_setting_lookup_string + (const config_setting_t * SETTING, const char * NAME, + const char ** VALUE) + These functions look up the value of the child setting named NAME + of the setting SETTING. They store the value at VALUE and return + `CONFIG_TRUE' on success. If the setting was not found or if the + type of the value did not match the type requested, they leave the + data pointed to by VALUE unmodified and return `CONFIG_FALSE'. + + Storage for the string returned by + `config_setting_lookup_string()' is managed by the library and + released automatically when the setting is destroyed or when the + setting's value is changed; the string must not be freed by the + caller. + + + -- Function: short config_setting_get_format + (config_setting_t * SETTING) + -- Function: int config_setting_set_format + (config_setting_t * SETTING, short FORMAT) + These functions get and set the external format for the setting + SETTING. + + The FORMAT must be one of the constants `CONFIG_FORMAT_DEFAULT' or + `CONFIG_FORMAT_HEX'. All settings support the + `CONFIG_FORMAT_DEFAULT' format. The `CONFIG_FORMAT_HEX' format + specifies hexadecimal formatting for integer values, and hence + only applies to settings of type `CONFIG_TYPE_INT' and + `CONFIG_TYPE_INT64'. If FORMAT is invalid for the given setting, + it is ignored. + + If a non-default format has not been set for the setting, + `config_setting_get_format()' returns the default format for the + configuration, as set by `config_set_default_format()'. + + `config_setting_set_format()' returns `CONFIG_TRUE' on success and + `CONFIG_FALSE' on failure. + + + -- Function: config_setting_t * config_setting_get_member + (config_setting_t * SETTING, const char * NAME) + This function fetches the child setting named NAME from the group + SETTING. It returns the requested setting on success, or `NULL' if + the setting was not found or if SETTING is not a group. + + + -- Function: config_setting_t * config_setting_get_elem + (const config_setting_t * SETTING, unsigned int INDEX) + This function fetches the element at the given index INDEX in the + setting SETTING, which must be an array, list, or group. It + returns the requested setting on success, or `NULL' if INDEX is + out of range or if SETTING is not an array, list, or group. + + + -- Function: int config_setting_get_int_elem + (const config_setting_t * SETTING, int INDEX) + -- Function: long long config_setting_get_int64_elem + (const config_setting_t * SETTING, int INDEX) + -- Function: double config_setting_get_float_elem + (const config_setting_t * SETTING, int INDEX) + -- Function: int config_setting_get_bool_elem + (const config_setting_t * SETTING, int INDEX) + -- Function: const char * config_setting_get_string_elem + (const config_setting_t * SETTING, int INDEX) + These functions return the value at the specified index INDEX in + the setting SETTING. If the setting is not an array or list, or if + the type of the element does not match the type requested, or if + INDEX is out of range, they return 0 or `NULL'. Storage for the + string returned by `config_setting_get_string_elem()' is managed + by the library and released automatically when the setting is + destroyed or when its value is changed; the string must not be + freed by the caller. + + -- Function: config_setting_t * config_setting_set_int_elem + (config_setting_t * SETTING, int INDEX, int VALUE) + -- Function: config_setting_t * config_setting_set_int64_elem + (config_setting_t * SETTING, int INDEX, long long VALUE) + -- Function: config_setting_t * config_setting_set_float_elem + (config_setting_t * SETTING, int INDEX, double VALUE) + -- Function: config_setting_t * config_setting_set_bool_elem + (config_setting_t * SETTING, int INDEX, int VALUE) + -- Function: config_setting_t * config_setting_set_string_elem + (config_setting_t * SETTING, int INDEX, const char * VALUE) + These functions set the value at the specified index INDEX in the + setting SETTING to VALUE. If INDEX is negative, a new element is + added to the end of the array or list. On success, these functions + return a pointer to the setting representing the element. If the + setting is not an array or list, or if the setting is an array and + the type of the array does not match the type of the value, or if + INDEX is out of range, they return `NULL'. + `config_setting_set_string_elem()' makes a copy of the passed + string VALUE, so it may be subsequently freed or modified by the + caller without affecting the value of the setting. + + -- Function: config_setting_t * config_setting_add + (config_setting_t * PARENT, const char * NAME, int TYPE) + This function adds a new child setting or element to the setting + PARENT, which must be a group, array, or list. If PARENT is an + array or list, the NAME parameter is ignored and may be `NULL'. + + The function returns the new setting on success, or `NULL' if + PARENT is not a group, array, or list; or if there is already a + child setting of PARENT named NAME; or if TYPE is invalid. If TYPE + is a scalar type, the new setting will have a default value of 0, + 0.0, `false', or `NULL', as appropriate. + + -- Function: int config_setting_remove (config_setting_t * PARENT, + const char * NAME) + This function removes and destroys the setting named NAME from the + parent setting PARENT, which must be a group. Any child settings + of the setting are recursively destroyed as well. + + The function returns `CONFIG_TRUE' on success. If PARENT is not a + group, or if it has no setting with the given name, it returns + `CONFIG_FALSE'. + + + -- Function: int config_setting_remove_elem + (config_setting_t * PARENT, unsigned int INDEX) + This function removes the child setting at the given index INDEX + from the setting PARENT, which must be a group, list, or array. Any + child settings of the removed setting are recursively destroyed as + well. + + The function returns `CONFIG_TRUE' on success. If PARENT is not a + group, list, or array, or if INDEX is out of range, it returns + `CONFIG_FALSE'. + + + -- Function: config_setting_t * config_root_setting + (const config_t * CONFIG) + This function returns the root setting for the configuration + CONFIG. The root setting is a group. + + + -- Function: const char * config_setting_name + (const config_setting_t * SETTING) + This function returns the name of the given SETTING, or `NULL' if + the setting has no name. Storage for the returned string is + managed by the library and released automatically when the setting + is destroyed; the string must not be freed by the caller. + + + -- Function: config_setting_t * config_setting_parent + (const config_setting_t * SETTING) + This function returns the parent setting of the given SETTING, or + `NULL' if SETTING is the root setting. + + + -- Function: int config_setting_is_root + (const config_setting_t * SETTING) + This function returns `CONFIG_TRUE' if the given SETTING is the + root setting, and `CONFIG_FALSE' otherwise. + + + -- Function: int config_setting_index + (const config_setting_t * SETTING) + This function returns the index of the given SETTING within its + parent setting. If SETTING is the root setting, this function + returns -1. + + + -- Function: int config_setting_length + (const config_setting_t * SETTING) + This function returns the number of settings in a group, or the + number of elements in a list or array. For other types of + settings, it returns 0. + + + -- Function: int config_setting_type (const config_setting_t * SETTING) + This function returns the type of the given SETTING. The return + value is one of the constants `CONFIG_TYPE_INT', + `CONFIG_TYPE_INT64', `CONFIG_TYPE_FLOAT', `CONFIG_TYPE_STRING', + `CONFIG_TYPE_BOOL', `CONFIG_TYPE_ARRAY', `CONFIG_TYPE_LIST', or + `CONFIG_TYPE_GROUP'. + + + -- Function: int config_setting_is_group + (const config_setting_t * SETTING) + -- Function: int config_setting_is_array + (const config_setting_t * SETTING) + -- Function: int config_setting_is_list + (const config_setting_t * SETTING) + These convenience functions, which are implemented as macros, test + if the setting SETTING is of a given type. They return + `CONFIG_TRUE' or `CONFIG_FALSE'. + + + -- Function: int config_setting_is_aggregate + (const config_setting_t * SETTING) + -- Function: int config_setting_is_scalar + (const config_setting_t * SETTING) + -- Function: int config_setting_is_number + (const config_setting_t * SETTING) + These convenience functions, which are implemented as macros, test + if the setting SETTING is of an aggregate type (a group, array, or + list), of a scalar type (integer, 64-bit integer, floating point, + boolean, or string), and of a number (integer, 64-bit integer, or + floating point), respectively. They return `CONFIG_TRUE' or + `CONFIG_FALSE'. + + + -- Function: const char * config_setting_source_file + (const config_setting_t * SETTING) + This function returns the name of the file from which the setting + SETTING was read, or NULL if the setting was not read from a file. + This information is useful for reporting application-level errors. + Storage for the returned string is managed by the library and + released automatically when the configuration is destroyed; the + string must not be freed by the caller. + + + -- Function: unsigned int config_setting_source_line + (const config_setting_t * SETTING) + This function returns the line number of the configuration file or + stream at which the setting SETTING was read, or 0 if no line + number is available. This information is useful for reporting + application-level errors. + + + -- Function: void config_setting_set_hook (config_setting_t * SETTING, + void * HOOK) + -- Function: void * config_setting_get_hook + (const config_setting_t * SETTING) + These functions make it possible to attach arbitrary data to each + setting structure, for instance a "wrapper" or "peer" object + written in another programming language. The destructor function, + if one has been supplied via a call to `config_set_destructor()', + will be called by the library to dispose of this data when the + setting itself is destroyed. There is no default destructor. + + + -- Function: void config_set_destructor (config_t * CONFIG, + void (* DESTRUCTOR)(void *)) + This function assigns the destructor function DESTRUCTOR for the + configuration CONFIG. This function accepts a single `void *' + argument and has no return value. See `config_setting_set_hook()' + above for more information. + + + +File: libconfig.info, Node: The C++ API, Next: Example Programs, Prev: The C API, Up: Top + +4 The C++ API +************* + +This chapter describes the C++ library API. The class `Config' +represents a configuration, and the class `Setting' represents a +configuration setting. Note that by design, neither of these classes +provides a public copy constructor or assignment operator. Therefore, +instances of these classes may only be passed between functions via +references or pointers. + + The library defines a group of exceptions, all of which extend the +common base exception `ConfigException'. + + A `SettingTypeException' is thrown when the type of a setting's +value does not match the type requested. + + A `SettingNotFoundException' is thrown when a setting is not found. + + A `SettingNameException' is thrown when an attempt is made to add a +new setting with a non-unique or invalid name. + + A `ParseException' is thrown when a parse error occurs while reading +a configuration from a stream. + + A `FileIOException' is thrown when an I/O error occurs while +reading/writing a configuration from/to a file. + + `SettingTypeException', `SettingNotFoundException', and +`SettingNameException' all extend the common base exception +`SettingException', which provides the following method: + + -- Method on SettingException: const char * getPath () + Returns the path to the setting associated with the exception, or + `NULL' if there is no applicable path. + + + The remainder of this chapter describes the methods for manipulating +configurations and configuration settings. + + -- Method on Config: Config () + -- Method on Config: ~Config () + These methods create and destroy `Config' objects. + + + -- Method on Config: void read (FILE * STREAM) + -- Method on Config: void write (FILE * STREAM) + The `read()' method reads and parses a configuration from the given + STREAM. A `ParseException' is thrown if a parse error occurs. + + The `write()' method writes the configuration to the given STREAM. + + + -- Method on Config: void readFile (const char * FILENAME) + -- Method on Config: void writeFile (const char * FILENAME) + The `readFile()' method reads and parses a configuration from the + file named FILENAME. A `ParseException' is thrown if a parse error + occurs. A `FileIOException' is thrown if the file cannot be read. + + The `writeFile()' method writes the configuration to the file + named FILENAME. A `FileIOException' is thrown if the file cannot + be written. + + + -- Method on Config: void readString (const char * STR) + -- Method on Config: void readString (const std::string &STR) + These methods read and parse a configuration from the string STR. + A `ParseException' is thrown if a parse error occurs. + + + -- Method on ParseException: const char * getError () + -- Method on ParseException: const char * getFile () + -- Method on ParseException: int getLine () + If a call to `readFile()', `readString()', or `read()' resulted in + a `ParseException', these methods can be called on the exception + object to obtain the text, filename, and line number of the parse + error. Storage for the strings returned by `getError()' and + `getFile()' are managed by the library; the strings must not be + freed by the caller. + + + -- Method on Config: void setIncludeDir (const char *INCLUDEDIR) + -- Method on Config: const char * getIncludeDir () + `setIncludeDir()' specifies the include directory, INCLUDEDIR, + relative to which the files specified in `@include' directives + will be located for the configuration. By default, there is no + include directory, and all include files are expected to be + relative to the current working directory. If INCLUDEDIR is + `NULL', the default behavior is reinstated. + + For example, if the include directory is set to `/usr/local/etc', + the include directive `@include "configs/extra.cfg"' would include + the file `/usr/local/etc/configs/extra.cfg'. + + `getIncludeDir()' returns the current include directory for the + configuration, or `NULL' if none is set. + + + -- Method on Config: void setAutoConvert (bool FLAG) + -- Method on Config: bool getAutoConvert () + `setAutoConvert()' enables number auto-conversion for the + configuration if FLAG is `true', and disables it otherwise. When + this feature is enabled, an attempt to assign a floating point + setting to an integer (or vice versa), or assign an integer to a + floating point setting (or vice versa) will cause the library to + silently perform the necessary conversion (possibly leading to + loss of data), rather than throwing a `SettingTypeException'. By + default this feature is disabled. + + `getAutoConvert()' returns `true' if number auto-conversion is + currently enabled for the configuration; otherwise it returns + `false'. + + + -- Method on Config: void setDefaultFormat (Setting::Format FORMAT) + -- Method on Config: Setting::Format getDefaultFormat () + These methods set and get the default external format for settings + in the configuration. If a non-default format has not been set for + a setting with `Setting::setFormat()', this configuration-wide + default format will be used instead when that setting is written + to a file or stream. + + + -- Method on Config: void setTabWidth (unsigned short WIDTH) + -- Method on Config: unsigned short getTabWidth () + These methods set and get the tab width for the configuration. The + tab width affects the formatting of the configuration when it is + written to a file or stream: each level of nesting is indented by + WIDTH spaces, or by a single tab character if WIDTH is 0. The tab + width has no effect on parsing. + + Valid tab widths range from 0 to 15. The default tab width is 2. + + + -- Method on Config: Setting & getRoot () + This method returns the root setting for the configuration, which + is a group. + + + -- Method on Config: Setting & lookup (const std::string &PATH) + -- Method on Config: Setting & lookup (const char * PATH) + These methods locate the setting specified by the path PATH. If + the requested setting is not found, a `SettingNotFoundException' is + thrown. + + + -- Method on Config: bool exists (const std::string &PATH) + -- Method on Config: bool exists (const char *PATH) + These methods test if a setting with the given PATH exists in the + configuration. They return `true' if the setting exists, and + `false' otherwise. These methods do not throw exceptions. + + + -- Method on Config: bool lookupValue (const char *PATH, bool &VALUE) + -- Method on Config: bool lookupValue (const std::string &PATH, + bool &VALUE) + -- Method on Config: bool lookupValue (const char *PATH, int &VALUE) + -- Method on Config: bool lookupValue (const std::string &PATH, + int &VALUE) + -- Method on Config: bool lookupValue (const char *PATH, + unsigned int &VALUE) + -- Method on Config: bool lookupValue (const std::string &PATH, + unsigned int &VALUE) + -- Method on Config: bool lookupValue (const char *PATH, + long long &VALUE) + -- Method on Config: bool lookupValue (const std::string &PATH, + long long &VALUE) + -- Method on Config: bool lookupValue (const char *PATH, float &VALUE) + -- Method on Config: bool lookupValue (const std::string &PATH, + float &VALUE) + -- Method on Config: bool lookupValue (const char *PATH, double &VALUE) + -- Method on Config: bool lookupValue (const std::string &PATH, + double &VALUE) + -- Method on Config: bool lookupValue (const char *PATH, + const char *&VALUE) + -- Method on Config: bool lookupValue (const std::string &PATH, + const char *&VALUE) + -- Method on Config: bool lookupValue (const char *PATH, + std::string &VALUE) + -- Method on Config: bool lookupValue (const std::string &PATH, + std::string &VALUE) + These are convenience methods for looking up the value of a setting + with the given PATH. If the setting is found and is of an + appropriate type, the value is stored in VALUE and the method + returns `true'. Otherwise, VALUE is left unmodified and the method + returns `false'. These methods do not throw exceptions. + + Storage for const char * values is managed by the library and + released automatically when the setting is destroyed or when its + value is changed; the string must not be freed by the caller. For + safety and convenience, always assigning string values to a + `std::string' is suggested. + + Since these methods have boolean return values and do not throw + exceptions, they can be used within boolean logic expressions. The + following example presents a concise way to look up three values + at once and perform error handling if any of them are not found or + are of the wrong type: + + + int var1; + double var2; + const char *var3; + + if(config.lookupValue("values.var1", var1) + && config.lookupValue("values.var2", var2) + && config.lookupValue("values.var3", var3)) + { + // use var1, var2, var3 + } + else + { + // error handling here + } + + This approach also takes advantage of the short-circuit evaluation + rules of C++, e.g., if the first lookup fails (returning `false'), + the remaining lookups are skipped entirely. + + + -- Method on Setting: operator bool () + -- Method on Setting: operator int () + -- Method on Setting: operator unsigned int () + -- Method on Setting: operator long () + -- Method on Setting: operator unsigned long () + -- Method on Setting: operator long long () + -- Method on Setting: operator unsigned long long () + -- Method on Setting: operator float () + -- Method on Setting: operator double () + -- Method on Setting: operator const char * () + -- Method on Setting: operator std::string () + -- Method on Setting: const char * c_str () + These cast operators allow a `Setting' object to be assigned to a + variable of type bool if it is of type `TypeBoolean'; int, + unsigned int; `long long' or `unsigned long long' if it is of type + `TypeInt64', float or double if it is of type `TypeFloat'; or + const char * or std::string if it is of type `TypeString'. + + Values of type `TypeInt' or `TypeInt64' may be assigned to + variables of type long, or unsigned long, depending on the sizes + of those types on the host system. + + Storage for const char * return values is managed by the library + and released automatically when the setting is destroyed or when + its value is changed; the string must not be freed by the caller. + For safety and convenience, always assigning string return values + to a `std::string' is suggested. + + The following examples demonstrate this usage: + + long width = config.lookup("application.window.size.w"); + + bool splashScreen = config.lookup("application.splash_screen"); + + std::string title = config.lookup("application.window.title"); + + Note that certain conversions can lead to loss of precision or + clipping of values, e.g., assigning a negative value to an unsigned + int (in which case the value will be treated as 0), or a + double-precision value to a float. The library does not treat + these lossy conversions as errors. + + Perhaps surprisingly, the following code in particular will cause a + compiler error: + + std::string title; + . + . + . + title = config.lookup("application.window.title"); + + This is because the assignment operator of `std::string' is being + invoked with a `Setting &' as an argument. The compiler is unable + to make an implicit conversion because both the `const char *' and + the `std::string' cast operators of `Setting' are equally + appropriate. This is not a bug in libconfig; providing only the + `const char *' cast operator would resolve this particular + ambiguity, but would cause assignments to `std::string' like the + one in the previous example to produce a compiler error. (To + understand why, see section 11.4.1 of The C++ Programming + Language.) + + The solution to this problem is to use an explicit conversion that + avoids the construction of an intermediate `std::string' object, + as follows: + + std::string title; + . + . + . + title = (const char *)config.lookup("application.window.title"); + + Or, alternatively, use the `c_str()' method, which has the same + effect: + + std::string title; + . + . + . + title = config.lookup("application.window.title").c_str(); + + If the assignment is invalid due to a type mismatch, a + `SettingTypeException' is thrown. + + + -- Method on Setting: Setting & operator= (bool VALUE) + -- Method on Setting: Setting & operator= (int VALUE) + -- Method on Setting: Setting & operator= (long VALUE) + -- Method on Setting: Setting & operator= (const long long &VALUE) + -- Method on Setting: Setting & operator= (float VALUE) + -- Method on Setting: Setting & operator= (const double &VALUE) + -- Method on Setting: Setting & operator= (const char *VALUE) + -- Method on Setting: Setting & operator= (const std::string &VALUE) + These assignment operators allow values of type bool, int, long, + long long, float, double, const char *, and std::string to be + assigned to a setting. In the case of strings, the library makes a + copy of the passed string VALUE, so it may be subsequently freed + or modified by the caller without affecting the value of the + setting. + + The following example code looks up a (presumably) integer setting + and changes its value: + + Setting &setting = config.lookup("application.window.size.w"); + setting = 1024; + + If the assignment is invalid due to a type mismatch, a + `SettingTypeException' is thrown. + + + -- Method on Setting: Setting & operator[] (int INDEX) + -- Method on Setting: Setting & operator[] (const std::string &NAME) + -- Method on Setting: Setting & operator[] (const char *NAME) + A `Setting' object may be subscripted with an integer index INDEX + if it is an array or list, or with either a string NAME or an + integer index INDEX if it is a group. For example, the following + code would produce the string `Last Name' when applied to the + example configuration in *note Configuration Files::. + + Setting& setting = config.lookup("application.misc"); + const char *s = setting["columns"][0]; + + If the setting is not an array, list, or group, a + `SettingTypeException' is thrown. If the subscript (INDEX or NAME) + does not refer to a valid element, a `SettingNotFoundException' is + thrown. + + Iterating over a group's child settings with an integer index will + return the settings in the same order that they appear in the + configuration. + + + -- Method on Setting: bool lookupValue (const char *NAME, bool &VALUE) + -- Method on Setting: bool lookupValue (const std::string &NAME, + bool &VALUE) + -- Method on Setting: bool lookupValue (const char *NAME, int &VALUE) + -- Method on Setting: bool lookupValue (const std::string &NAME, + int &VALUE) + -- Method on Setting: bool lookupValue (const char *NAME, + unsigned int &VALUE) + -- Method on Setting: bool lookupValue (const std::string &NAME, + unsigned int &VALUE) + -- Method on Setting: bool lookupValue (const char *NAME, + long long &VALUE) + -- Method on Setting: bool lookupValue (const std::string &NAME, + long long &VALUE) + -- Method on Setting: bool lookupValue (const char *NAME, + unsigned long long &VALUE) + -- Method on Setting: bool lookupValue (const std::string &NAME, + unsigned long long &VALUE) + -- Method on Setting: bool lookupValue (const char *NAME, float &VALUE) + -- Method on Setting: bool lookupValue (const std::string &NAME, + float &VALUE) + -- Method on Setting: bool lookupValue (const char *NAME, + double &VALUE) + -- Method on Setting: bool lookupValue (const std::string &NAME, + double &VALUE) + -- Method on Setting: bool lookupValue (const char *NAME, + const char *&VALUE) + -- Method on Setting: bool lookupValue (const std::string &NAME, + const char *&VALUE) + -- Method on Setting: bool lookupValue (const char *NAME, + std::string &VALUE) + -- Method on Setting: bool lookupValue (const std::string &NAME, + std::string &VALUE) + These are convenience methods for looking up the value of a child + setting with the given NAME. If the setting is found and is of an + appropriate type, the value is stored in VALUE and the method + returns `true'. Otherwise, VALUE is left unmodified and the method + returns `false'. These methods do not throw exceptions. + + Storage for const char * values is managed by the library and + released automatically when the setting is destroyed or when its + value is changed; the string must not be freed by the caller. For + safety and convenience, always assigning string values to a + `std::string' is suggested. + + Since these methods have boolean return values and do not throw + exceptions, they can be used within boolean logic expressions. The + following example presents a concise way to look up three values + at once and perform error handling if any of them are not found or + are of the wrong type: + + + int var1; + double var2; + const char *var3; + + if(setting.lookupValue("var1", var1) + && setting.lookupValue("var2", var2) + && setting.lookupValue("var3", var3)) + { + // use var1, var2, var3 + } + else + { + // error handling here + } + + This approach also takes advantage of the short-circuit evaluation + rules of C++, e.g., if the first lookup fails (returning `false'), + the remaining lookups are skipped entirely. + + + -- Method on Setting: Setting & add (const std::string &NAME, + Setting::Type TYPE) + -- Method on Setting: Setting & add (const char *NAME, + Setting::Type TYPE) + These methods add a new child setting with the given NAME and TYPE + to the setting, which must be a group. They return a reference to + the new setting. If the setting already has a child setting with + the given name, or if the name is invalid, a + `SettingNameException' is thrown. If the setting is not a group, a + `SettingTypeException' is thrown. + + Once a setting has been created, neither its name nor type can be + changed. + + + -- Method on Setting: Setting & add (Setting::Type TYPE) + This method adds a new element to the setting, which must be of + type `TypeArray' or `TypeList'. If the setting is an array which + currently has zero elements, the TYPE parameter (which must be + `TypeInt', `TypeInt64', `TypeFloat', `TypeBool', or `TypeString') + determines the type for the array; otherwise it must match the + type of the existing elements in the array. + + The method returns the new setting on success. If TYPE is a scalar + type, the new setting will have a default value of 0, 0.0, + `false', or `NULL', as appropriate. + + The method throws a `SettingTypeException' if the setting is not + an array or list, or if TYPE is invalid. + + + -- Method on Setting: void remove (const std::string &NAME) + -- Method on Setting: void remove (const char *NAME) + These methods remove the child setting with the given NAME from + the setting, which must be a group. Any child settings of the + removed setting are recursively destroyed as well. + + If the setting is not a group, a `SettingTypeException' is thrown. + If the setting does not have a child setting with the given name, + a `SettingNotFoundException' is thrown. + + + -- Method on Setting: void remove (unsigned int INDEX) + This method removes the child setting at the given index INDEX from + the setting, which must be a group, list, or array. Any child + settings of the removed setting are recursively destroyed as well. + + If the setting is not a group, list, or array, a + `SettingTypeException' is thrown. If INDEX is out of range, a + `SettingNotFoundException' is thrown. + + + -- Method on Setting: const char * getName () + This method returns the name of the setting, or `NULL' if the + setting has no name. Storage for the returned string is managed by + the library and released automatically when the setting is + destroyed; the string must not be freed by the caller. For safety + and convenience, consider assigning the return value to a + `std::string'. + + + -- Method on Setting: std::string getPath () + This method returns the complete dot-separated path to the + setting. Settings which do not have a name (list and array + elements) are represented by their index in square brackets. + + + -- Method on Setting: Setting & getParent () + This method returns the parent setting of the setting. If the + setting is the root setting, a `SettingNotFoundException' is + thrown. + + + -- Method on Setting: bool isRoot () + This method returns `true' if the setting is the root setting, and + `false' otherwise. + + + -- Method on Setting: int getIndex () + This method returns the index of the setting within its parent + setting. When applied to the root setting, this method returns -1. + + + -- Method on Setting: Setting::Type getType () + This method returns the type of the setting. The `Setting::Type' + enumeration consists of the following constants: `TypeInt', + `TypeInt64', `TypeFloat', `TypeString', `TypeBoolean', + `TypeArray', `TypeList', and `TypeGroup'. + + + -- Method on Setting: Setting::Format getFormat () + -- Method on Setting: void setFormat (Setting::Format FORMAT) + These methods get and set the external format for the setting. + + The SETTING::FORMAT enumeration consists of the following + constants: `FormatDefault' and `FormatHex'. All settings support + the `FormatDefault' format. The `FormatHex' format specifies + hexadecimal formatting for integer values, and hence only applies + to settings of type `TypeInt' and `TypeInt64'. If FORMAT is + invalid for the given setting, it is ignored. + + + -- Method on Setting: bool exists (const std::string &NAME) + -- Method on Setting: bool exists (const char *NAME) + These methods test if the setting has a child setting with the + given NAME. They return `true' if the setting exists, and `false' + otherwise. These methods do not throw exceptions. + + + -- Method on Setting: int getLength () + This method returns the number of settings in a group, or the + number of elements in a list or array. For other types of + settings, it returns 0. + + + -- Method on Setting: bool isGroup () + -- Method on Setting: bool isArray () + -- Method on Setting: bool isList () + These convenience methods test if a setting is of a given type. + + + -- Method on Setting: bool isAggregate () + -- Method on Setting: bool isScalar () + -- Method on Setting: bool isNumber () + These convenience methods test if a setting is of an aggregate + type (a group, array, or list), of a scalar type (integer, 64-bit + integer, floating point, boolean, or string), and of a number + (integer, 64-bit integer, or floating point), respectively. + + + -- Method on Setting: const char * getSourceFile () + This function returns the name of the file from which the setting + was read, or NULL if the setting was not read from a file. This + information is useful for reporting application-level errors. + Storage for the returned string is managed by the library and + released automatically when the configuration is destroyed; the + string must not be freed by the caller. + + + -- Method on Setting: unsigned int getSourceLine () + This function returns the line number of the configuration file or + stream at which the setting SETTING was read, or 0 if no line + number is available. This information is useful for reporting + application-level errors. + + + +File: libconfig.info, Node: Example Programs, Next: Configuration File Grammar, Prev: The C++ API, Up: Top + +5 Example Programs +****************** + +Practical example programs that illustrate how to use libconfig from +both C and C++ are included in the `examples' subdirectory of the +distribution. These examples include: + +`examples/c/example1.c' + An example C program that reads a configuration from an existing + file `example.cfg' (also located in `examples/c') and displays + some of its contents. + +`examples/c++/example1.cpp' + The C++ equivalent of `example1.c'. + +`examples/c/example2.c' + An example C program that reads a configuration from an existing + file `example.cfg' (also located in `examples/c'), adds new + settings to the configuration, and writes the updated + configuration to another file. + +`examples/c++/example2.cpp' + The C++ equivalent of `example2.c' + +`examples/c/example3.c' + An example C program that constructs a new configuration in memory + and writes it to a file. + +`examples/c++/example3.cpp' + The C++ equivalent of `example3.c' + + + +File: libconfig.info, Node: Configuration File Grammar, Next: License, Prev: Example Programs, Up: Top + +6 Configuration File Grammar +**************************** + +Below is the BNF grammar for configuration files. Comments and include +directives are not part of the grammar, so they are not included here. + + + configuration = setting-list | empty + + setting-list = setting | setting-list setting + + setting = name (":" | "=") value (";" | "," | empty) + + value = scalar-value | array | list | group + + value-list = value | value-list "," value + + scalar-value = boolean | integer | integer64 | hex | hex64 | float + | string + + scalar-value-list = scalar-value | scalar-value-list "," scalar-value + + array = "[" (scalar-value-list | empty) "]" + + list = "(" (value-list | empty) ")" + + group = "{" (setting-list | empty) "}" + + empty = + + + + Terminals are defined below as regular expressions: + +`boolean' `([Tt][Rr][Uu][Ee])|([Ff][Aa][Ll][Ss][Ee])' +`string' `\"([^\"\\]|\\.)*\"' +`name' `[A-Za-z\*][-A-Za-z0-9_\*]*' +`integer' `[-+]?[0-9]+' +`integer64' `[-+]?[0-9]+L(L)?' +`hex' `0[Xx][0-9A-Fa-f]+' +`hex64' `0[Xx][0-9A-Fa-f]+L(L)?' +`float' `([-+]?([0-9]*)?\.[0-9]*([eE][-+]?[0-9]+)?)|([-+]([0-9]+)(\.[0-9]*)?[eE][-+]?[0-9]+)' + + +File: libconfig.info, Node: License, Next: Function Index, Prev: Configuration File Grammar, Up: Top + +Appendix A License +****************** + + GNU LESSER GENERAL PUBLIC LICENSE + Version 2.1, February 1999 + + + Copyright (C) 1991, 1999 Free Software Foundation, Inc., 59 Temple +Place, Suite 330, Boston, MA 02111-1307 USA + + Everyone is permitted to copy and distribute verbatim copies of this +license document, but changing it is not allowed. + + [This is the first released version of the Lesser GPL. It also +counts as the successor of the GNU Library Public License, version 2, +hence the version number 2.1.] + + + Preamble + + The licenses for most software are designed to take away your +freedom to share and change it. By contrast, the GNU General Public +Licenses are intended to guarantee your freedom to share and change +free software-to make sure the software is free for all its users. + + This license, the Lesser General Public License, applies to some +specially designated software packages-typically libraries-of the Free +Software Foundation and other authors who decide to use it. You can use +it too, but we suggest you first think carefully about whether this +license or the ordinary General Public License is the better strategy to +use in any particular case, based on the explanations below. + + When we speak of free software, we are referring to freedom of use, +not price. Our General Public Licenses are designed to make sure that +you have the freedom to distribute copies of free software (and charge +for this service if you wish); that you receive source code or can get +it if you want it; that you can change the software and use pieces of +it in new free programs; and that you are informed that you can do these +things. + + To protect your rights, we need to make restrictions that forbid +distributors to deny you these rights or to ask you to surrender these +rights. These restrictions translate to certain responsibilities for +you if you distribute copies of the library or if you modify it. + + For example, if you distribute copies of the library, whether gratis +or for a fee, you must give the recipients all the rights that we gave +you. You must make sure that they, too, receive or can get the source +code. If you link other code with the library, you must provide +complete object files to the recipients, so that they can relink them +with the library after making changes to the library and recompiling +it. And you must show them these terms so they know their rights. + + We protect your rights with a two-step method: (1) we copyright the +library, and (2) we offer you this license, which gives you legal +permission to copy, distribute and/or modify the library. + + To protect each distributor, we want to make it very clear that +there is no warranty for the free library. Also, if the library is +modified by someone else and passed on, the recipients should know that +what they have is not the original version, so that the original +author's reputation will not be affected by problems that might be +introduced by others. + + Finally, software patents pose a constant threat to the existence of +any free program. We wish to make sure that a company cannot +effectively restrict the users of a free program by obtaining a +restrictive license from a patent holder. Therefore, we insist that +any patent license obtained for a version of the library must be +consistent with the full freedom of use specified in this license. + + Most GNU software, including some libraries, is covered by the +ordinary GNU General Public License. This license, the GNU Lesser +General Public License, applies to certain designated libraries, and is +quite different from the ordinary General Public License. We use this +license for certain libraries in order to permit linking those +libraries into non-free programs. + + When a program is linked with a library, whether statically or using +a shared library, the combination of the two is legally speaking a +combined work, a derivative of the original library. The ordinary +General Public License therefore permits such linking only if the entire +combination fits its criteria of freedom. The Lesser General Public +License permits more lax criteria for linking other code with the +library. + + We call this license the "Lesser" General Public License because it +does Less to protect the user's freedom than the ordinary General Public +License. It also provides other free software developers Less of an +advantage over competing non-free programs. These disadvantages are the +reason we use the ordinary General Public License for many libraries. +However, the Lesser license provides advantages in certain special +circumstances. + + For example, on rare occasions, there may be a special need to +encourage the widest possible use of a certain library, so that it +becomes a de-facto standard. To achieve this, non-free programs must +be allowed to use the library. A more frequent case is that a free +library does the same job as widely used non-free libraries. In this +case, there is little to gain by limiting the free library to free +software only, so we use the Lesser General Public License. + + In other cases, permission to use a particular library in non-free +programs enables a greater number of people to use a large body of free +software. For example, permission to use the GNU C Library in non-free +programs enables many more people to use the whole GNU operating system, +as well as its variant, the GNU/Linux operating system. + + Although the Lesser General Public License is Less protective of the +users' freedom, it does ensure that the user of a program that is linked +with the Library has the freedom and the wherewithal to run that program +using a modified version of the Library. + + The precise terms and conditions for copying, distribution and +modification follow. Pay close attention to the difference between a +"work based on the library" and a "work that uses the library". The +former contains code derived from the library, whereas the latter must +be combined with the library in order to run. + + GNU LESSER GENERAL PUBLIC LICENSE + TERMS AND CONDITIONS FOR COPYING, DISTRIBUTION AND MODIFICATION + + + 0. This License Agreement applies to any software library or other + program which contains a notice placed by the copyright holder or + other authorized party saying it may be distributed under the + terms of this Lesser General Public License (also called "this + License"). Each licensee is addressed as "you". + + A "library" means a collection of software functions and/or data + prepared so as to be conveniently linked with application programs + (which use some of those functions and data) to form executables. + + The "Library", below, refers to any such software library or work + which has been distributed under these terms. A "work based on + the Library" means either the Library or any derivative work under + copyright law: that is to say, a work containing the Library or a + portion of it, either verbatim or with modifications and/or + translated straightforwardly into another language. (Hereinafter, + translation is included without limitation in the term + "modification".) + + "Source code" for a work means the preferred form of the work for + making modifications to it. For a library, complete source code + means all the source code for all modules it contains, plus any + associated interface definition files, plus the scripts used to + control compilation and installation of the library. + + Activities other than copying, distribution and modification are + not covered by this License; they are outside its scope. The act + of running a program using the Library is not restricted, and + output from such a program is covered only if its contents + constitute a work based on the Library (independent of the use of + the Library in a tool for writing it). Whether that is true + depends on what the Library does and what the program that uses + the Library does. + + + 1. You may copy and distribute verbatim copies of the Library's + complete source code as you receive it, in any medium, provided + that you conspicuously and appropriately publish on each copy an + appropriate copyright notice and disclaimer of warranty; keep + intact all the notices that refer to this License and to the + absence of any warranty; and distribute a copy of this License + along with the Library. + + You may charge a fee for the physical act of transferring a copy, + and you may at your option offer warranty protection in exchange + for a fee. + + + 2. You may modify your copy or copies of the Library or any portion + of it, thus forming a work based on the Library, and copy and + distribute such modifications or work under the terms of Section 1 + above, provided that you also meet all of these conditions: + + a. The modified work must itself be a software library. + + + b. You must cause the files modified to carry prominent notices + stating that you changed the files and the date of any change. + + + c. You must cause the whole of the work to be licensed at no + charge to all third parties under the terms of this License. + + + d. If a facility in the modified Library refers to a function or + a table of data to be supplied by an application program that + uses the facility, other than as an argument passed when the + facility is invoked, then you must make a good faith effort + to ensure that, in the event an application does not supply + such function or table, the facility still operates, and + performs whatever part of its purpose remains meaningful. + + (For example, a function in a library to compute square roots + has a purpose that is entirely well-defined independent of + the application. Therefore, Subsection 2d requires that any + application-supplied function or table used by this function + must be optional: if the application does not supply it, the + square root function must still compute square roots.) + + + These requirements apply to the modified work as a whole. If + identifiable sections of that work are not derived from the + Library, and can be reasonably considered independent and separate + works in themselves, then this License, and its terms, do not + apply to those sections when you distribute them as separate + works. But when you distribute the same sections as part of a + whole which is a work based on the Library, the distribution of + the whole must be on the terms of this License, whose permissions + for other licensees extend to the entire whole, and thus to each + and every part regardless of who wrote it. + + Thus, it is not the intent of this section to claim rights or + contest your rights to work written entirely by you; rather, the + intent is to exercise the right to control the distribution of + derivative or collective works based on the Library. + + In addition, mere aggregation of another work not based on the + Library with the Library (or with a work based on the Library) on + a volume of a storage or distribution medium does not bring the + other work under the scope of this License. + + + 3. You may opt to apply the terms of the ordinary GNU General Public + License instead of this License to a given copy of the Library. + To do this, you must alter all the notices that refer to this + License, so that they refer to the ordinary GNU General Public + License, version 2, instead of to this License. (If a newer + version than version 2 of the ordinary GNU General Public License + has appeared, then you can specify that version instead if you + wish.) Do not make any other change in these notices. + + Once this change is made in a given copy, it is irreversible for + that copy, so the ordinary GNU General Public License applies to + all subsequent copies and derivative works made from that copy. + + This option is useful when you wish to copy part of the code of the + Library into a program that is not a library. + + + 4. You may copy and distribute the Library (or a portion or + derivative of it, under Section 2) in object code or executable + form under the terms of Sections 1 and 2 above provided that you + accompany it with the complete corresponding machine-readable + source code, which must be distributed under the terms of Sections + 1 and 2 above on a medium customarily used for software + interchange. + + If distribution of object code is made by offering access to copy + from a designated place, then offering equivalent access to copy + the source code from the same place satisfies the requirement to + distribute the source code, even though third parties are not + compelled to copy the source along with the object code. + + + 5. A program that contains no derivative of any portion of the + Library, but is designed to work with the Library by being + compiled or linked with it, is called a "work that uses the + Library". Such a work, in isolation, is not a derivative work of + the Library, and therefore falls outside the scope of this License. + + However, linking a "work that uses the Library" with the Library + creates an executable that is a derivative of the Library (because + it contains portions of the Library), rather than a "work that + uses the library". The executable is therefore covered by this + License. Section 6 states terms for distribution of such + executables. + + When a "work that uses the Library" uses material from a header + file that is part of the Library, the object code for the work may + be a derivative work of the Library even though the source code is + not. Whether this is true is especially significant if the work + can be linked without the Library, or if the work is itself a + library. The threshold for this to be true is not precisely + defined by law. + + If such an object file uses only numerical parameters, data + structure layouts and accessors, and small macros and small inline + functions (ten lines or less in length), then the use of the + object file is unrestricted, regardless of whether it is legally a + derivative work. (Executables containing this object code plus + portions of the Library will still fall under Section 6.) + + Otherwise, if the work is a derivative of the Library, you may + distribute the object code for the work under the terms of Section + 6. Any executables containing that work also fall under Section + 6, whether or not they are linked directly with the Library itself. + + + 6. As an exception to the Sections above, you may also combine or + link a "work that uses the Library" with the Library to produce a + work containing portions of the Library, and distribute that work + under terms of your choice, provided that the terms permit + modification of the work for the customer's own use and reverse + engineering for debugging such modifications. + + You must give prominent notice with each copy of the work that the + Library is used in it and that the Library and its use are covered + by this License. You must supply a copy of this License. If the + work during execution displays copyright notices, you must include + the copyright notice for the Library among them, as well as a + reference directing the user to the copy of this License. Also, + you must do one of these things: + + + a. Accompany the work with the complete corresponding + machine-readable source code for the Library including + whatever changes were used in the work (which must be + distributed under Sections 1 and 2 above); and, if the work + is an executable linked with the Library, with the complete + machine-readable "work that uses the Library", as object code + and/or source code, so that the user can modify the Library + and then relink to produce a modified executable containing + the modified Library. (It is understood that the user who + changes the contents of definitions files in the Library will + not necessarily be able to recompile the application to use + the modified definitions.) + + + b. Use a suitable shared library mechanism for linking with the + Library. A suitable mechanism is one that (1) uses at run + time a copy of the library already present on the user's + computer system, rather than copying library functions into + the executable, and (2) will operate properly with a modified + version of the library, if the user installs one, as long as + the modified version is interface-compatible with the version + that the work was made with. + + + c. Accompany the work with a written offer, valid for at least + three years, to give the same user the materials specified in + Subsection 6a, above, for a charge no more than the cost of + performing this distribution. + + + d. If distribution of the work is made by offering access to + copy from a designated place, offer equivalent access to copy + the above specified materials from the same place. + + + e. Verify that the user has already received a copy of these + materials or that you have already sent this user a copy. + + + For an executable, the required form of the "work that uses the + Library" must include any data and utility programs needed for + reproducing the executable from it. However, as a special + exception, the materials to be distributed need not include + anything that is normally distributed (in either source or binary + form) with the major components (compiler, kernel, and so on) of + the operating system on which the executable runs, unless that + component itself accompanies the executable. + + It may happen that this requirement contradicts the license + restrictions of other proprietary libraries that do not normally + accompany the operating system. Such a contradiction means you + cannot use both them and the Library together in an executable + that you distribute. + + + 7. You may place library facilities that are a work based on the + Library side-by-side in a single library together with other + library facilities not covered by this License, and distribute + such a combined library, provided that the separate distribution + of the work based on the Library and of the other library + facilities is otherwise permitted, and provided that you do these + two things: + + + a. Accompany the combined library with a copy of the same work + based on the Library, uncombined with any other library + facilities. This must be distributed under the terms of the + Sections above. + + + b. Give prominent notice with the combined library of the fact + that part of it is a work based on the Library, and + explaining where to find the accompanying uncombined form of + the same work. + + + + 8. You may not copy, modify, sublicense, link with, or distribute the + Library except as expressly provided under this License. Any + attempt otherwise to copy, modify, sublicense, link with, or + distribute the Library is void, and will automatically terminate + your rights under this License. However, parties who have + received copies, or rights, from you under this License will not + have their licenses terminated so long as such parties remain in + full compliance. + + + 9. You are not required to accept this License, since you have not + signed it. However, nothing else grants you permission to modify + or distribute the Library or its derivative works. These actions + are prohibited by law if you do not accept this License. + Therefore, by modifying or distributing the Library (or any work + based on the Library), you indicate your acceptance of this + License to do so, and all its terms and conditions for copying, + distributing or modifying the Library or works based on it. + + + 10. Each time you redistribute the Library (or any work based on the + Library), the recipient automatically receives a license from the + original licensor to copy, distribute, link with or modify the + Library subject to these terms and conditions. You may not impose + any further restrictions on the recipients' exercise of the rights + granted herein. You are not responsible for enforcing compliance + by third parties with this License. + + + 11. If, as a consequence of a court judgment or allegation of patent + infringement or for any other reason (not limited to patent + issues), conditions are imposed on you (whether by court order, + agreement or otherwise) that contradict the conditions of this + License, they do not excuse you from the conditions of this + License. If you cannot distribute so as to satisfy simultaneously + your obligations under this License and any other pertinent + obligations, then as a consequence you may not distribute the + Library at all. For example, if a patent license would not permit + royalty-free redistribution of the Library by all those who + receive copies directly or indirectly through you, then the only + way you could satisfy both it and this License would be to refrain + entirely from distribution of the Library. + + If any portion of this section is held invalid or unenforceable + under any particular circumstance, the balance of the section is + intended to apply, and the section as a whole is intended to apply + in other circumstances. + + It is not the purpose of this section to induce you to infringe any + patents or other property right claims or to contest validity of + any such claims; this section has the sole purpose of protecting + the integrity of the free software distribution system which is + implemented by public license practices. Many people have made + generous contributions to the wide range of software distributed + through that system in reliance on consistent application of that + system; it is up to the author/donor to decide if he or she is + willing to distribute software through any other system and a + licensee cannot impose that choice. + + This section is intended to make thoroughly clear what is believed + to be a consequence of the rest of this License. + + + 12. If the distribution and/or use of the Library is restricted in + certain countries either by patents or by copyrighted interfaces, + the original copyright holder who places the Library under this + License may add an explicit geographical distribution limitation + excluding those countries, so that distribution is permitted only + in or among countries not thus excluded. In such case, this + License incorporates the limitation as if written in the body of + this License. + + + 13. The Free Software Foundation may publish revised and/or new + versions of the Lesser General Public License from time to time. + Such new versions will be similar in spirit to the present + version, but may differ in detail to address new problems or + concerns. + + Each version is given a distinguishing version number. If the + Library specifies a version number of this License which applies + to it and "any later version", you have the option of following + the terms and conditions either of that version or of any later + version published by the Free Software Foundation. If the Library + does not specify a license version number, you may choose any + version ever published by the Free Software Foundation. + + + 14. If you wish to incorporate parts of the Library into other free + programs whose distribution conditions are incompatible with + these, write to the author to ask for permission. For software + which is copyrighted by the Free Software Foundation, write to the + Free Software Foundation; we sometimes make exceptions for this. + Our decision will be guided by the two goals of preserving the + free status of all derivatives of our free software and of + promoting the sharing and reuse of software generally. + + + NO WARRANTY + + 15. BECAUSE THE LIBRARY IS LICENSED FREE OF CHARGE, THERE IS NO + WARRANTY FOR THE LIBRARY, TO THE EXTENT PERMITTED BY APPLICABLE + LAW. EXCEPT WHEN OTHERWISE STATED IN WRITING THE COPYRIGHT + HOLDERS AND/OR OTHER PARTIES PROVIDE THE LIBRARY "AS IS" WITHOUT + WARRANTY OF ANY KIND, EITHER EXPRESSED OR IMPLIED, INCLUDING, BUT + NOT LIMITED TO, THE IMPLIED WARRANTIES OF MERCHANTABILITY AND + FITNESS FOR A PARTICULAR PURPOSE. THE ENTIRE RISK AS TO THE + QUALITY AND PERFORMANCE OF THE LIBRARY IS WITH YOU. SHOULD THE + LIBRARY PROVE DEFECTIVE, YOU ASSUME THE COST OF ALL NECESSARY + SERVICING, REPAIR OR CORRECTION. + + + 16. IN NO EVENT UNLESS REQUIRED BY APPLICABLE LAW OR AGREED TO IN + WRITING WILL ANY COPYRIGHT HOLDER, OR ANY OTHER PARTY WHO MAY + MODIFY AND/OR REDISTRIBUTE THE LIBRARY AS PERMITTED ABOVE, BE + LIABLE TO YOU FOR DAMAGES, INCLUDING ANY GENERAL, SPECIAL, + INCIDENTAL OR CONSEQUENTIAL DAMAGES ARISING OUT OF THE USE OR + INABILITY TO USE THE LIBRARY (INCLUDING BUT NOT LIMITED TO LOSS OF + DATA OR DATA BEING RENDERED INACCURATE OR LOSSES SUSTAINED BY YOU + OR THIRD PARTIES OR A FAILURE OF THE LIBRARY TO OPERATE WITH ANY + OTHER SOFTWARE), EVEN IF SUCH HOLDER OR OTHER PARTY HAS BEEN + ADVISED OF THE POSSIBILITY OF SUCH DAMAGES. + + + + END OF TERMS AND CONDITIONS + + How to Apply These Terms to Your New Libraries + + If you develop a new library, and you want it to be of the greatest +possible use to the public, we recommend making it free software that +everyone can redistribute and change. You can do so by permitting +redistribution under these terms (or, alternatively, under the terms of +the ordinary General Public License). + + To apply these terms, attach the following notices to the library. +It is safest to attach them to the start of each source file to most +effectively convey the exclusion of warranty; and each file should have +at least the "copyright" line and a pointer to where the full notice is +found. + + + +Copyright (C) + +This library is free software; you can redistribute it and/or +modify it under the terms of the GNU Lesser General Public +License as published by the Free Software Foundation; either +version 2 of the License, or (at your option) any later version. + +This library is distributed in the hope that it will be useful, +but WITHOUT ANY WARRANTY; without even the implied warranty of +MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU +Lesser General Public License for more details. + +You should have received a copy of the GNU Lesser General Public +License along with this library; if not, write to the Free Software +Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA + + Also add information on how to contact you by electronic and paper +mail. + + You should also get your employer (if you work as a programmer) or +your school, if any, to sign a "copyright disclaimer" for the library, +if necessary. Here is a sample; alter the names: + + +Yoyodyne, Inc., hereby disclaims all copyright interest in the +library `Frob' (a library for tweaking knobs) written by James Random Hacker. + +, 1 April 1990 +Ty Coon, President of Vice + + That's all there is to it! + + +File: libconfig.info, Node: Function Index, Next: Type Index, Prev: License, Up: Top + +Function Index +************** + +[index] +* Menu: + +* add on Setting: The C++ API. (line 428) +* c_str on Setting: The C++ API. (line 234) +* Config on Config: The C++ API. (line 43) +* config_destroy: The C API. (line 15) +* config_error_file: The C API. (line 66) +* config_error_line: The C API. (line 67) +* config_error_text: The C API. (line 65) +* config_error_type: The C API. (line 79) +* config_get_auto_convert: The C API. (line 108) +* config_get_default_format: The C API. (line 125) +* config_get_include_dir: The C API. (line 91) +* config_get_tab_width: The C API. (line 137) +* config_init: The C API. (line 14) +* config_lookup: The C API. (line 172) +* config_lookup_bool: The C API. (line 155) +* config_lookup_float: The C API. (line 153) +* config_lookup_int: The C API. (line 149) +* config_lookup_int64: The C API. (line 151) +* config_lookup_string: The C API. (line 157) +* config_read: The C API. (line 27) +* config_read_file: The C API. (line 37) +* config_read_string: The C API. (line 46) +* config_root_setting: The C API. (line 358) +* config_set_auto_convert: The C API. (line 107) +* config_set_default_format: The C API. (line 124) +* config_set_destructor: The C API. (line 461) +* config_set_include_dir: The C API. (line 89) +* config_set_tab_width: The C API. (line 135) +* config_setting_add: The C API. (line 323) +* config_setting_get_bool: The C API. (line 186) +* config_setting_get_bool_elem: The C API. (line 289) +* config_setting_get_elem: The C API. (line 275) +* config_setting_get_float: The C API. (line 184) +* config_setting_get_float_elem: The C API. (line 287) +* config_setting_get_format: The C API. (line 245) +* config_setting_get_hook: The C API. (line 451) +* config_setting_get_int: The C API. (line 180) +* config_setting_get_int64: The C API. (line 182) +* config_setting_get_int64_elem: The C API. (line 285) +* config_setting_get_int_elem: The C API. (line 283) +* config_setting_get_member: The C API. (line 268) +* config_setting_get_string: The C API. (line 188) +* config_setting_get_string_elem: The C API. (line 291) +* config_setting_index: The C API. (line 384) +* config_setting_is_aggregate: The C API. (line 417) +* config_setting_is_array: The C API. (line 408) +* config_setting_is_group: The C API. (line 406) +* config_setting_is_list: The C API. (line 410) +* config_setting_is_number: The C API. (line 421) +* config_setting_is_root: The C API. (line 378) +* config_setting_is_scalar: The C API. (line 419) +* config_setting_length: The C API. (line 391) +* config_setting_lookup_bool: The C API. (line 227) +* config_setting_lookup_float: The C API. (line 224) +* config_setting_lookup_int: The C API. (line 218) +* config_setting_lookup_int64: The C API. (line 221) +* config_setting_lookup_string: The C API. (line 230) +* config_setting_name: The C API. (line 364) +* config_setting_parent: The C API. (line 372) +* config_setting_remove: The C API. (line 335) +* config_setting_remove_elem: The C API. (line 346) +* config_setting_set_bool: The C API. (line 205) +* config_setting_set_bool_elem: The C API. (line 308) +* config_setting_set_float: The C API. (line 203) +* config_setting_set_float_elem: The C API. (line 306) +* config_setting_set_format: The C API. (line 247) +* config_setting_set_hook: The C API. (line 449) +* config_setting_set_int: The C API. (line 199) +* config_setting_set_int64: The C API. (line 201) +* config_setting_set_int64_elem: The C API. (line 304) +* config_setting_set_int_elem: The C API. (line 302) +* config_setting_set_string: The C API. (line 207) +* config_setting_set_string_elem: The C API. (line 310) +* config_setting_source_file: The C API. (line 431) +* config_setting_source_line: The C API. (line 441) +* config_setting_type: The C API. (line 397) +* config_write: The C API. (line 54) +* config_write_file: The C API. (line 59) +* exists on Config: The C++ API. (line 149) +* exists on Setting: The C++ API. (line 529) +* getAutoConvert on Config: The C++ API. (line 102) +* getDefaultFormat on Config: The C++ API. (line 118) +* getError on ParseException: The C++ API. (line 73) +* getFile on ParseException: The C++ API. (line 74) +* getFormat on Setting: The C++ API. (line 517) +* getIncludeDir on Config: The C++ API. (line 85) +* getIndex on Setting: The C++ API. (line 505) +* getLength on Setting: The C++ API. (line 536) +* getLine on ParseException: The C++ API. (line 75) +* getName on Setting: The C++ API. (line 479) +* getParent on Setting: The C++ API. (line 494) +* getPath on Setting: The C++ API. (line 488) +* getPath on SettingException: The C++ API. (line 35) +* getRoot on Config: The C++ API. (line 137) +* getSourceFile on Setting: The C++ API. (line 557) +* getSourceLine on Setting: The C++ API. (line 566) +* getTabWidth on Config: The C++ API. (line 127) +* getType on Setting: The C++ API. (line 510) +* isAggregate on Setting: The C++ API. (line 548) +* isArray on Setting: The C++ API. (line 543) +* isGroup on Setting: The C++ API. (line 542) +* isList on Setting: The C++ API. (line 544) +* isNumber on Setting: The C++ API. (line 550) +* isRoot on Setting: The C++ API. (line 500) +* isScalar on Setting: The C++ API. (line 549) +* LIBCONFIG_VER_MAJOR: Version Test Macros. (line 9) +* LIBCONFIG_VER_MINOR: Version Test Macros. (line 10) +* LIBCONFIG_VER_REVISION: Version Test Macros. (line 11) +* LIBCONFIGXX_VER_MAJOR: Version Test Macros. (line 28) +* LIBCONFIGXX_VER_MINOR: Version Test Macros. (line 29) +* LIBCONFIGXX_VER_REVISION: Version Test Macros. (line 30) +* lookup on Config: The C++ API. (line 142) +* lookupValue on Config: The C++ API. (line 156) +* lookupValue on Setting: The C++ API. (line 355) +* operator bool () on Setting: The C++ API. (line 223) +* operator const char * () on Setting: The C++ API. (line 232) +* operator double () on Setting: The C++ API. (line 231) +* operator float () on Setting: The C++ API. (line 230) +* operator int () on Setting: The C++ API. (line 224) +* operator long () on Setting: The C++ API. (line 226) +* operator long long () on Setting: The C++ API. (line 228) +* operator std::string () on Setting: The C++ API. (line 233) +* operator unsigned int () on Setting: The C++ API. (line 225) +* operator unsigned long () on Setting: The C++ API. (line 227) +* operator unsigned long long () on Setting: The C++ API. (line 229) +* operator= on Setting: The C++ API. (line 308) +* operator[] on Setting: The C++ API. (line 333) +* read on Config: The C++ API. (line 48) +* readFile on Config: The C++ API. (line 56) +* readString on Config: The C++ API. (line 67) +* remove on Setting: The C++ API. (line 458) +* setAutoConvert on Config: The C++ API. (line 101) +* setDefaultFormat on Config: The C++ API. (line 117) +* setFormat on Setting: The C++ API. (line 518) +* setIncludeDir on Config: The C++ API. (line 84) +* setTabWidth on Config: The C++ API. (line 126) +* write on Config: The C++ API. (line 49) +* writeFile on Config: The C++ API. (line 57) +* ~Config on Config: The C++ API. (line 44) + + +File: libconfig.info, Node: Type Index, Next: Concept Index, Prev: Function Index, Up: Top + +Type Index +********** + +[index] +* Menu: + +* Config: The C++ API. (line 6) +* config_error_t: The C API. (line 79) +* config_setting_t: The C API. (line 6) +* config_t: The C API. (line 6) +* ConfigException: The C++ API. (line 13) +* FileIOException: The C++ API. (line 27) +* ParseException: The C++ API. (line 24) +* Setting: The C++ API. (line 6) +* Setting::Format: The C++ API. (line 520) +* Setting::Type: The C++ API. (line 510) +* SettingException: The C++ API. (line 30) +* SettingFormat: The C API. (line 250) +* SettingNameException: The C++ API. (line 21) +* SettingNotFoundException: The C++ API. (line 19) +* SettingTypeException: The C++ API. (line 16) + + +File: libconfig.info, Node: Concept Index, Prev: Type Index, Up: Top + +Concept Index +************* + +[index] +* Menu: + +* aggregate value: The C API. (line 421) +* array: Configuration Files. (line 24) +* comment: Comments. (line 6) +* configuration: Configuration Files. (line 24) +* escape sequence: String Values. (line 6) +* format: The C API. (line 250) +* group: Configuration Files. (line 24) +* include directive: Include Directives. (line 6) +* list: Configuration Files. (line 24) +* locale: Internationalization Issues. + (line 14) +* path: Configuration Files. (line 77) +* scalar value: Configuration Files. (line 24) +* setting: Configuration Files. (line 24) +* Unicode: Internationalization Issues. + (line 6) +* UTF-8: Internationalization Issues. + (line 6) +* value: Configuration Files. (line 24) + + + +Tag Table: +Node: Top245 +Node: Introduction532 +Node: Why Another Configuration File Library?1368 +Node: Using the Library from a C Program2444 +Node: Using the Library from a C++ Program2912 +Node: Multithreading Issues3577 +Node: Internationalization Issues5144 +Node: Compiling Using pkg-config6667 +Node: Version Test Macros8197 +Node: Configuration Files9383 +Node: Settings13232 +Node: Groups13550 +Node: Arrays13824 +Node: Lists14096 +Node: Integer Values14382 +Node: 64-bit Integer Values14846 +Node: Floating Point Values15225 +Node: Boolean Values15682 +Node: String Values15954 +Node: Comments17074 +Node: Include Directives17981 +Node: The C API19454 +Node: The C++ API41050 +Node: Example Programs65375 +Node: Configuration File Grammar66483 +Node: License67822 +Node: Function Index95916 +Node: Type Index106208 +Node: Concept Index107446 + +End Tag Table diff --git a/libconfig-1.4.9/doc/libconfig.texi b/libconfig-1.4.9/doc/libconfig.texi new file mode 100644 index 0000000000000000000000000000000000000000..52dca20fcd9f4b174fa2933f2d9642c6cb93c17a --- /dev/null +++ b/libconfig-1.4.9/doc/libconfig.texi @@ -0,0 +1,1910 @@ +\input texinfo.tex @c -*-texinfo-*- +@c +@c %**start of header + +@c All text is ignored before the setfilename. +@setfilename libconfig.info +@settitle libconfig + +@set edition 1.4.9 +@set update-date 28 September 2012 +@set subtitle-text A Library For Processing Structured Configuration Files +@set author-text Mark A.@: Lindner + +@comment %**end of header + +@dircategory Software libraries +@direntry +* libconfig: (libconfig). A Library For Processing Structured Configuration Files +@end direntry + + +@tex +\global\emergencystretch = .3\hsize +@end tex + +@setchapternewpage odd + +@titlepage + +@title libconfig +@subtitle @value{subtitle-text} +@subtitle Version @value{edition} +@subtitle @value{update-date} + +@author @value{author-text} + +@page +@vskip 0pt plus 1filll +Copyright @copyright{} 2005-2012 Mark A Lindner + +Permission is granted to make and distribute verbatim copies of +this manual provided the copyright notice and this permission notice +are preserved on all copies. + +Permission is granted to copy and distribute modified versions of this +manual under the conditions for verbatim copying, provided that the entire +resulting derived work is distributed under the terms of a permission +notice identical to this one. + +@end titlepage + +@c Give the HTML output a title page that somewhat resembles the printed one +@ifhtml +@html +
+
@value{subtitle-text}
+Version @value{edition}
+@value{update-date}
+



+@value{author-text} +
+

+@end html +@end ifhtml + +@contents + +@ifnottex +@node Top +@comment node-name, next, previous, up +@top libconfig +@end ifnottex + +@menu +* Introduction:: +* Configuration Files:: +* The C API:: +* The C++ API:: +* Example Programs:: +* Configuration File Grammar:: +* License:: +* Function Index:: +* Type Index:: +* Concept Index:: +@end menu + +@node Introduction, Configuration Files, Top, Top +@comment node-name, next, previous, up +@menu +* Why Another Configuration File Library?:: +* Using the Library from a C Program:: +* Using the Library from a C++ Program:: +* Multithreading Issues:: +* Internationalization Issues:: +* Compiling Using pkg-config:: +* Version Test Macros:: +@end menu +@chapter Introduction + +@i{Libconfig} is a library for reading, manipulating, and writing +structured configuration files. The library features a fully +reentrant parser and includes bindings for both the C and C++ +programming languages. + +The library runs on modern POSIX-compilant systems, such as Linux, +Solaris, and Mac OS X (Darwin), as well as on Microsoft Windows +2000/XP and later (with either Microsoft Visual Studio 2005 or later, +or the GNU toolchain via the MinGW environment). + +@node Why Another Configuration File Library?, Using the Library from a C Program, , Introduction +@comment node-name, next, previous, up +@section Why Another Configuration File Library? + +There are several open-source configuration file libraries available +as of this writing. This library was written because each of those +libraries falls short in one or more ways. The main features of +@i{libconfig} that set it apart from the other libraries are: + +@itemize @bullet + +@item A fully reentrant parser. Independent configurations can be parsed in concurrent threads at the same time. + +@item Both C @i{and} C++ bindings, as well as hooks to allow for the creation of wrappers in other languages. + +@item A simple, structured configuration file format that is more +readable and compact than XML and more flexible than the obsolete but +prevalent Windows ``INI'' file format. + +@item A low-footprint implementation (just 37K for the C library and 76K for +the C++ library) that is suitable for memory-constrained systems. + +@item Proper documentation. + +@end itemize + +@node Using the Library from a C Program, Using the Library from a C++ Program, Why Another Configuration File Library?, Introduction +@comment node-name, next, previous, up +@section Using the Library from a C Program + +To use the library from C code, include the following preprocessor +directive in your source files: + +@sp 1 +@smallexample +#include +@end smallexample +@sp 1 + +To link with the library, specify @samp{-lconfig} as an argument to the +linker. + +@node Using the Library from a C++ Program, Multithreading Issues, Using the Library from a C Program, Introduction +@comment node-name, next, previous, up +@section Using the Library from a C++ Program + +To use the library from C++, include the following preprocessor +directive in your source files: + +@sp 1 +@smallexample +#include +@end smallexample +@sp 1 + +Or, alternatively: + +@sp 1 +@smallexample +#include +@end smallexample +@sp 1 +@page +The C++ API classes are defined in the namespace @samp{libconfig}, hence the +following statement may optionally be used: + +@sp 1 +@smallexample +using namespace libconfig; +@end smallexample +@sp 1 + +To link with the library, specify @samp{-lconfig++} as an argument to +the linker. + +@node Multithreading Issues, Internationalization Issues, Using the Library from a C++ Program, Introduction +@comment node-name, next, previous, up +@section Multithreading Issues + +@i{Libconfig} is fully @dfn{reentrant}; the functions in the library +do not make use of global variables and do not maintain state between +successive calls. Therefore two independent configurations may be safely +manipulated concurrently by two distinct threads. + +@i{Libconfig} is not @dfn{thread-safe}. The library is not aware of +the presence of threads and knows nothing about the host system's +threading model. Therefore, if an instance of a configuration is to be +accessed from multiple threads, it must be suitably protected by +synchronization mechanisms like read-write locks or mutexes; the +standard rules for safe multithreaded access to shared data must be +observed. + +@i{Libconfig} is not @dfn{async-safe}. Calls should not be made into +the library from signal handlers, because some of the C library +routines that it uses may not be async-safe. + +@i{Libconfig} is not guaranteed to be @dfn{cancel-safe}. Since it is +not aware of the host system's threading model, the library does not +contain any thread cancellation points. In most cases this will not be +an issue for multithreaded programs. However, be aware that some of +the routines in the library (namely those that read/write +configurations from/to files or streams) perform I/O using C library +routines which may potentially block; whether or not these C library +routines are cancel-safe depends on the host system. + +@node Internationalization Issues, Compiling Using pkg-config, Multithreading Issues, Introduction +@comment node-name, next, previous, up +@section Internationalization Issues + +@cindex Unicode +@cindex UTF-8 +@i{Libconfig} does not natively support Unicode configuration files, +but string values may contain Unicode text encoded in UTF-8; such +strings will be treated as ordinary 8-bit ASCII text by the +library. It is the responsibility of the calling program to perform +the necessary conversions to/from wide (@t{wchar_t}) strings using the +wide string conversion functions such as @t{mbsrtowcs()} and +@t{wcsrtombs()} or the @t{iconv()} function of the @i{libiconv} +library. + +@cindex locale +The textual representation of a floating point value varies by +locale. However, the @i{libconfig} grammar specifies that +floating point values are represented using a period (`.') as the +radix symbol; this is consistent with the grammar of most programming +languages. When a configuration is read in or written out, +@i{libconfig} temporarily changes the @t{LC_NUMERIC} category of the +locale of the calling thread to the ``C'' locale to ensure consistent +handling of floating point values regardless of the locale(s) in use +by the calling program. + +Note that the MinGW environment does not (as of this writing) provide +functions for changing the locale of the calling thread. Therefore, +when using @i{libconfig} in that environment, the calling program is +responsible for changing the @t{LC_NUMERIC} category of the locale to +the "C" locale before reading or writing a configuration. + +@node Compiling Using pkg-config, Version Test Macros, Internationalization Issues, Introduction +@comment node-name, next, previous, up +@section Compiling Using pkg-config + +On UNIX systems you can use the @i{pkg-config} utility (version 0.20 +or later) to automatically select the appropriate compiler and linker +switches for @i{libconfig}. Ensure that the environment variable +@code{PKG_CONFIG_PATH} contains the absolute path to the +@file{lib/pkgconfig} subdirectory of the @i{libconfig} installation. Then, +you can compile and link C programs with @i{libconfig} as follows: + +@smallexample +gcc `pkg-config --cflags libconfig` myprogram.c -o myprogram \ + `pkg-config --libs libconfig` +@end smallexample +@sp 1 + +And similarly, for C++ programs: + +@smallexample +g++ `pkg-config --cflags libconfig++` myprogram.cpp -o myprogram \ + `pkg-config --libs libconfig++` +@end smallexample + +@sp 1 +Note the backticks in the above examples. + +When using @b{autoconf}, the @code{PKG_CHECK_MODULES} m4 macro may be used to check for the presence of a given version of @i{libconfig}, and set the appropriate Makefile variables automatically. For example: + +@smallexample +PKG_CHECK_MODULES([LIBCONFIGXX], [libconfig++ >= 1.4],, + AC_MSG_ERROR([libconfig++ 1.4 or newer not found.]) +) +@end smallexample + +In the above example, if @i{libconfig++} version 1.4 or newer is found, +the Makefile variables @code{LIBCONFIGXX_LIBS} and @code{LIBCONFIGXX_CFLAGS} will be +set to the appropriate compiler and linker flags for compiling with +@i{libconfig}, and if it is not found, the configure script will abort +with an error to that effect. + +@node Version Test Macros, , Compiling Using pkg-config, Introduction +@comment node-name, next, previous, up +@section Version Test Macros + +The @file{libconfig.h} header declares the following macros: + +@defmac LIBCONFIG_VER_MAJOR +@defmacx LIBCONFIG_VER_MINOR +@defmacx LIBCONFIG_VER_REVISION + +These macros represent the major version, minor version, and revision +of the @i{libconfig} library. For example, in @i{libconfig} 1.4 these +are defined as @samp{1}, @samp{4}, and @samp{0}, respectively. These +macros can be used in preprocessor directives to determine which +@i{libconfig} features and/or APIs are present. For example: + +@smallexample +#if (((LIBCONFIG_VER_MAJOR == 1) && (LIBCONFIG_VER_MINOR >= 4)) \ + || (LIBCONFIG_VER_MAJOR > 1)) + /* use features present in libconfig 1.4 and later */ +#endif +@end smallexample + +These macros were introduced in @i{libconfig} 1.4. + +@end defmac + +Similarly, the @file{libconfig.h++} header declares the following macros: + +@defmac LIBCONFIGXX_VER_MAJOR +@defmacx LIBCONFIGXX_VER_MINOR +@defmacx LIBCONFIGXX_VER_REVISION + +These macros represent the major version, minor version, and revision +of the @i{libconfig++} library. + +@end defmac + +@node Configuration Files, The C API, Introduction, Top +@comment node-name, next, previous, up +@menu +* Settings:: +* Groups:: +* Arrays:: +* Lists:: +* Integer Values:: +* 64-bit Integer Values:: +* Floating Point Values:: +* Boolean Values:: +* String Values:: +* Comments:: +* Include Directives:: +@end menu +@chapter Configuration Files + +@i{Libconfig} supports structured, hierarchical configurations. These +configurations can be read from and written to files and manipulated +in memory. + +@cindex setting +@cindex value +@cindex scalar value +@cindex array +@cindex group +@cindex list +@cindex configuration +A @dfn{configuration} consists of a group of @dfn{settings}, which +associate names with values. A @dfn{value} can be one of the +following: + +@itemize @bullet +@item A @dfn{scalar value}: integer, 64-bit integer, floating-point number, boolean, +or string +@item An @dfn{array}, which is a sequence of scalar values, all of which must have the same type +@item A @dfn{group}, which is a collection of settings +@item A @dfn{list}, which is a sequence of values of any type, including other lists +@end itemize + +Consider the following configuration file for a hypothetical GUI +application, which illustrates all of the elements of the configuration +file grammar. + +@sp 1 +@cartouche +@smallexample +# Example application configuration file + +version = "1.0"; + +application: +@{ + window: + @{ + title = "My Application"; + size = @{ w = 640; h = 480; @}; + pos = @{ x = 350; y = 250; @}; + @}; + + list = ( ( "abc", 123, true ), 1.234, ( /* an empty list */) ); + + books = ( @{ title = "Treasure Island"; + author = "Robert Louis Stevenson"; + price = 29.95; + qty = 5; @}, + @{ title = "Snow Crash"; + author = "Neal Stephenson"; + price = 9.99; + qty = 8; @} ); + + misc: + @{ + pi = 3.141592654; + bigint = 9223372036854775807L; + columns = [ "Last Name", "First Name", "MI" ]; + bitmask = 0x1FC3; + @}; +@}; +@end smallexample +@end cartouche +@sp 1 + +@cindex path +Settings can be uniquely identified within the configuration by a +@dfn{path}. The path is a dot-separated sequence of names, beginning +at a top-level group and ending at the setting itself. Each name in +the path is the name of a setting; if the setting has no name because +it is an element in a list or array, an integer index in square +brackets can be used as the name. + +For example, in our hypothetical configuration file, the path to the +@code{x} setting is @code{application.window.pos.x}; the path to the +@code{version} setting is simply @code{version}; and the path to the +@code{title} setting of the second book in the @code{books} list is +@code{application.books.[1].title}. + +The datatype of a value is determined from the format of the value +itself. If the value is enclosed in double quotes, it is treated as a +string. If it looks like an integer or floating point number, it is +treated as such. If it is one of the values @code{TRUE}, @code{true}, +@code{FALSE}, or @code{false} (or any other mixed-case version of +those tokens, e.g., @code{True} or @code{FaLsE}), it is treated as a +boolean. If it consists of a comma-separated list of values enclosed +in square brackets, it is treated as an array. And if it consists of a +comma-separated list of values enclosed in parentheses, it is treated +as a list. Any value which does not meet any of these criteria is +considered invalid and results in a parse error. + +All names are case-sensitive. They may consist only of alphanumeric +characters, dashes (@samp{-}), underscores (@samp{_}), and asterisks +(@samp{*}), and must begin with a letter or asterisk. No other +characters are allowed. + +In C and C++, integer, 64-bit integer, floating point, and string +values are mapped to the types @code{int}, @code{long long}, +@code{double}, and @code{const char *}, respectively. The boolean type +is mapped to @code{int} in C and @code{bool} in C++. + +The following sections describe the elements of the configuration file +grammar in additional detail. + +@node Settings, Groups, , Configuration Files +@comment node-name, next, previous, up +@section Settings + +A setting has the form: + +@i{name} @b{=} @i{value} @b{;} + +or: + +@i{name} @b{:} @i{value} @b{;} + +The trailing semicolon is optional. Whitespace is not significant. + +The value may be a scalar value, an array, a group, or a list. + +@node Groups, Arrays, Settings, Configuration Files +@comment node-name, next, previous, up +@section Groups + +A group has the form: + +@b{@{} + @i{settings ...} +@b{@}} + +Groups can contain any number of settings, but each setting must have +a unique name within the group. + +@node Arrays, Lists, Groups, Configuration Files +@comment node-name, next, previous, up +@section Arrays + +An array has the form: + +@b{[} @i{value}@b{,} @i{value ...} @b{]} + +An array may have zero or more elements, but the elements must all be +scalar values of the same type. + +@node Lists, Integer Values, Arrays, Configuration Files +@comment node-name, next, previous, up +@section Lists + +A list has the form: + +@b{(} @i{value}@b{,} @i{value ...} @b{)} + +A list may have zero or more elements, each of which can be a scalar +value, an array, a group, or another list. + +@node Integer Values, 64-bit Integer Values, Lists, Configuration Files +@comment node-name, next, previous, up +@section Integer Values + +Integers can be represented in one of two ways: as a series of one or +more decimal digits (@samp{0} - @samp{9}), with an optional leading +sign character (@samp{+} or @samp{-}); or as a hexadecimal value +consisting of the characters @samp{0x} followed by a series of one or +more hexadecimal digits (@samp{0} - @samp{9}, @samp{A} - @samp{F}, +@samp{a} - @samp{f}). + +@node 64-bit Integer Values, Floating Point Values, Integer Values, Configuration Files +@comment node-name, next, previous, up +@section 64-bit Integer Values + +Long long (64-bit) integers are represented identically to integers, +except that an 'L' character is appended to indicate a 64-bit +value. For example, @samp{0L} indicates a 64-bit integer value 0. + +@node Floating Point Values, Boolean Values, 64-bit Integer Values, Configuration Files +@comment node-name, next, previous, up +@section Floating Point Values + +Floating point values consist of a series of one or more digits, one +decimal point, an optional leading sign character (@samp{+} or +@samp{-}), and an optional exponent. An exponent consists of the +letter @samp{E} or @samp{e}, an optional sign character, and a series +of one or more digits. + +@node Boolean Values, String Values, Floating Point Values, Configuration Files +@comment node-name, next, previous, up +@section Boolean Values + +Boolean values may have one of the following values: @samp{true}, +@samp{false}, or any mixed-case variation thereof. + +@node String Values, Comments, Boolean Values, Configuration Files +@comment node-name, next, previous, up +@section String Values + +@cindex escape sequence +String values consist of arbitrary text delimited by double +quotes. Literal double quotes can be escaped by preceding them with a +backslash: @samp{\"}. The escape sequences @samp{\\}, @samp{\f}, +@samp{\n}, @samp{\r}, and @samp{\t} are also recognized, and have the +usual meaning. + +In addition, the @samp{\x} escape sequence is supported; this sequence +must be followed by @i{exactly two} hexadecimal digits, which represent an +8-bit ASCII value. For example, @samp{\xFF} represents the character +with ASCII code 0xFF. + +No other escape sequences are currently supported. + +Adjacent strings are automatically concatenated, as in C/C++ source +code. This is useful for formatting very long strings as sequences of +shorter strings. For example, the following constructs are equivalent: + +@itemize @bullet +@item +@code{"The quick brown fox jumped over the lazy dog."} + +@item +@code{"The quick brown fox"} @* +@code{" jumped over the lazy dog."} + +@item +@code{"The quick" /* comment */ " brown fox " // another comment} @* +@code{"jumped over the lazy dog."} + +@end itemize +@page +@node Comments, Include Directives, String Values, Configuration Files +@comment node-name, next, previous, up +@section Comments + +@cindex comment +Three types of comments are allowed within a configuration: + +@itemize @bullet + +@item Script-style comments. All text beginning with a @samp{#} character +to the end of the line is ignored. + +@item C-style comments. All text, including line breaks, between a starting +@samp{/*} sequence and an ending @samp{*/} sequence is ignored. + +@item C++-style comments. All text beginning with a @samp{//} sequence to the +end of the line is ignored. + +@end itemize + +As expected, comment delimiters appearing within quoted strings are +treated as literal text. + +Comments are ignored when the configuration is read in, so they are +not treated as part of the configuration. Therefore if the +configuration is written back out to a stream, any comments that were +present in the original configuration will be lost. + +@node Include Directives, , Comments, Configuration Files +@comment node-name, next, previous, up +@section Include Directives + +@cindex include directive +A configuration file may ``include'' the contents of another file +using an @i{include directive}. This directive has the effect of +inlining the contents of the named file at the point of inclusion. + +An include directive must appear on its own line in the input. It has +the form: + +@b{@@include "}@i{filename}@b{"} + +Any backslashes or double quotes in the filename must be escaped as +@samp{\\} and @samp{\"}, respectively. + +For example, consider the following two configuration files: + +@cartouche +@smallexample +# file: quote.cfg +quote = "Criticism may not be agreeable, but it is necessary." + " It fulfils the same function as pain in the human" + " body. It calls attention to an unhealthy state of" + " things.\n" + "\t--Winston Churchill"; +@end smallexample +@end cartouche + +@cartouche +@smallexample +# file: test.cfg +info: @{ + name = "Winston Churchill"; + @@include "quote.cfg" + country = "UK"; +@}; +@end smallexample +@end cartouche + +Include files may be nested to a maximum of 10 levels; exceeding this +limit results in a parse error. + +Like comments, include directives are not part of the configuration +file syntax. They are processed before the configuration itself is +parsed. Therefore, they are not preserved when the configuration is +written back out to a stream. There is presently no support for +programmatically inserting include directives into a configuration. + +@node The C API, The C++ API, Configuration Files, Top +@comment node-name, next, previous, up +@chapter The C API + +@tindex config_t +@tindex config_setting_t +This chapter describes the C library API. The type @i{config_t} +represents a configuration, and the type @i{config_setting_t} represents +a configuration setting. + +The boolean values @code{CONFIG_TRUE} and @code{CONFIG_FALSE} are +macros defined as @code{(1)} and @code{(0)}, respectively. + +@deftypefun void config_init (@w{config_t * @var{config}}) +@deftypefunx void config_destroy (@w{config_t * @var{config}}) + +These functions initialize and destroy the configuration object @var{config}. + +@code{config_init()} initializes the @i{config_t} structure pointed to by +@var{config} as a new, empty configuration. + +@code{config_destroy()} destroys the configuration @var{config}, +deallocating all memory associated with the configuration, but does not +attempt to deallocate the @i{config_t} structure itself. + +@end deftypefun + +@deftypefun int config_read (@w{config_t * @var{config}}, @w{FILE * @var{stream}}) + +This function reads and parses a configuration from the given +@var{stream} into the configuration object @var{config}. It returns +@code{CONFIG_TRUE} on success, or @code{CONFIG_FALSE} on failure; the +@code{config_error_text()}, @code{config_error_file()}, +@code{config_error_line()}, and @code{config_error_type()} functions, +described below, can be used to obtain information about the error. + +@end deftypefun + +@deftypefun int config_read_file (@w{config_t * @var{config}}, @w{const char * @var{filename}}) + +This function reads and parses a configuration from the file named +@var{filename} into the configuration object @var{config}. It returns +@code{CONFIG_TRUE} on success, or @code{CONFIG_FALSE} on failure; the +@code{config_error_text()} and @code{config_error_line()} functions, +described below, can be used to obtain information about the error. + +@end deftypefun + +@deftypefun int config_read_string (@w{config_t * @var{config}}, @w{const char * @var{str}}) + +This function reads and parses a configuration from the string +@var{str} into the configuration object @var{config}. It returns +@code{CONFIG_TRUE} on success, or @code{CONFIG_FALSE} on failure; the +@code{config_error_text()} and @code{config_error_line()} functions, +described below, can be used to obtain information about the error. + +@end deftypefun + +@deftypefun void config_write (@w{const config_t * @var{config}}, @w{FILE * @var{stream}}) + +This function writes the configuration @var{config} to the given +@var{stream}. + +@end deftypefun + +@deftypefun int config_write_file (@w{config_t * @var{config}}, @w{const char * @var{filename}}) + +This function writes the configuration @var{config} to the file named +@var{filename}. It returns @code{CONFIG_TRUE} on success, or +@code{CONFIG_FALSE} on failure. + +@end deftypefun + +@deftypefun {const char *} config_error_text (@w{const config_t * @var{config}}) +@deftypefunx {const char *} config_error_file (@w{const config_t * @var{config}}) +@deftypefunx int config_error_line (@w{const config_t * @var{config}}) + +These functions, which are implemented as macros, return the text, +filename, and line number of the parse error, if one occurred during a +call to @code{config_read()}, @code{config_read_string()}, or +@code{config_read_file()}. Storage for the strings returned by +@code{config_error_text()} and @code{config_error_file()} are managed +by the library and released automatically when the configuration is +destroyed; these strings must not be freed by the caller. If the error +occurred in text that was read from a string or stream, +@code{config_error_file()} will return NULL. + +@end deftypefun + +@deftypefun config_error_t config_error_type (@w{const config_t * @var{config}}) +@tindex config_error_t +This function, which is implemented as a macro, returns the type of +error that occurred during the last call to one of the read or write +functions. The @var{config_error_t} type is an enumeration with the +following values: @code{CONFIG_ERR_NONE}, @code{CONFIG_ERR_FILE_IO}, +@code{CONFIG_ERR_PARSE}. These represent success, a file I/O error, +and a parsing error, respectively. + +@end deftypefun + +@deftypefun void config_set_include_dir (@w{config_t *@var{config}}, @w{const char *@var{include_dir}}) +@deftypefunx {const char *} config_get_include_dir (@w{const config_t *@var{config}}) + +@code{config_set_include_dir()} specifies the include directory, +@var{include_dir}, relative to which the files specified in +@samp{@@include} directives will be located for the configuration +@var{config}. By default, there is no include directory, and all +include files are expected to be relative to the current working +directory. If @var{include_dir} is @code{NULL}, the default behavior +is reinstated. + +For example, if the include directory is set to @file{/usr/local/etc}, +the include directive @samp{@@include "configs/extra.cfg"} would include the +file @file{/usr/local/etc/configs/extra.cfg}. + +@code{config_get_include_dir()} returns the current include directory for the +configuration @var{config}, or @code{NULL} if none is set. + +@end deftypefun + +@deftypefun void config_set_auto_convert (@w{config_t *@var{config}}, @w{int @var{flag}}) +@deftypefunx int config_get_auto_convert (@w{const config_t *@var{config}}) + +@code{config_set_auto_convert()} enables number auto-conversion for +the configuration @var{config} if @var{flag} is non-zero, and disables +it otherwise. When this feature is enabled, an attempt to retrieve a +floating point setting's value into an integer (or vice versa), or +store an integer to a floating point setting's value (or vice versa) +will cause the library to silently perform the necessary conversion +(possibly leading to loss of data), rather than reporting failure. By +default this feature is disabled. + +@code{config_get_auto_convert()} returns @code{CONFIG_TRUE} if number +auto-conversion is currently enabled for @var{config}; otherwise it +returns @code{CONFIG_FALSE}. + +@end deftypefun + +@deftypefun void config_set_default_format (@w{config_t * @var{config}}, @w{short @var{format}}) +@deftypefunx short config_get_default_format (@w{config_t * @var{config}}) + +These functions, which are implemented as macros, set and get the +default external format for settings in the configuration +@var{config}. If a non-default format has not been set for a setting +with @code{config_setting_set_format()}, this configuration-wide +default format will be used instead when that setting is written to a +file or stream. + +@end deftypefun + +@deftypefun void config_set_tab_width (@w{config_t * @var{config}}, @w{unsigned short @var{width}}) +@deftypefunx {unsigned short} config_get_tab_width (@w{const config_t * @var{config}}) + +These functions, which are implemented as macros, set and get the tab +width for the configuration @var{config}. The tab width affects the +formatting of the configuration when it is written to a file or +stream: each level of nesting is indented by @var{width} spaces, or +by a single tab character if @var{width} is 0. The tab width has no +effect on parsing. + +Valid tab widths range from 0 to 15. The default tab width is 2. + +@end deftypefun + +@deftypefun int config_lookup_int (@w{const config_t * @var{config}}, @w{const char * @var{path}}, @w{int * @var{value}}) +@deftypefunx int config_lookup_int64 (@w{const config_t * @var{config}}, @w{const char * @var{path}}, @w{long long * @var{value}}) +@deftypefunx int config_lookup_float (@w{const config_t * @var{config}}, @w{const char * @var{path}}, @w{double * @var{value}}) +@deftypefunx int config_lookup_bool (@w{const config_t * @var{config}}, @w{const char * @var{path}}, @w{int * @var{value}}) +@deftypefunx int config_lookup_string (@w{const config_t * @var{config}}, @w{const char * @var{path}}, @w{const char ** @var{value}}) + +These functions look up the value of the setting in the configuration +@var{config} specified by the path @var{path}. They store the value of +the setting at @var{value} and return @code{CONFIG_TRUE} on +success. If the setting was not found or if the type of the value did +not match the type requested, they leave the data pointed to by +@var{value} unmodified and return @code{CONFIG_FALSE}. + +Storage for the string returned by @code{config_lookup_string()} is +managed by the library and released automatically when the setting is +destroyed or when the setting's value is changed; the string must not +be freed by the caller. + +@end deftypefun + +@deftypefun {config_setting_t *} config_lookup (@w{const config_t * @var{config}}, @w{const char * @var{path}}) + +This function locates the setting in the configuration @var{config} +specified by the path @var{path}. It returns a pointer to the +@code{config_setting_t} structure on success, or @code{NULL} if the +setting was not found. + +@end deftypefun + +@deftypefun int config_setting_get_int (@w{const config_setting_t * @var{setting}}) +@deftypefunx {long long} config_setting_get_int64 (@w{const config_setting_t * @var{setting}}) +@deftypefunx double config_setting_get_float (@w{const config_setting_t * @var{setting}}) +@deftypefunx int config_setting_get_bool (@w{const config_setting_t * @var{setting}}) +@deftypefunx {const char *} config_setting_get_string (@w{const config_setting_t * @var{setting}}) + +These functions return the value of the given @var{setting}. If the +type of the setting does not match the type requested, a 0 or +@code{NULL} value is returned. Storage for the string returned by +@code{config_setting_get_string()} is managed by the library and +released automatically when the setting is destroyed or when the +setting's value is changed; the string must not be freed by the +caller. + +@end deftypefun +@deftypefun int config_setting_set_int (@w{config_setting_t * @var{setting}}, @w{int @var{value}}) +@deftypefunx int config_setting_set_int64 (@w{config_setting_t * @var{setting}}, @w{long long @var{value}}) +@deftypefunx int config_setting_set_float (@w{config_setting_t * @var{setting}}, @w{double @var{value}}) +@deftypefunx int config_setting_set_bool (@w{config_setting_t * @var{setting}}, @w{int @var{value}}) +@deftypefunx int config_setting_set_string (@w{config_setting_t * @var{setting}}, @w{const char * @var{value}}) + +These functions set the value of the given @var{setting} to +@var{value}. On success, they return @code{CONFIG_TRUE}. If +the setting does not match the type of the value, they return +@code{CONFIG_FALSE}. @code{config_setting_set_string()} makes a copy +of the passed string @var{value}, so it may be subsequently freed or +modified by the caller without affecting the value of the setting. + +@end deftypefun + +@deftypefun int config_setting_lookup_int (@w{const config_setting_t * @var{setting}}, @w{const char * @var{name}}, @w{int * @var{value}}) +@deftypefunx int config_setting_lookup_int64 (@w{const config_setting_t * @var{setting}}, @w{const char * @var{name}}, @w{long long * @var{value}}) +@deftypefunx int config_setting_lookup_float (@w{const config_setting_t * @var{setting}}, @w{const char * @var{name}}, @w{double * @var{value}}) +@deftypefunx int config_setting_lookup_bool (@w{const config_setting_t * @var{setting}}, @w{const char * @var{name}}, @w{int * @var{value}}) +@deftypefunx int config_setting_lookup_string (@w{const config_setting_t * @var{setting}}, @w{const char * @var{name}}, @w{const char ** @var{value}}) + +These functions look up the value of the child setting named +@var{name} of the setting @var{setting}. They store the value at +@var{value} and return @code{CONFIG_TRUE} on success. If the setting +was not found or if the type of the value did not match the type +requested, they leave the data pointed to by @var{value} unmodified +and return @code{CONFIG_FALSE}. + +Storage for the string returned by @code{config_setting_lookup_string()} is +managed by the library and released automatically when the setting is +destroyed or when the setting's value is changed; the string must not +be freed by the caller. + +@end deftypefun + +@deftypefun short config_setting_get_format (@w{config_setting_t * @var{setting}}) +@deftypefunx int config_setting_set_format (@w{config_setting_t * @var{setting}}, @w{short @var{format}}) + +These functions get and set the external format for the setting @var{setting}. + +@tindex SettingFormat +@cindex format + +The @var{format} must be one of the constants +@code{CONFIG_FORMAT_DEFAULT} or @code{CONFIG_FORMAT_HEX}. All settings +support the @code{CONFIG_FORMAT_DEFAULT} format. The +@code{CONFIG_FORMAT_HEX} format specifies hexadecimal formatting for +integer values, and hence only applies to settings of type +@code{CONFIG_TYPE_INT} and @code{CONFIG_TYPE_INT64}. If @var{format} +is invalid for the given setting, it is ignored. + +If a non-default format has not been set for the setting, @code{config_setting_get_format()} returns the default format for the configuration, as set by @code{config_set_default_format()}. + +@code{config_setting_set_format()} returns @code{CONFIG_TRUE} on +success and @code{CONFIG_FALSE} on failure. + +@end deftypefun + + +@deftypefun {config_setting_t *} config_setting_get_member (@w{config_setting_t * @var{setting}}, @w{const char * @var{name}}) + +This function fetches the child setting named @var{name} from the group +@var{setting}. It returns the requested setting on success, or +@code{NULL} if the setting was not found or if @var{setting} is not a +group. + +@end deftypefun + +@deftypefun {config_setting_t *} config_setting_get_elem (@w{const config_setting_t * @var{setting}}, @w{unsigned int @var{index}}) + +This function fetches the element at the given index @var{index} in the +setting @var{setting}, which must be an array, list, or group. It returns the +requested setting on success, or @code{NULL} if @var{index} is out of +range or if @var{setting} is not an array, list, or group. + +@end deftypefun + +@deftypefun int config_setting_get_int_elem (@w{const config_setting_t * @var{setting}}, @w{int @var{index}}) +@deftypefunx {long long} config_setting_get_int64_elem (@w{const config_setting_t * @var{setting}}, @w{int @var{index}}) +@deftypefunx double config_setting_get_float_elem (@w{const config_setting_t * @var{setting}}, @w{int @var{index}}) +@deftypefunx int config_setting_get_bool_elem (@w{const config_setting_t * @var{setting}}, @w{int @var{index}}) +@deftypefunx {const char *} config_setting_get_string_elem (@w{const config_setting_t * @var{setting}}, @w{int @var{index}}) + +These functions return the value at the specified index @var{index} in the +setting @var{setting}. If the setting is not an array or list, or if +the type of the element does not match the type requested, or if +@var{index} is out of range, they return 0 or @code{NULL}. Storage for +the string returned by @code{config_setting_get_string_elem()} is +managed by the library and released automatically when the setting is +destroyed or when its value is changed; the string must not be freed +by the caller. +@end deftypefun + +@deftypefun {config_setting_t *} config_setting_set_int_elem (@w{config_setting_t * @var{setting}}, @w{int @var{index}}, @w{int @var{value}}) +@deftypefunx {config_setting_t *} config_setting_set_int64_elem (@w{config_setting_t * @var{setting}}, @w{int @var{index}}, @w{long long @var{value}}) +@deftypefunx {config_setting_t *} config_setting_set_float_elem (@w{config_setting_t * @var{setting}}, @w{int @var{index}}, @w{double @var{value}}) +@deftypefunx {config_setting_t *} config_setting_set_bool_elem (@w{config_setting_t * @var{setting}}, @w{int @var{index}}, @w{int @var{value}}) +@deftypefunx {config_setting_t *} config_setting_set_string_elem (@w{config_setting_t * @var{setting}}, @w{int @var{index}}, @w{const char * @var{value}}) + +These functions set the value at the specified index @var{index} in the +setting @var{setting} to @var{value}. If @var{index} is negative, a +new element is added to the end of the array or list. On success, +these functions return a pointer to the setting representing the +element. If the setting is not an array or list, or if the setting is +an array and the type of the array does not match the type of the +value, or if @var{index} is out of range, they return +@code{NULL}. @code{config_setting_set_string_elem()} makes a copy of +the passed string @var{value}, so it may be subsequently freed or +modified by the caller without affecting the value of the setting. +@end deftypefun + +@deftypefun {config_setting_t *} config_setting_add (@w{config_setting_t * @var{parent}}, @w{const char * @var{name}}, @w{int @var{type}}) + +This function adds a new child setting or element to the setting +@var{parent}, which must be a group, array, or list. If @var{parent} +is an array or list, the @var{name} parameter is ignored and may be +@code{NULL}. + +The function returns the new setting on success, or @code{NULL} if +@var{parent} is not a group, array, or list; or if there is already a +child setting of @var{parent} named @var{name}; or if @var{type} is +invalid. If @var{type} is a scalar type, the new setting will have a +default value of 0, 0.0, @code{false}, or @code{NULL}, as appropriate. +@end deftypefun + +@deftypefun int config_setting_remove (@w{config_setting_t * @var{parent}}, @w{const char * @var{name}}) + +This function removes and destroys the setting named @var{name} from +the parent setting @var{parent}, which must be a group. Any child +settings of the setting are recursively destroyed as well. + +The function returns @code{CONFIG_TRUE} on success. If @var{parent} is +not a group, or if it has no setting with the given name, it returns +@code{CONFIG_FALSE}. + +@end deftypefun + +@deftypefun int config_setting_remove_elem (@w{config_setting_t * @var{parent}}, @w{unsigned int @var{index}}) + +This function removes the child setting at the given index @var{index} from +the setting @var{parent}, which must be a group, list, or array. Any +child settings of the removed setting are recursively destroyed as +well. + +The function returns @code{CONFIG_TRUE} on success. If @var{parent} is +not a group, list, or array, or if @var{index} is out of range, it returns +@code{CONFIG_FALSE}. + +@end deftypefun + +@deftypefun {config_setting_t *} config_root_setting (@w{const config_t * @var{config}}) + +This function returns the root setting for the configuration +@var{config}. The root setting is a group. + +@end deftypefun + +@deftypefun {const char *} config_setting_name (@w{const config_setting_t * @var{setting}}) + +This function returns the name of the given @var{setting}, or +@code{NULL} if the setting has no name. Storage for the returned +string is managed by the library and released automatically when the +setting is destroyed; the string must not be freed by the caller. + +@end deftypefun + +@deftypefun {config_setting_t *} config_setting_parent (@w{const config_setting_t * @var{setting}}) + +This function returns the parent setting of the given @var{setting}, +or @code{NULL} if @var{setting} is the root setting. + +@end deftypefun + +@deftypefun int config_setting_is_root (@w{const config_setting_t * @var{setting}}) + +This function returns @code{CONFIG_TRUE} if the given @var{setting} is +the root setting, and @code{CONFIG_FALSE} otherwise. + +@end deftypefun + +@deftypefun int config_setting_index (@w{const config_setting_t * @var{setting}}) + +This function returns the index of the given @var{setting} within its +parent setting. If @var{setting} is the root setting, this function +returns -1. + +@end deftypefun + +@deftypefun int config_setting_length (@w{const config_setting_t * @var{setting}}) + +This function returns the number of settings in a group, or the number of +elements in a list or array. For other types of settings, it returns +0. + +@end deftypefun + +@deftypefun int config_setting_type (@w{const config_setting_t * @var{setting}}) + +This function returns the type of the given @var{setting}. The return +value is one of the constants +@code{CONFIG_TYPE_INT}, @code{CONFIG_TYPE_INT64}, @code{CONFIG_TYPE_FLOAT}, +@code{CONFIG_TYPE_STRING}, @code{CONFIG_TYPE_BOOL}, +@code{CONFIG_TYPE_ARRAY}, @code{CONFIG_TYPE_LIST}, or @code{CONFIG_TYPE_GROUP}. + +@end deftypefun + +@deftypefun int config_setting_is_group (@w{const config_setting_t * @var{setting}}) +@deftypefunx int config_setting_is_array (@w{const config_setting_t * @var{setting}}) +@deftypefunx int config_setting_is_list (@w{const config_setting_t * @var{setting}}) + +These convenience functions, which are implemented as macros, test if +the setting @var{setting} is of a given type. They return +@code{CONFIG_TRUE} or @code{CONFIG_FALSE}. + +@end deftypefun + +@deftypefun int config_setting_is_aggregate (@w{const config_setting_t * @var{setting}}) +@deftypefunx int config_setting_is_scalar (@w{const config_setting_t * @var{setting}}) +@deftypefunx int config_setting_is_number (@w{const config_setting_t * @var{setting}}) + +@cindex aggregate value +These convenience functions, which are implemented as macros, test if +the setting @var{setting} is of an aggregate type (a group, array, or +list), of a scalar type (integer, 64-bit integer, floating point, +boolean, or string), and of a number (integer, 64-bit integer, or +floating point), respectively. They return @code{CONFIG_TRUE} or +@code{CONFIG_FALSE}. + +@end deftypefun + +@deftypefun {const char *} config_setting_source_file (@w{const config_setting_t * @var{setting}}) + +This function returns the name of the file from which the setting +@var{setting} was read, or NULL if the setting was not read from a +file. This information is useful for reporting application-level +errors. Storage for the returned string is managed by the library and +released automatically when the configuration is destroyed; the +string must not be freed by the caller. + +@end deftypefun + +@deftypefun {unsigned int} config_setting_source_line (@w{const config_setting_t * @var{setting}}) + +This function returns the line number of the configuration file or +stream at which the setting @var{setting} was read, or 0 if no line +number is available. This information is useful for reporting +application-level errors. + +@end deftypefun + +@deftypefun void config_setting_set_hook (@w{config_setting_t * @var{setting}}, @w{void * @var{hook}}) +@deftypefunx {void *} config_setting_get_hook (@w{const config_setting_t * @var{setting}}) + +These functions make it possible to attach arbitrary data to each +setting structure, for instance a ``wrapper'' or ``peer'' object written in +another programming language. The destructor function, if one has been +supplied via a call to @code{config_set_destructor()}, will be called +by the library to dispose of this data when the setting itself is +destroyed. There is no default destructor. + +@end deftypefun + +@deftypefun void config_set_destructor (@w{config_t * @var{config}}, @w{void (* @var{destructor})(void *)}) + +This function assigns the destructor function @var{destructor} for the +configuration @var{config}. This function accepts a single @code{void +*} argument and has no return value. See +@code{config_setting_set_hook()} above for more information. + +@end deftypefun + +@node The C++ API, Example Programs, The C API, Top +@comment node-name, next, previous, up +@chapter The C++ API + +@tindex Config +@tindex Setting +This chapter describes the C++ library API. The class @code{Config} +represents a configuration, and the class @code{Setting} represents a +configuration setting. Note that by design, neither of these classes +provides a public copy constructor or assignment operator. Therefore, +instances of these classes may only be passed between functions via +references or pointers. + +@tindex ConfigException +The library defines a group of exceptions, all of which extend the +common base exception @code{ConfigException}. + +@tindex SettingTypeException +A @code{SettingTypeException} is thrown when the type of a setting's +value does not match the type requested. + +@tindex SettingNotFoundException +A @code{SettingNotFoundException} is thrown when a setting is not found. + +@tindex SettingNameException +A @code{SettingNameException} is thrown when an attempt is made to add +a new setting with a non-unique or invalid name. + +@tindex ParseException +A @code{ParseException} is thrown when a parse error occurs while +reading a configuration from a stream. + +@tindex FileIOException +A @code{FileIOException} is thrown when an I/O error occurs while +reading/writing a configuration from/to a file. + +@tindex SettingException +@code{SettingTypeException}, @code{SettingNotFoundException}, and +@code{SettingNameException} all extend the common base +exception @code{SettingException}, which provides the following method: + +@deftypemethod SettingException {const char *} getPath () + +Returns the path to the setting associated with the exception, or +@code{NULL} if there is no applicable path. + +@end deftypemethod + +The remainder of this chapter describes the methods for manipulating +configurations and configuration settings. + +@deftypemethod Config {} Config () +@deftypemethodx Config {} ~Config () + +These methods create and destroy @code{Config} objects. + +@end deftypemethod + +@deftypemethod Config void read (@w{FILE * @var{stream}}) +@deftypemethodx Config void write (@w{FILE * @var{stream}}) + +The @code{read()} method reads and parses a configuration from the given +@var{stream}. A @code{ParseException} is thrown if a parse error occurs. + +The @code{write()} method writes the configuration to the given @var{stream}. + +@end deftypemethod + +@deftypemethod Config void readFile (@w{const char * @var{filename}}) +@deftypemethodx Config void writeFile (@w{const char * @var{filename}}) + +The @code{readFile()} method reads and parses a configuration from the +file named @var{filename}. A @code{ParseException} is thrown if a +parse error occurs. A @code{FileIOException} is thrown if the file +cannot be read. + +The @code{writeFile()} method writes the configuration to the file +named @var{filename}. A @code{FileIOException} is thrown if the file cannot +be written. + +@end deftypemethod + +@deftypemethod Config void readString (@w{const char * @var{str}}) +@deftypemethodx Config void readString (@w{const std::string &@var{str}}) + +These methods read and parse a configuration from the string +@var{str}. A @code{ParseException} is thrown if a parse error occurs. + +@end deftypemethod + +@deftypemethod ParseException {const char *} getError () +@deftypemethodx ParseException {const char *} getFile () +@deftypemethodx ParseException int getLine () + +If a call to @code{readFile()}, @code{readString()}, or @code{read()} +resulted in a @code{ParseException}, these methods can be called on +the exception object to obtain the text, filename, and line number of +the parse error. Storage for the strings returned by @code{getError()} +and @code{getFile()} are managed by the library; the strings must not +be freed by the caller. + +@end deftypemethod + +@deftypemethod Config void setIncludeDir (@w{const char *@var{includeDir}}) +@deftypemethodx Config {const char *} getIncludeDir () + +@code{setIncludeDir()} specifies the include directory, +@var{includeDir}, relative to which the files specified in +@samp{@@include} directives will be located for the configuration. By +default, there is no include directory, and all include files are +expected to be relative to the current working directory. If +@var{includeDir} is @code{NULL}, the default behavior is reinstated. + +For example, if the include directory is set to @file{/usr/local/etc}, +the include directive @samp{@@include "configs/extra.cfg"} would include the +file @file{/usr/local/etc/configs/extra.cfg}. + +@code{getIncludeDir()} returns the current include directory for the +configuration, or @code{NULL} if none is set. + +@end deftypemethod + +@deftypemethod Config void setAutoConvert (bool @var{flag}) +@deftypemethodx Config bool getAutoConvert () + +@code{setAutoConvert()} enables number auto-conversion for the +configuration if @var{flag} is @code{true}, and disables it +otherwise. When this feature is enabled, an attempt to assign a +floating point setting to an integer (or vice versa), or +assign an integer to a floating point setting (or vice versa) will +cause the library to silently perform the necessary conversion +(possibly leading to loss of data), rather than throwing a +@code{SettingTypeException}. By default this feature is disabled. + +@code{getAutoConvert()} returns @code{true} if number auto-conversion +is currently enabled for the configuration; otherwise it returns +@code{false}. + +@end deftypemethod + +@deftypemethod Config void setDefaultFormat (@w{Setting::Format @var{format}}) +@deftypemethodx Config Setting::Format getDefaultFormat () + +These methods set and get the default external format for settings in +the configuration. If a non-default format has not been set for a +setting with @code{Setting::setFormat()}, this configuration-wide +default format will be used instead when that setting is written to a +file or stream. + +@end deftypemethod + +@deftypemethod Config void setTabWidth (@w{unsigned short @var{width}}) +@deftypemethodx Config {unsigned short} getTabWidth () + +These methods set and get the tab width for the configuration. The tab +width affects the formatting of the configuration when it is written +to a file or stream: each level of nesting is indented by @var{width} +spaces, or by a single tab character if @var{width} is 0. The tab +width has no effect on parsing. + +Valid tab widths range from 0 to 15. The default tab width is 2. + +@end deftypemethod + +@deftypemethod Config {Setting &} getRoot () + +This method returns the root setting for the configuration, which is a group. + +@end deftypemethod + +@deftypemethod Config {Setting &} lookup (@w{const std::string &@var{path}}) +@deftypemethodx Config {Setting &} lookup (@w{const char * @var{path}}) + +These methods locate the setting specified by the path @var{path}. If +the requested setting is not found, a @code{SettingNotFoundException} is +thrown. + +@end deftypemethod +@deftypemethod Config bool exists (@w{const std::string &@var{path}}) +@deftypemethodx Config bool exists (@w{const char *@var{path}}) + +These methods test if a setting with the given @var{path} exists in +the configuration. They return @code{true} if the setting exists, and +@code{false} otherwise. These methods do not throw exceptions. + +@end deftypemethod + +@deftypemethod Config bool lookupValue (@w{const char *@var{path}}, @w{bool &@var{value}}) +@deftypemethodx Config bool lookupValue (@w{const std::string &@var{path}}, @w{bool &@var{value}}) + +@deftypemethodx Config bool lookupValue (@w{const char *@var{path}}, @w{int &@var{value}}) +@deftypemethodx Config bool lookupValue (@w{const std::string &@var{path}}, @w{int &@var{value}}) + +@deftypemethodx Config bool lookupValue (@w{const char *@var{path}}, @w{unsigned int &@var{value}}) +@deftypemethodx Config bool lookupValue (@w{const std::string &@var{path}}, @w{unsigned int &@var{value}}) + +@deftypemethodx Config bool lookupValue (@w{const char *@var{path}}, @w{long long &@var{value}}) +@deftypemethodx Config bool lookupValue (@w{const std::string &@var{path}}, @w{long long &@var{value}}) + +@deftypemethodx Config bool lookupValue (@w{const char *@var{path}}, @w{float &@var{value}}) +@deftypemethodx Config bool lookupValue (@w{const std::string &@var{path}}, @w{float &@var{value}}) + +@deftypemethodx Config bool lookupValue (@w{const char *@var{path}}, @w{double &@var{value}}) +@deftypemethodx Config bool lookupValue (@w{const std::string &@var{path}}, @w{double &@var{value}}) + +@deftypemethodx Config bool lookupValue (@w{const char *@var{path}}, @w{const char *&@var{value}}) +@deftypemethodx Config bool lookupValue (@w{const std::string &@var{path}}, @w{const char *&@var{value}}) + +@deftypemethodx Config bool lookupValue (@w{const char *@var{path}}, @w{std::string &@var{value}}) +@deftypemethodx Config bool lookupValue (@w{const std::string &@var{path}}, @w{std::string &@var{value}}) + +These are convenience methods for looking up the value of a setting +with the given @var{path}. If the setting is found and is of an +appropriate type, the value is stored in @var{value} and the method +returns @code{true}. Otherwise, @var{value} is left unmodified and the +method returns @code{false}. These methods do not throw exceptions. + +Storage for @w{@i{const char *}} values is managed by the library and +released automatically when the setting is destroyed or when its value +is changed; the string must not be freed by the caller. For safety and +convenience, always assigning string values to a @code{std::string} is +suggested. + +Since these methods have boolean return values and do not throw +exceptions, they can be used within boolean logic expressions. The following +example presents a concise way to look up three values at once and +perform error handling if any of them are not found or are of the +wrong type: + +@sp 1 +@cartouche +@smallexample +int var1; +double var2; +const char *var3; + +if(config.lookupValue("values.var1", var1) + && config.lookupValue("values.var2", var2) + && config.lookupValue("values.var3", var3)) +@{ + // use var1, var2, var3 +@} +else +@{ + // error handling here +@} +@end smallexample +@end cartouche + +This approach also takes advantage of the short-circuit evaluation rules +of C++, e.g., if the first lookup fails (returning @code{false}), the +remaining lookups are skipped entirely. + +@end deftypemethod + +@deftypemethod Setting {} {operator bool ()} +@deftypemethodx Setting {} {operator int ()} +@deftypemethodx Setting {} {operator unsigned int ()} +@deftypemethodx Setting {} {operator long ()} +@deftypemethodx Setting {} {operator unsigned long ()} +@deftypemethodx Setting {} {operator long long ()} +@deftypemethodx Setting {} {operator unsigned long long ()} +@deftypemethodx Setting {} {operator float ()} +@deftypemethodx Setting {} {operator double ()} +@deftypemethodx Setting {} {operator const char * ()} +@deftypemethodx Setting {} {operator std::string ()} +@deftypemethodx Setting {const char *} c_str () + +These cast operators allow a @code{Setting} object to be assigned to a +variable of type @i{bool} if it is of type @code{TypeBoolean}; +@i{int}, @i{unsigned int}; @code{long long} or @code{unsigned long long} if +it is of type @code{TypeInt64}, @i{float} or @i{double} if it is of type +@code{TypeFloat}; or @w{@i{const char *}} or @i{std::string} if it is +of type @code{TypeString}. + +Values of type @code{TypeInt} or @code{TypeInt64} may be assigned to +variables of type @i{long}, or @i{unsigned long}, depending on the +sizes of those types on the host system. + +Storage for @w{@i{const char *}} return values is managed by the +library and released automatically when the setting is destroyed or +when its value is changed; the string must not be freed by the +caller. For safety and convenience, always assigning string return +values to a @code{std::string} is suggested. + +The following examples demonstrate this usage: + +@cartouche +@smallexample +long width = config.lookup("application.window.size.w"); + +bool splashScreen = config.lookup("application.splash_screen"); + +std::string title = config.lookup("application.window.title"); +@end smallexample +@end cartouche + +Note that certain conversions can lead to loss of precision or +clipping of values, e.g., assigning a negative value to an @i{unsigned +int} (in which case the value will be treated as 0), or a +double-precision value to a @i{float}. The library does not treat +these lossy conversions as errors. + +Perhaps surprisingly, the following code in particular will cause a +compiler error: + +@cartouche +@smallexample +std::string title; +. +. +. +title = config.lookup("application.window.title"); +@end smallexample +@end cartouche + +This is because the assignment operator of @code{std::string} is being +invoked with a @code{Setting &} as an argument. The compiler is unable +to make an implicit conversion because both the @code{const char *} +and the @code{std::string} cast operators of @code{Setting} are +equally appropriate. This is not a bug in @i{libconfig}; providing +only the @code{const char *} cast operator would resolve this +particular ambiguity, but would cause assignments to +@code{std::string} like the one in the previous example to produce a +compiler error. (To understand why, see section 11.4.1 of @i{The C++ +Programming Language}.) + +The solution to this problem is to use an explicit conversion that +avoids the construction of an intermediate @code{std::string} object, +as follows: + +@cartouche +@smallexample +std::string title; +. +. +. +title = (const char *)config.lookup("application.window.title"); +@end smallexample +@end cartouche + +Or, alternatively, use the @code{c_str()} method, which has the same effect: + +@cartouche +@smallexample +std::string title; +. +. +. +title = config.lookup("application.window.title").c_str(); +@end smallexample +@end cartouche + +If the assignment is invalid due to a type mismatch, a +@code{SettingTypeException} is thrown. + +@end deftypemethod + +@deftypemethod Setting {Setting &} operator= (@w{bool @var{value}}) +@deftypemethodx Setting {Setting &} operator= (@w{int @var{value}}) +@deftypemethodx Setting {Setting &} operator= (@w{long @var{value}}) +@deftypemethodx Setting {Setting &} operator= (@w{const long long &@var{value}}) +@deftypemethodx Setting {Setting &} operator= (@w{float @var{value}}) +@deftypemethodx Setting {Setting &} operator= (@w{const double &@var{value}}) +@deftypemethodx Setting {Setting &} operator= (@w{const char *@var{value}}) +@deftypemethodx Setting {Setting &} operator= (@w{const std::string &@var{value}}) + +These assignment operators allow values of type @i{bool}, @i{int}, +@i{long}, @i{long long}, @i{float}, @i{double}, @i{const char *}, and +@i{std::string} to be assigned to a setting. In the case of strings, +the library makes a copy of the passed string @var{value}, so it may +be subsequently freed or modified by the caller without affecting the +value of the setting. + +The following example code looks up a (presumably) integer setting +and changes its value: + +@cartouche +@smallexample +Setting &setting = config.lookup("application.window.size.w"); +setting = 1024; +@end smallexample +@end cartouche + +If the assignment is invalid due to a type mismatch, a +@code{SettingTypeException} is thrown. + +@end deftypemethod + +@deftypemethod Setting {Setting &} {operator[]} (@w{int @var{index}}) +@deftypemethodx Setting {Setting &} {operator[]} (@w{const std::string &@var{name}}) +@deftypemethodx Setting {Setting &} {operator[]} (@w{const char *@var{name}}) + +A @code{Setting} object may be subscripted with an integer index +@var{index} if it is an array or list, or with either a string +@var{name} or an integer index @var{index} if it is a group. For example, +the following code would produce the string @samp{Last Name} when +applied to the example configuration in @ref{Configuration Files}. + +@cartouche +@smallexample +Setting& setting = config.lookup("application.misc"); +const char *s = setting["columns"][0]; +@end smallexample +@end cartouche + +If the setting is not an array, list, or group, a +@code{SettingTypeException} is thrown. If the subscript (@var{index} +or @var{name}) does not refer to a valid element, a +@code{SettingNotFoundException} is thrown. + +Iterating over a group's child settings with an integer index will +return the settings in the same order that they appear in the +configuration. + +@end deftypemethod + +@deftypemethod Setting bool lookupValue (@w{const char *@var{name}}, @w{bool &@var{value}}) +@deftypemethodx Setting bool lookupValue (@w{const std::string &@var{name}}, @w{bool &@var{value}}) + +@deftypemethodx Setting bool lookupValue (@w{const char *@var{name}}, @w{int &@var{value}}) +@deftypemethodx Setting bool lookupValue (@w{const std::string &@var{name}}, @w{int &@var{value}}) + +@deftypemethodx Setting bool lookupValue (@w{const char *@var{name}}, @w{unsigned int &@var{value}}) +@deftypemethodx Setting bool lookupValue (@w{const std::string &@var{name}}, @w{unsigned int &@var{value}}) + +@deftypemethodx Setting bool lookupValue (@w{const char *@var{name}}, @w{long long &@var{value}}) +@deftypemethodx Setting bool lookupValue (@w{const std::string &@var{name}}, @w{long long &@var{value}}) + +@deftypemethodx Setting bool lookupValue (@w{const char *@var{name}}, @w{unsigned long long &@var{value}}) +@deftypemethodx Setting bool lookupValue (@w{const std::string &@var{name}}, @w{unsigned long long &@var{value}}) + +@deftypemethodx Setting bool lookupValue (@w{const char *@var{name}}, @w{float &@var{value}}) +@deftypemethodx Setting bool lookupValue (@w{const std::string &@var{name}}, @w{float &@var{value}}) + +@deftypemethodx Setting bool lookupValue (@w{const char *@var{name}}, @w{double &@var{value}}) +@deftypemethodx Setting bool lookupValue (@w{const std::string &@var{name}}, @w{double &@var{value}}) + +@deftypemethodx Setting bool lookupValue (@w{const char *@var{name}}, @w{const char *&@var{value}}) +@deftypemethodx Setting bool lookupValue (@w{const std::string &@var{name}}, @w{const char *&@var{value}}) + +@deftypemethodx Setting bool lookupValue (@w{const char *@var{name}}, @w{std::string &@var{value}}) +@deftypemethodx Setting bool lookupValue (@w{const std::string &@var{name}}, @w{std::string &@var{value}}) + +These are convenience methods for looking up the value of a child setting +with the given @var{name}. If the setting is found and is of an +appropriate type, the value is stored in @var{value} and the method +returns @code{true}. Otherwise, @var{value} is left unmodified and the +method returns @code{false}. These methods do not throw exceptions. + +Storage for @w{@i{const char *}} values is managed by the library and +released automatically when the setting is destroyed or when its value +is changed; the string must not be freed by the caller. For safety and +convenience, always assigning string values to a @code{std::string} is +suggested. + +Since these methods have boolean return values and do not throw +exceptions, they can be used within boolean logic expressions. The following +example presents a concise way to look up three values at once and +perform error handling if any of them are not found or are of the +wrong type: + +@sp 1 +@cartouche +@smallexample +int var1; +double var2; +const char *var3; + +if(setting.lookupValue("var1", var1) + && setting.lookupValue("var2", var2) + && setting.lookupValue("var3", var3)) +@{ + // use var1, var2, var3 +@} +else +@{ + // error handling here +@} +@end smallexample +@end cartouche + +This approach also takes advantage of the short-circuit evaluation +rules of C++, e.g., if the first lookup fails (returning @code{false}), the +remaining lookups are skipped entirely. + +@end deftypemethod + +@deftypemethod Setting {Setting &} add (@w{const std::string &@var{name}}, @w{Setting::Type @var{type}}) +@deftypemethodx Setting {Setting &} add (@w{const char *@var{name}}, @w{Setting::Type @var{type}}) + +These methods add a new child setting with the given @var{name} and +@var{type} to the setting, which must be a group. They return a +reference to the new setting. If the setting already has a child +setting with the given name, or if the name is invalid, a +@code{SettingNameException} is thrown. If the setting is not a group, +a @code{SettingTypeException} is thrown. + +Once a setting has been created, neither its name nor type can be +changed. + +@end deftypemethod + +@deftypemethod Setting {Setting &} add (@w{Setting::Type @var{type}}) + +This method adds a new element to the setting, which must be of type +@code{TypeArray} or @code{TypeList}. If the setting is an array which +currently has zero elements, the @var{type} parameter (which must be +@code{TypeInt}, @code{TypeInt64}, @code{TypeFloat}, @code{TypeBool}, +or @code{TypeString}) determines the type for the array; otherwise it +must match the type of the existing elements in the array. + +The method returns the new setting on success. If @var{type} is a +scalar type, the new setting will have a default value of 0, 0.0, +@code{false}, or @code{NULL}, as appropriate. + +The method throws a @code{SettingTypeException} if the setting is not +an array or list, or if @var{type} is invalid. + +@end deftypemethod + +@deftypemethod Setting void remove (@w{const std::string &@var{name}}) +@deftypemethodx Setting void remove (@w{const char *@var{name}}) + +These methods remove the child setting with the given @var{name} from +the setting, which must be a group. Any child settings of the removed +setting are recursively destroyed as well. + +If the setting is not a group, a @code{SettingTypeException} is +thrown. If the setting does not have a child setting with the given +name, a @code{SettingNotFoundException} is thrown. + +@end deftypemethod + +@deftypemethod Setting void remove (@w{unsigned int @var{index}}) + +This method removes the child setting at the given index @var{index} from +the setting, which must be a group, list, or array. Any child settings +of the removed setting are recursively destroyed as well. + +If the setting is not a group, list, or array, a +@code{SettingTypeException} is thrown. If @var{index} is out of range, +a @code{SettingNotFoundException} is thrown. + +@end deftypemethod + +@deftypemethod Setting {const char *} getName () + +This method returns the name of the setting, or @code{NULL} if the +setting has no name. Storage for the returned string is managed by the +library and released automatically when the setting is destroyed; the +string must not be freed by the caller. For safety and convenience, +consider assigning the return value to a @code{std::string}. + +@end deftypemethod + +@deftypemethod Setting {std::string} getPath () + +This method returns the complete dot-separated path to the +setting. Settings which do not have a name (list and array elements) +are represented by their index in square brackets. + +@end deftypemethod + +@deftypemethod Setting {Setting &} getParent () + +This method returns the parent setting of the setting. If the setting +is the root setting, a @code{SettingNotFoundException} is thrown. + +@end deftypemethod + +@deftypemethod Setting bool isRoot () + +This method returns @code{true} if the setting is the root setting, and +@code{false} otherwise. + +@end deftypemethod + +@deftypemethod Setting int getIndex () + +This method returns the index of the setting within its parent +setting. When applied to the root setting, this method returns -1. + +@end deftypemethod + +@deftypemethod Setting Setting::Type getType () + +@tindex Setting::Type +This method returns the type of the setting. The +@code{Setting::Type} enumeration consists of the following constants: +@code{TypeInt}, @code{TypeInt64}, @code{TypeFloat}, @code{TypeString}, +@code{TypeBoolean}, @code{TypeArray}, @code{TypeList}, and +@code{TypeGroup}. + +@end deftypemethod + +@deftypemethod Setting Setting::Format getFormat () +@deftypemethodx Setting void setFormat (@w{Setting::Format @var{format}}) + +These methods get and set the external format for the setting. + +@tindex Setting::Format +The @var{Setting::Format} enumeration consists of the following +constants: @code{FormatDefault} and @code{FormatHex}. All settings +support the @code{FormatDefault} format. The @code{FormatHex} format +specifies hexadecimal formatting for integer values, and hence only +applies to settings of type @code{TypeInt} and @code{TypeInt64}. If +@var{format} is invalid for the given setting, it is ignored. + +@end deftypemethod + +@deftypemethod Setting bool exists (@w{const std::string &@var{name}}) +@deftypemethodx Setting bool exists (@w{const char *@var{name}}) + +These methods test if the setting has a child setting with the given +@var{name}. They return @code{true} if the setting exists, and +@code{false} otherwise. These methods do not throw exceptions. + +@end deftypemethod + +@deftypemethod Setting int getLength () + +This method returns the number of settings in a group, or the number of +elements in a list or array. For other types of settings, it returns +0. + +@end deftypemethod + +@deftypemethod Setting bool isGroup () +@deftypemethodx Setting bool isArray () +@deftypemethodx Setting bool isList () + +These convenience methods test if a setting is of a given type. + +@end deftypemethod + +@deftypemethod Setting bool isAggregate () +@deftypemethodx Setting bool isScalar () +@deftypemethodx Setting bool isNumber () + +These convenience methods test if a setting is of an aggregate type (a +group, array, or list), of a scalar type (integer, 64-bit integer, +floating point, boolean, or string), and of a number (integer, 64-bit +integer, or floating point), respectively. + +@end deftypemethod + +@deftypemethod Setting {const char *} getSourceFile () + +This function returns the name of the file from which the setting was +read, or NULL if the setting was not read from a file. This +information is useful for reporting application-level errors. Storage +for the returned string is managed by the library and released +automatically when the configuration is destroyed; the string must +not be freed by the caller. + +@end deftypemethod + +@deftypemethod Setting {unsigned int} getSourceLine () + +This function returns the line number of the configuration file or +stream at which the setting @var{setting} was read, or 0 if no line +number is available. This information is useful for reporting +application-level errors. + +@end deftypemethod + +@node Example Programs, Configuration File Grammar, The C++ API, Top +@comment node-name, next, previous, up +@chapter Example Programs + +Practical example programs that illustrate how to use @i{libconfig} +from both C and C++ are included in the @file{examples} subdirectory +of the distribution. These examples include: + +@table @file + +@item examples/c/example1.c +An example C program that reads a configuration from an existing file +@file{example.cfg} (also located in @file{examples/c}) and displays +some of its contents. + +@item examples/c++/example1.cpp +The C++ equivalent of @file{example1.c}. + +@item examples/c/example2.c +An example C program that reads a configuration from an existing file +@file{example.cfg} (also located in @file{examples/c}), adds new +settings to the configuration, and writes the updated configuration to +another file. + +@item examples/c++/example2.cpp +The C++ equivalent of @file{example2.c} + +@item examples/c/example3.c +An example C program that constructs a new configuration in memory and writes it to a file. + +@item examples/c++/example3.cpp +The C++ equivalent of @file{example3.c} + +@end table + +@node Configuration File Grammar, License, Example Programs, Top +@comment node-name, next, previous, up +@chapter Configuration File Grammar + +Below is the BNF grammar for configuration files. Comments and include +directives are not part of the grammar, so they are not included here. + +@sp 1 +@example +configuration = setting-list | empty + +setting-list = setting | setting-list setting + +setting = name (":" | "=") value (";" | "," | empty) + +value = scalar-value | array | list | group + +value-list = value | value-list "," value + +scalar-value = boolean | integer | integer64 | hex | hex64 | float + | string + +scalar-value-list = scalar-value | scalar-value-list "," scalar-value + +array = "[" (scalar-value-list | empty) "]" + +list = "(" (value-list | empty) ")" + +group = "@{" (setting-list | empty) "@}" + +empty = +@end example + +@sp 2 +Terminals are defined below as regular expressions: +@sp 1 + +@multitable @columnfractions .2 .8 +@item @code{boolean} @tab +@code{([Tt][Rr][Uu][Ee])|([Ff][Aa][Ll][Ss][Ee])} +@item @code{string} @tab +@code{\"([^\"\\]|\\.)*\"} +@item @code{name} @tab +@code{[A-Za-z\*][-A-Za-z0-9_\*]*} +@item @code{integer} @tab +@code{[-+]?[0-9]+} +@item @code{integer64} @tab +@code{[-+]?[0-9]+L(L)?} +@item @code{hex} @tab +@code{0[Xx][0-9A-Fa-f]+} +@item @code{hex64} @tab +@code{0[Xx][0-9A-Fa-f]+L(L)?} +@item @code{float} @tab +@code{([-+]?([0-9]*)?\.[0-9]*([eE][-+]?[0-9]+)?)|([-+]([0-9]+)(\.[0-9]*)?[eE][-+]?[0-9]+)} +@end multitable + +@node License, Function Index, Configuration File Grammar, Top +@comment node-name, next, previous, up +@appendix License + +@include LGPL.texi + +@node Function Index, Type Index, License, Top +@comment node-name, next, previous, up +@unnumbered Function Index + +@printindex fn + +@node Type Index, Concept Index, Function Index, Top +@comment node-name, next, previous, up +@unnumbered Type Index + +@printindex tp + +@node Concept Index, , Type Index, Top +@comment node-name, next, previous, up +@unnumbered Concept Index + +@printindex cp + +@bye diff --git a/libconfig-1.4.9/examples/Makefile b/libconfig-1.4.9/examples/Makefile new file mode 100644 index 0000000000000000000000000000000000000000..23ee6cfcdfaaf3c4eafe451702fa93abc2fda1cd --- /dev/null +++ b/libconfig-1.4.9/examples/Makefile @@ -0,0 +1,569 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# examples/Makefile. Generated from Makefile.in by configure. + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + + + +pkgdatadir = $(datadir)/libconfig +pkgincludedir = $(includedir)/libconfig +pkglibdir = $(libdir)/libconfig +pkglibexecdir = $(libexecdir)/libconfig +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = x86_64-unknown-linux-gnu +host_triplet = x86_64-unknown-linux-gnu +target_triplet = x86_64-unknown-linux-gnu +#am__append_1 = c++ +subdir = examples +DIST_COMMON = $(srcdir)/Makefile.am $(srcdir)/Makefile.in +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = +CONFIG_CLEAN_VPATH_FILES = +SOURCES = +DIST_SOURCES = +RECURSIVE_TARGETS = all-recursive check-recursive dvi-recursive \ + html-recursive info-recursive install-data-recursive \ + install-dvi-recursive install-exec-recursive \ + install-html-recursive install-info-recursive \ + install-pdf-recursive install-ps-recursive install-recursive \ + installcheck-recursive installdirs-recursive pdf-recursive \ + ps-recursive uninstall-recursive +RECURSIVE_CLEAN_TARGETS = mostlyclean-recursive clean-recursive \ + distclean-recursive maintainer-clean-recursive +AM_RECURSIVE_TARGETS = $(RECURSIVE_TARGETS:-recursive=) \ + $(RECURSIVE_CLEAN_TARGETS:-recursive=) tags TAGS ctags CTAGS \ + distdir +ETAGS = etags +CTAGS = ctags +DIST_SUBDIRS = c c++ +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +am__relativize = \ + dir0=`pwd`; \ + sed_first='s,^\([^/]*\)/.*$$,\1,'; \ + sed_rest='s,^[^/]*/*,,'; \ + sed_last='s,^.*/\([^/]*\)$$,\1,'; \ + sed_butlast='s,/*[^/]*$$,,'; \ + while test -n "$$dir1"; do \ + first=`echo "$$dir1" | sed -e "$$sed_first"`; \ + if test "$$first" != "."; then \ + if test "$$first" = ".."; then \ + dir2=`echo "$$dir0" | sed -e "$$sed_last"`/"$$dir2"; \ + dir0=`echo "$$dir0" | sed -e "$$sed_butlast"`; \ + else \ + first2=`echo "$$dir2" | sed -e "$$sed_first"`; \ + if test "$$first2" = "$$first"; then \ + dir2=`echo "$$dir2" | sed -e "$$sed_rest"`; \ + else \ + dir2="../$$dir2"; \ + fi; \ + dir0="$$dir0"/"$$first"; \ + fi; \ + fi; \ + dir1=`echo "$$dir1" | sed -e "$$sed_rest"`; \ + done; \ + reldir="$$dir2" +ACLOCAL = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run aclocal-1.11 +AMTAR = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run tar +AR = ar +AS = as +AUTOCONF = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoconf +AUTOHEADER = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoheader +AUTOMAKE = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run automake-1.11 +AWK = gawk +CC = gcc +CCDEPMODE = depmode=gcc3 +CFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter +CPP = gcc -E +CPPFLAGS = +CXX = g++ +CXXCPP = g++ -E +CXXDEPMODE = depmode=gcc3 +CXXFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wno-unused-parameter +CYGPATH_W = echo +DEFS = -DHAVE_CONFIG_H +DEPDIR = .deps +DLLTOOL = false +DSYMUTIL = +DUMPBIN = +ECHO_C = +ECHO_N = -n +ECHO_T = +EGREP = /usr/bin/grep -E +EXEEXT = +FGREP = /usr/bin/grep -F +GREP = /usr/bin/grep +INSTALL = /usr/bin/install -c +INSTALL_DATA = ${INSTALL} -m 644 +INSTALL_PROGRAM = ${INSTALL} +INSTALL_SCRIPT = ${INSTALL} +INSTALL_STRIP_PROGRAM = $(install_sh) -c -s +LD = /usr/bin/ld -m elf_x86_64 +LDFLAGS = +LEX = flex +LEXLIB = +LEX_OUTPUT_ROOT = lex.yy +LIBOBJS = +LIBS = +LIBTOOL = $(SHELL) $(top_builddir)/libtool +LIPO = +LN_S = ln -s +LTLIBOBJS = +MAKEINFO = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run makeinfo +MANIFEST_TOOL = : +MKDIR_P = /usr/bin/mkdir -p +NM = /usr/bin/nm -B +NMEDIT = +OBJDUMP = objdump +OBJEXT = o +OTOOL = +OTOOL64 = +PACKAGE = libconfig +PACKAGE_BUGREPORT = hyperrealm@gmail.com +PACKAGE_NAME = libconfig +PACKAGE_STRING = libconfig 1.4.9 +PACKAGE_TARNAME = libconfig +PACKAGE_URL = http://www.hyperrealm.com/main.php?s=libconfig +PACKAGE_VERSION = 1.4.9 +PATH_SEPARATOR = : +RANLIB = ranlib +SED = /usr/bin/sed +SET_MAKE = +SHELL = /bin/sh +STRIP = strip +VERSION = 1.4.9 +YACC = bison -y +YFLAGS = +abs_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/examples +abs_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/examples +abs_top_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +abs_top_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +ac_ct_AR = ar +ac_ct_CC = gcc +ac_ct_CXX = g++ +ac_ct_DUMPBIN = +am__include = include +am__leading_dot = . +am__quote = +am__tar = ${AMTAR} chof - "$$tardir" +am__untar = ${AMTAR} xf - +bindir = ${exec_prefix}/bin +build = x86_64-unknown-linux-gnu +build_alias = +build_cpu = x86_64 +build_os = linux-gnu +build_vendor = unknown +builddir = . +datadir = ${datarootdir} +datarootdir = ${prefix}/share +docdir = ${datarootdir}/doc/${PACKAGE_TARNAME} +dvidir = ${docdir} +exec_prefix = ${prefix} +host = x86_64-unknown-linux-gnu +host_alias = +host_cpu = x86_64 +host_os = linux-gnu +host_vendor = unknown +htmldir = ${docdir} +includedir = ${prefix}/include +infodir = ${datarootdir}/info +install_sh = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/install-sh +libdir = ${exec_prefix}/lib +libexecdir = ${exec_prefix}/libexec +localedir = ${datarootdir}/locale +localstatedir = ${prefix}/var +mandir = ${datarootdir}/man +mkdir_p = /usr/bin/mkdir -p +oldincludedir = /usr/include +pdfdir = ${docdir} +prefix = /usr/local +program_transform_name = s,x,x, +psdir = ${docdir} +sbindir = ${exec_prefix}/sbin +sharedstatedir = ${prefix}/com +srcdir = . +sysconfdir = ${prefix}/etc +target = x86_64-unknown-linux-gnu +target_alias = +target_cpu = x86_64 +target_os = linux-gnu +target_vendor = unknown +top_build_prefix = ../ +top_builddir = .. +top_srcdir = .. +SUBDIRS = c $(am__append_1) +all: all-recursive + +.SUFFIXES: +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu examples/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu examples/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +# This directory's subdirectories are mostly independent; you can cd +# into them and run `make' without going through this Makefile. +# To change the values of `make' variables: instead of editing Makefiles, +# (1) if the variable is set in `config.status', edit `config.status' +# (which will cause the Makefiles to be regenerated when you run `make'); +# (2) otherwise, pass the desired values on the `make' command line. +$(RECURSIVE_TARGETS): + @fail= failcom='exit 1'; \ + for f in x $$MAKEFLAGS; do \ + case $$f in \ + *=* | --[!k]*);; \ + *k*) failcom='fail=yes';; \ + esac; \ + done; \ + dot_seen=no; \ + target=`echo $@ | sed s/-recursive//`; \ + list='$(SUBDIRS)'; for subdir in $$list; do \ + echo "Making $$target in $$subdir"; \ + if test "$$subdir" = "."; then \ + dot_seen=yes; \ + local_target="$$target-am"; \ + else \ + local_target="$$target"; \ + fi; \ + ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) $$local_target) \ + || eval $$failcom; \ + done; \ + if test "$$dot_seen" = "no"; then \ + $(MAKE) $(AM_MAKEFLAGS) "$$target-am" || exit 1; \ + fi; test -z "$$fail" + +$(RECURSIVE_CLEAN_TARGETS): + @fail= failcom='exit 1'; \ + for f in x $$MAKEFLAGS; do \ + case $$f in \ + *=* | --[!k]*);; \ + *k*) failcom='fail=yes';; \ + esac; \ + done; \ + dot_seen=no; \ + case "$@" in \ + distclean-* | maintainer-clean-*) list='$(DIST_SUBDIRS)' ;; \ + *) list='$(SUBDIRS)' ;; \ + esac; \ + rev=''; for subdir in $$list; do \ + if test "$$subdir" = "."; then :; else \ + rev="$$subdir $$rev"; \ + fi; \ + done; \ + rev="$$rev ."; \ + target=`echo $@ | sed s/-recursive//`; \ + for subdir in $$rev; do \ + echo "Making $$target in $$subdir"; \ + if test "$$subdir" = "."; then \ + local_target="$$target-am"; \ + else \ + local_target="$$target"; \ + fi; \ + ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) $$local_target) \ + || eval $$failcom; \ + done && test -z "$$fail" +tags-recursive: + list='$(SUBDIRS)'; for subdir in $$list; do \ + test "$$subdir" = . || ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) tags); \ + done +ctags-recursive: + list='$(SUBDIRS)'; for subdir in $$list; do \ + test "$$subdir" = . || ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) ctags); \ + done + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: tags-recursive $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + if ($(ETAGS) --etags-include --version) >/dev/null 2>&1; then \ + include_option=--etags-include; \ + empty_fix=.; \ + else \ + include_option=--include; \ + empty_fix=; \ + fi; \ + list='$(SUBDIRS)'; for subdir in $$list; do \ + if test "$$subdir" = .; then :; else \ + test ! -f $$subdir/TAGS || \ + set "$$@" "$$include_option=$$here/$$subdir/TAGS"; \ + fi; \ + done; \ + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: ctags-recursive $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done + @list='$(DIST_SUBDIRS)'; for subdir in $$list; do \ + if test "$$subdir" = .; then :; else \ + test -d "$(distdir)/$$subdir" \ + || $(MKDIR_P) "$(distdir)/$$subdir" \ + || exit 1; \ + fi; \ + done + @list='$(DIST_SUBDIRS)'; for subdir in $$list; do \ + if test "$$subdir" = .; then :; else \ + dir1=$$subdir; dir2="$(distdir)/$$subdir"; \ + $(am__relativize); \ + new_distdir=$$reldir; \ + dir1=$$subdir; dir2="$(top_distdir)"; \ + $(am__relativize); \ + new_top_distdir=$$reldir; \ + echo " (cd $$subdir && $(MAKE) $(AM_MAKEFLAGS) top_distdir="$$new_top_distdir" distdir="$$new_distdir" \\"; \ + echo " am__remove_distdir=: am__skip_length_check=: am__skip_mode_fix=: distdir)"; \ + ($(am__cd) $$subdir && \ + $(MAKE) $(AM_MAKEFLAGS) \ + top_distdir="$$new_top_distdir" \ + distdir="$$new_distdir" \ + am__remove_distdir=: \ + am__skip_length_check=: \ + am__skip_mode_fix=: \ + distdir) \ + || exit 1; \ + fi; \ + done +check-am: all-am +check: check-recursive +all-am: Makefile +installdirs: installdirs-recursive +installdirs-am: +install: install-recursive +install-exec: install-exec-recursive +install-data: install-data-recursive +uninstall: uninstall-recursive + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-recursive +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-recursive + +clean-am: clean-generic clean-libtool mostlyclean-am + +distclean: distclean-recursive + -rm -f Makefile +distclean-am: clean-am distclean-generic distclean-tags + +dvi: dvi-recursive + +dvi-am: + +html: html-recursive + +html-am: + +info: info-recursive + +info-am: + +install-data-am: + +install-dvi: install-dvi-recursive + +install-dvi-am: + +install-exec-am: + +install-html: install-html-recursive + +install-html-am: + +install-info: install-info-recursive + +install-info-am: + +install-man: + +install-pdf: install-pdf-recursive + +install-pdf-am: + +install-ps: install-ps-recursive + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-recursive + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-recursive + +mostlyclean-am: mostlyclean-generic mostlyclean-libtool + +pdf: pdf-recursive + +pdf-am: + +ps: ps-recursive + +ps-am: + +uninstall-am: + +.MAKE: $(RECURSIVE_CLEAN_TARGETS) $(RECURSIVE_TARGETS) ctags-recursive \ + install-am install-strip tags-recursive + +.PHONY: $(RECURSIVE_CLEAN_TARGETS) $(RECURSIVE_TARGETS) CTAGS GTAGS \ + all all-am check check-am clean clean-generic clean-libtool \ + ctags ctags-recursive distclean distclean-generic \ + distclean-libtool distclean-tags distdir dvi dvi-am html \ + html-am info info-am install install-am install-data \ + install-data-am install-dvi install-dvi-am install-exec \ + install-exec-am install-html install-html-am install-info \ + install-info-am install-man install-pdf install-pdf-am \ + install-ps install-ps-am install-strip installcheck \ + installcheck-am installdirs installdirs-am maintainer-clean \ + maintainer-clean-generic mostlyclean mostlyclean-generic \ + mostlyclean-libtool pdf pdf-am ps ps-am tags tags-recursive \ + uninstall uninstall-am + + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/examples/Makefile.am b/libconfig-1.4.9/examples/Makefile.am new file mode 100644 index 0000000000000000000000000000000000000000..e084bf0c6ebb40112a1225212caff7b9f61e0ad8 --- /dev/null +++ b/libconfig-1.4.9/examples/Makefile.am @@ -0,0 +1,6 @@ + +SUBDIRS = c + +if BUILDCXX +SUBDIRS += c++ +endif diff --git a/libconfig-1.4.9/examples/Makefile.in b/libconfig-1.4.9/examples/Makefile.in new file mode 100644 index 0000000000000000000000000000000000000000..0d30e54a5d940a330ddf1f4cb419e284d1d9d6e6 --- /dev/null +++ b/libconfig-1.4.9/examples/Makefile.in @@ -0,0 +1,569 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# @configure_input@ + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + +@SET_MAKE@ +VPATH = @srcdir@ +pkgdatadir = $(datadir)/@PACKAGE@ +pkgincludedir = $(includedir)/@PACKAGE@ +pkglibdir = $(libdir)/@PACKAGE@ +pkglibexecdir = $(libexecdir)/@PACKAGE@ +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = @build@ +host_triplet = @host@ +target_triplet = @target@ +@BUILDCXX_TRUE@am__append_1 = c++ +subdir = examples +DIST_COMMON = $(srcdir)/Makefile.am $(srcdir)/Makefile.in +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = +CONFIG_CLEAN_VPATH_FILES = +SOURCES = +DIST_SOURCES = +RECURSIVE_TARGETS = all-recursive check-recursive dvi-recursive \ + html-recursive info-recursive install-data-recursive \ + install-dvi-recursive install-exec-recursive \ + install-html-recursive install-info-recursive \ + install-pdf-recursive install-ps-recursive install-recursive \ + installcheck-recursive installdirs-recursive pdf-recursive \ + ps-recursive uninstall-recursive +RECURSIVE_CLEAN_TARGETS = mostlyclean-recursive clean-recursive \ + distclean-recursive maintainer-clean-recursive +AM_RECURSIVE_TARGETS = $(RECURSIVE_TARGETS:-recursive=) \ + $(RECURSIVE_CLEAN_TARGETS:-recursive=) tags TAGS ctags CTAGS \ + distdir +ETAGS = etags +CTAGS = ctags +DIST_SUBDIRS = c c++ +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +am__relativize = \ + dir0=`pwd`; \ + sed_first='s,^\([^/]*\)/.*$$,\1,'; \ + sed_rest='s,^[^/]*/*,,'; \ + sed_last='s,^.*/\([^/]*\)$$,\1,'; \ + sed_butlast='s,/*[^/]*$$,,'; \ + while test -n "$$dir1"; do \ + first=`echo "$$dir1" | sed -e "$$sed_first"`; \ + if test "$$first" != "."; then \ + if test "$$first" = ".."; then \ + dir2=`echo "$$dir0" | sed -e "$$sed_last"`/"$$dir2"; \ + dir0=`echo "$$dir0" | sed -e "$$sed_butlast"`; \ + else \ + first2=`echo "$$dir2" | sed -e "$$sed_first"`; \ + if test "$$first2" = "$$first"; then \ + dir2=`echo "$$dir2" | sed -e "$$sed_rest"`; \ + else \ + dir2="../$$dir2"; \ + fi; \ + dir0="$$dir0"/"$$first"; \ + fi; \ + fi; \ + dir1=`echo "$$dir1" | sed -e "$$sed_rest"`; \ + done; \ + reldir="$$dir2" +ACLOCAL = @ACLOCAL@ +AMTAR = @AMTAR@ +AR = @AR@ +AS = @AS@ +AUTOCONF = @AUTOCONF@ +AUTOHEADER = @AUTOHEADER@ +AUTOMAKE = @AUTOMAKE@ +AWK = @AWK@ +CC = @CC@ +CCDEPMODE = @CCDEPMODE@ +CFLAGS = @CFLAGS@ +CPP = @CPP@ +CPPFLAGS = @CPPFLAGS@ +CXX = @CXX@ +CXXCPP = @CXXCPP@ +CXXDEPMODE = @CXXDEPMODE@ +CXXFLAGS = @CXXFLAGS@ +CYGPATH_W = @CYGPATH_W@ +DEFS = @DEFS@ +DEPDIR = @DEPDIR@ +DLLTOOL = @DLLTOOL@ +DSYMUTIL = @DSYMUTIL@ +DUMPBIN = @DUMPBIN@ +ECHO_C = @ECHO_C@ +ECHO_N = @ECHO_N@ +ECHO_T = @ECHO_T@ +EGREP = @EGREP@ +EXEEXT = @EXEEXT@ +FGREP = @FGREP@ +GREP = @GREP@ +INSTALL = @INSTALL@ +INSTALL_DATA = @INSTALL_DATA@ +INSTALL_PROGRAM = @INSTALL_PROGRAM@ +INSTALL_SCRIPT = @INSTALL_SCRIPT@ +INSTALL_STRIP_PROGRAM = @INSTALL_STRIP_PROGRAM@ +LD = @LD@ +LDFLAGS = @LDFLAGS@ +LEX = @LEX@ +LEXLIB = @LEXLIB@ +LEX_OUTPUT_ROOT = @LEX_OUTPUT_ROOT@ +LIBOBJS = @LIBOBJS@ +LIBS = @LIBS@ +LIBTOOL = @LIBTOOL@ +LIPO = @LIPO@ +LN_S = @LN_S@ +LTLIBOBJS = @LTLIBOBJS@ +MAKEINFO = @MAKEINFO@ +MANIFEST_TOOL = @MANIFEST_TOOL@ +MKDIR_P = @MKDIR_P@ +NM = @NM@ +NMEDIT = @NMEDIT@ +OBJDUMP = @OBJDUMP@ +OBJEXT = @OBJEXT@ +OTOOL = @OTOOL@ +OTOOL64 = @OTOOL64@ +PACKAGE = @PACKAGE@ +PACKAGE_BUGREPORT = @PACKAGE_BUGREPORT@ +PACKAGE_NAME = @PACKAGE_NAME@ +PACKAGE_STRING = @PACKAGE_STRING@ +PACKAGE_TARNAME = @PACKAGE_TARNAME@ +PACKAGE_URL = @PACKAGE_URL@ +PACKAGE_VERSION = @PACKAGE_VERSION@ +PATH_SEPARATOR = @PATH_SEPARATOR@ +RANLIB = @RANLIB@ +SED = @SED@ +SET_MAKE = @SET_MAKE@ +SHELL = @SHELL@ +STRIP = @STRIP@ +VERSION = @VERSION@ +YACC = @YACC@ +YFLAGS = @YFLAGS@ +abs_builddir = @abs_builddir@ +abs_srcdir = @abs_srcdir@ +abs_top_builddir = @abs_top_builddir@ +abs_top_srcdir = @abs_top_srcdir@ +ac_ct_AR = @ac_ct_AR@ +ac_ct_CC = @ac_ct_CC@ +ac_ct_CXX = @ac_ct_CXX@ +ac_ct_DUMPBIN = @ac_ct_DUMPBIN@ +am__include = @am__include@ +am__leading_dot = @am__leading_dot@ +am__quote = @am__quote@ +am__tar = @am__tar@ +am__untar = @am__untar@ +bindir = @bindir@ +build = @build@ +build_alias = @build_alias@ +build_cpu = @build_cpu@ +build_os = @build_os@ +build_vendor = @build_vendor@ +builddir = @builddir@ +datadir = @datadir@ +datarootdir = @datarootdir@ +docdir = @docdir@ +dvidir = @dvidir@ +exec_prefix = @exec_prefix@ +host = @host@ +host_alias = @host_alias@ +host_cpu = @host_cpu@ +host_os = @host_os@ +host_vendor = @host_vendor@ +htmldir = @htmldir@ +includedir = @includedir@ +infodir = @infodir@ +install_sh = @install_sh@ +libdir = @libdir@ +libexecdir = @libexecdir@ +localedir = @localedir@ +localstatedir = @localstatedir@ +mandir = @mandir@ +mkdir_p = @mkdir_p@ +oldincludedir = @oldincludedir@ +pdfdir = @pdfdir@ +prefix = @prefix@ +program_transform_name = @program_transform_name@ +psdir = @psdir@ +sbindir = @sbindir@ +sharedstatedir = @sharedstatedir@ +srcdir = @srcdir@ +sysconfdir = @sysconfdir@ +target = @target@ +target_alias = @target_alias@ +target_cpu = @target_cpu@ +target_os = @target_os@ +target_vendor = @target_vendor@ +top_build_prefix = @top_build_prefix@ +top_builddir = @top_builddir@ +top_srcdir = @top_srcdir@ +SUBDIRS = c $(am__append_1) +all: all-recursive + +.SUFFIXES: +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu examples/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu examples/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +# This directory's subdirectories are mostly independent; you can cd +# into them and run `make' without going through this Makefile. +# To change the values of `make' variables: instead of editing Makefiles, +# (1) if the variable is set in `config.status', edit `config.status' +# (which will cause the Makefiles to be regenerated when you run `make'); +# (2) otherwise, pass the desired values on the `make' command line. +$(RECURSIVE_TARGETS): + @fail= failcom='exit 1'; \ + for f in x $$MAKEFLAGS; do \ + case $$f in \ + *=* | --[!k]*);; \ + *k*) failcom='fail=yes';; \ + esac; \ + done; \ + dot_seen=no; \ + target=`echo $@ | sed s/-recursive//`; \ + list='$(SUBDIRS)'; for subdir in $$list; do \ + echo "Making $$target in $$subdir"; \ + if test "$$subdir" = "."; then \ + dot_seen=yes; \ + local_target="$$target-am"; \ + else \ + local_target="$$target"; \ + fi; \ + ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) $$local_target) \ + || eval $$failcom; \ + done; \ + if test "$$dot_seen" = "no"; then \ + $(MAKE) $(AM_MAKEFLAGS) "$$target-am" || exit 1; \ + fi; test -z "$$fail" + +$(RECURSIVE_CLEAN_TARGETS): + @fail= failcom='exit 1'; \ + for f in x $$MAKEFLAGS; do \ + case $$f in \ + *=* | --[!k]*);; \ + *k*) failcom='fail=yes';; \ + esac; \ + done; \ + dot_seen=no; \ + case "$@" in \ + distclean-* | maintainer-clean-*) list='$(DIST_SUBDIRS)' ;; \ + *) list='$(SUBDIRS)' ;; \ + esac; \ + rev=''; for subdir in $$list; do \ + if test "$$subdir" = "."; then :; else \ + rev="$$subdir $$rev"; \ + fi; \ + done; \ + rev="$$rev ."; \ + target=`echo $@ | sed s/-recursive//`; \ + for subdir in $$rev; do \ + echo "Making $$target in $$subdir"; \ + if test "$$subdir" = "."; then \ + local_target="$$target-am"; \ + else \ + local_target="$$target"; \ + fi; \ + ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) $$local_target) \ + || eval $$failcom; \ + done && test -z "$$fail" +tags-recursive: + list='$(SUBDIRS)'; for subdir in $$list; do \ + test "$$subdir" = . || ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) tags); \ + done +ctags-recursive: + list='$(SUBDIRS)'; for subdir in $$list; do \ + test "$$subdir" = . || ($(am__cd) $$subdir && $(MAKE) $(AM_MAKEFLAGS) ctags); \ + done + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: tags-recursive $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + if ($(ETAGS) --etags-include --version) >/dev/null 2>&1; then \ + include_option=--etags-include; \ + empty_fix=.; \ + else \ + include_option=--include; \ + empty_fix=; \ + fi; \ + list='$(SUBDIRS)'; for subdir in $$list; do \ + if test "$$subdir" = .; then :; else \ + test ! -f $$subdir/TAGS || \ + set "$$@" "$$include_option=$$here/$$subdir/TAGS"; \ + fi; \ + done; \ + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: ctags-recursive $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done + @list='$(DIST_SUBDIRS)'; for subdir in $$list; do \ + if test "$$subdir" = .; then :; else \ + test -d "$(distdir)/$$subdir" \ + || $(MKDIR_P) "$(distdir)/$$subdir" \ + || exit 1; \ + fi; \ + done + @list='$(DIST_SUBDIRS)'; for subdir in $$list; do \ + if test "$$subdir" = .; then :; else \ + dir1=$$subdir; dir2="$(distdir)/$$subdir"; \ + $(am__relativize); \ + new_distdir=$$reldir; \ + dir1=$$subdir; dir2="$(top_distdir)"; \ + $(am__relativize); \ + new_top_distdir=$$reldir; \ + echo " (cd $$subdir && $(MAKE) $(AM_MAKEFLAGS) top_distdir="$$new_top_distdir" distdir="$$new_distdir" \\"; \ + echo " am__remove_distdir=: am__skip_length_check=: am__skip_mode_fix=: distdir)"; \ + ($(am__cd) $$subdir && \ + $(MAKE) $(AM_MAKEFLAGS) \ + top_distdir="$$new_top_distdir" \ + distdir="$$new_distdir" \ + am__remove_distdir=: \ + am__skip_length_check=: \ + am__skip_mode_fix=: \ + distdir) \ + || exit 1; \ + fi; \ + done +check-am: all-am +check: check-recursive +all-am: Makefile +installdirs: installdirs-recursive +installdirs-am: +install: install-recursive +install-exec: install-exec-recursive +install-data: install-data-recursive +uninstall: uninstall-recursive + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-recursive +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-recursive + +clean-am: clean-generic clean-libtool mostlyclean-am + +distclean: distclean-recursive + -rm -f Makefile +distclean-am: clean-am distclean-generic distclean-tags + +dvi: dvi-recursive + +dvi-am: + +html: html-recursive + +html-am: + +info: info-recursive + +info-am: + +install-data-am: + +install-dvi: install-dvi-recursive + +install-dvi-am: + +install-exec-am: + +install-html: install-html-recursive + +install-html-am: + +install-info: install-info-recursive + +install-info-am: + +install-man: + +install-pdf: install-pdf-recursive + +install-pdf-am: + +install-ps: install-ps-recursive + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-recursive + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-recursive + +mostlyclean-am: mostlyclean-generic mostlyclean-libtool + +pdf: pdf-recursive + +pdf-am: + +ps: ps-recursive + +ps-am: + +uninstall-am: + +.MAKE: $(RECURSIVE_CLEAN_TARGETS) $(RECURSIVE_TARGETS) ctags-recursive \ + install-am install-strip tags-recursive + +.PHONY: $(RECURSIVE_CLEAN_TARGETS) $(RECURSIVE_TARGETS) CTAGS GTAGS \ + all all-am check check-am clean clean-generic clean-libtool \ + ctags ctags-recursive distclean distclean-generic \ + distclean-libtool distclean-tags distdir dvi dvi-am html \ + html-am info info-am install install-am install-data \ + install-data-am install-dvi install-dvi-am install-exec \ + install-exec-am install-html install-html-am install-info \ + install-info-am install-man install-pdf install-pdf-am \ + install-ps install-ps-am install-strip installcheck \ + installcheck-am installdirs installdirs-am maintainer-clean \ + maintainer-clean-generic mostlyclean mostlyclean-generic \ + mostlyclean-libtool pdf pdf-am ps ps-am tags tags-recursive \ + uninstall uninstall-am + + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/examples/c++/.deps/example1.Po b/libconfig-1.4.9/examples/c++/.deps/example1.Po new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/examples/c++/.deps/example1.Po @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/examples/c++/.deps/example2.Po b/libconfig-1.4.9/examples/c++/.deps/example2.Po new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/examples/c++/.deps/example2.Po @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/examples/c++/.deps/example3.Po b/libconfig-1.4.9/examples/c++/.deps/example3.Po new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/examples/c++/.deps/example3.Po @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/examples/c++/.deps/example4.Po b/libconfig-1.4.9/examples/c++/.deps/example4.Po new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/examples/c++/.deps/example4.Po @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/examples/c++/Makefile b/libconfig-1.4.9/examples/c++/Makefile new file mode 100644 index 0000000000000000000000000000000000000000..20ab8011827210b74d064d20ae15a3a20fa2dcb7 --- /dev/null +++ b/libconfig-1.4.9/examples/c++/Makefile @@ -0,0 +1,519 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# examples/c++/Makefile. Generated from Makefile.in by configure. + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + + + + +pkgdatadir = $(datadir)/libconfig +pkgincludedir = $(includedir)/libconfig +pkglibdir = $(libdir)/libconfig +pkglibexecdir = $(libexecdir)/libconfig +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = x86_64-unknown-linux-gnu +host_triplet = x86_64-unknown-linux-gnu +target_triplet = x86_64-unknown-linux-gnu +noinst_PROGRAMS = example1$(EXEEXT) example2$(EXEEXT) \ + example3$(EXEEXT) example4$(EXEEXT) +subdir = examples/c++ +DIST_COMMON = $(srcdir)/Makefile.am $(srcdir)/Makefile.in +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = +CONFIG_CLEAN_VPATH_FILES = +PROGRAMS = $(noinst_PROGRAMS) +am_example1_OBJECTS = example1.$(OBJEXT) +example1_OBJECTS = $(am_example1_OBJECTS) +example1_LDADD = $(LDADD) +example1_DEPENDENCIES = $(top_builddir)/lib/libconfig++.la +am_example2_OBJECTS = example2.$(OBJEXT) +example2_OBJECTS = $(am_example2_OBJECTS) +example2_LDADD = $(LDADD) +example2_DEPENDENCIES = $(top_builddir)/lib/libconfig++.la +am_example3_OBJECTS = example3.$(OBJEXT) +example3_OBJECTS = $(am_example3_OBJECTS) +example3_LDADD = $(LDADD) +example3_DEPENDENCIES = $(top_builddir)/lib/libconfig++.la +am_example4_OBJECTS = example4.$(OBJEXT) +example4_OBJECTS = $(am_example4_OBJECTS) +example4_LDADD = $(LDADD) +example4_DEPENDENCIES = $(top_builddir)/lib/libconfig++.la +DEFAULT_INCLUDES = -I. -I$(top_builddir) +depcomp = $(SHELL) $(top_srcdir)/aux-build/depcomp +am__depfiles_maybe = depfiles +am__mv = mv -f +CXXCOMPILE = $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS) +LTCXXCOMPILE = $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS) +CXXLD = $(CXX) +CXXLINK = $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=link $(CXXLD) $(AM_CXXFLAGS) $(CXXFLAGS) $(AM_LDFLAGS) \ + $(LDFLAGS) -o $@ +SOURCES = $(example1_SOURCES) $(example2_SOURCES) $(example3_SOURCES) \ + $(example4_SOURCES) +DIST_SOURCES = $(example1_SOURCES) $(example2_SOURCES) \ + $(example3_SOURCES) $(example4_SOURCES) +ETAGS = etags +CTAGS = ctags +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +ACLOCAL = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run aclocal-1.11 +AMTAR = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run tar +AR = ar +AS = as +AUTOCONF = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoconf +AUTOHEADER = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoheader +AUTOMAKE = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run automake-1.11 +AWK = gawk +CC = gcc +CCDEPMODE = depmode=gcc3 +CFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter +CPP = gcc -E +CPPFLAGS = +CXX = g++ +CXXCPP = g++ -E +CXXDEPMODE = depmode=gcc3 +CXXFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wno-unused-parameter +CYGPATH_W = echo +DEFS = -DHAVE_CONFIG_H +DEPDIR = .deps +DLLTOOL = false +DSYMUTIL = +DUMPBIN = +ECHO_C = +ECHO_N = -n +ECHO_T = +EGREP = /usr/bin/grep -E +EXEEXT = +FGREP = /usr/bin/grep -F +GREP = /usr/bin/grep +INSTALL = /usr/bin/install -c +INSTALL_DATA = ${INSTALL} -m 644 +INSTALL_PROGRAM = ${INSTALL} +INSTALL_SCRIPT = ${INSTALL} +INSTALL_STRIP_PROGRAM = $(install_sh) -c -s +LD = /usr/bin/ld -m elf_x86_64 +LDFLAGS = +LEX = flex +LEXLIB = +LEX_OUTPUT_ROOT = lex.yy +LIBOBJS = +LIBS = +LIBTOOL = $(SHELL) $(top_builddir)/libtool +LIPO = +LN_S = ln -s +LTLIBOBJS = +MAKEINFO = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run makeinfo +MANIFEST_TOOL = : +MKDIR_P = /usr/bin/mkdir -p +NM = /usr/bin/nm -B +NMEDIT = +OBJDUMP = objdump +OBJEXT = o +OTOOL = +OTOOL64 = +PACKAGE = libconfig +PACKAGE_BUGREPORT = hyperrealm@gmail.com +PACKAGE_NAME = libconfig +PACKAGE_STRING = libconfig 1.4.9 +PACKAGE_TARNAME = libconfig +PACKAGE_URL = http://www.hyperrealm.com/main.php?s=libconfig +PACKAGE_VERSION = 1.4.9 +PATH_SEPARATOR = : +RANLIB = ranlib +SED = /usr/bin/sed +SET_MAKE = +SHELL = /bin/sh +STRIP = strip +VERSION = 1.4.9 +YACC = bison -y +YFLAGS = +abs_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/examples/c++ +abs_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/examples/c++ +abs_top_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +abs_top_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +ac_ct_AR = ar +ac_ct_CC = gcc +ac_ct_CXX = g++ +ac_ct_DUMPBIN = +am__include = include +am__leading_dot = . +am__quote = +am__tar = ${AMTAR} chof - "$$tardir" +am__untar = ${AMTAR} xf - +bindir = ${exec_prefix}/bin +build = x86_64-unknown-linux-gnu +build_alias = +build_cpu = x86_64 +build_os = linux-gnu +build_vendor = unknown +builddir = . +datadir = ${datarootdir} +datarootdir = ${prefix}/share +docdir = ${datarootdir}/doc/${PACKAGE_TARNAME} +dvidir = ${docdir} +exec_prefix = ${prefix} +host = x86_64-unknown-linux-gnu +host_alias = +host_cpu = x86_64 +host_os = linux-gnu +host_vendor = unknown +htmldir = ${docdir} +includedir = ${prefix}/include +infodir = ${datarootdir}/info +install_sh = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/install-sh +libdir = ${exec_prefix}/lib +libexecdir = ${exec_prefix}/libexec +localedir = ${datarootdir}/locale +localstatedir = ${prefix}/var +mandir = ${datarootdir}/man +mkdir_p = /usr/bin/mkdir -p +oldincludedir = /usr/include +pdfdir = ${docdir} +prefix = /usr/local +program_transform_name = s,x,x, +psdir = ${docdir} +sbindir = ${exec_prefix}/sbin +sharedstatedir = ${prefix}/com +srcdir = . +sysconfdir = ${prefix}/etc +target = x86_64-unknown-linux-gnu +target_alias = +target_cpu = x86_64 +target_os = linux-gnu +target_vendor = unknown +top_build_prefix = ../../ +top_builddir = ../.. +top_srcdir = ../.. +example1_SOURCES = example1.cpp +example2_SOURCES = example2.cpp +example3_SOURCES = example3.cpp +example4_SOURCES = example4.cpp +AM_CPPFLAGS = -I $(top_srcdir)/lib +LDADD = $(top_builddir)/lib/libconfig++.la +EXTRA_DIST = \ + example.cfg invalid.cfg \ + *.vcproj + +all: all-am + +.SUFFIXES: +.SUFFIXES: .cpp .lo .o .obj +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu examples/c++/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu examples/c++/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): + +clean-noinstPROGRAMS: + @list='$(noinst_PROGRAMS)'; test -n "$$list" || exit 0; \ + echo " rm -f" $$list; \ + rm -f $$list || exit $$?; \ + test -n "$(EXEEXT)" || exit 0; \ + list=`for p in $$list; do echo "$$p"; done | sed 's/$(EXEEXT)$$//'`; \ + echo " rm -f" $$list; \ + rm -f $$list +example1$(EXEEXT): $(example1_OBJECTS) $(example1_DEPENDENCIES) + @rm -f example1$(EXEEXT) + $(CXXLINK) $(example1_OBJECTS) $(example1_LDADD) $(LIBS) +example2$(EXEEXT): $(example2_OBJECTS) $(example2_DEPENDENCIES) + @rm -f example2$(EXEEXT) + $(CXXLINK) $(example2_OBJECTS) $(example2_LDADD) $(LIBS) +example3$(EXEEXT): $(example3_OBJECTS) $(example3_DEPENDENCIES) + @rm -f example3$(EXEEXT) + $(CXXLINK) $(example3_OBJECTS) $(example3_LDADD) $(LIBS) +example4$(EXEEXT): $(example4_OBJECTS) $(example4_DEPENDENCIES) + @rm -f example4$(EXEEXT) + $(CXXLINK) $(example4_OBJECTS) $(example4_LDADD) $(LIBS) + +mostlyclean-compile: + -rm -f *.$(OBJEXT) + +distclean-compile: + -rm -f *.tab.c + +include ./$(DEPDIR)/example1.Po +include ./$(DEPDIR)/example2.Po +include ./$(DEPDIR)/example3.Po +include ./$(DEPDIR)/example4.Po + +.cpp.o: + $(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +# source='$<' object='$@' libtool=no \ +# DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) \ +# $(CXXCOMPILE) -c -o $@ $< + +.cpp.obj: + $(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'` + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +# source='$<' object='$@' libtool=no \ +# DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) \ +# $(CXXCOMPILE) -c -o $@ `$(CYGPATH_W) '$<'` + +.cpp.lo: + $(LTCXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo +# source='$<' object='$@' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) \ +# $(LTCXXCOMPILE) -c -o $@ $< + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done +check-am: all-am +check: check-am +all-am: Makefile $(PROGRAMS) +installdirs: +install: install-am +install-exec: install-exec-am +install-data: install-data-am +uninstall: uninstall-am + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-am +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-am + +clean-am: clean-generic clean-libtool clean-noinstPROGRAMS \ + mostlyclean-am + +distclean: distclean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +distclean-am: clean-am distclean-compile distclean-generic \ + distclean-tags + +dvi: dvi-am + +dvi-am: + +html: html-am + +html-am: + +info: info-am + +info-am: + +install-data-am: + +install-dvi: install-dvi-am + +install-dvi-am: + +install-exec-am: + +install-html: install-html-am + +install-html-am: + +install-info: install-info-am + +install-info-am: + +install-man: + +install-pdf: install-pdf-am + +install-pdf-am: + +install-ps: install-ps-am + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-am + +mostlyclean-am: mostlyclean-compile mostlyclean-generic \ + mostlyclean-libtool + +pdf: pdf-am + +pdf-am: + +ps: ps-am + +ps-am: + +uninstall-am: + +.MAKE: install-am install-strip + +.PHONY: CTAGS GTAGS all all-am check check-am clean clean-generic \ + clean-libtool clean-noinstPROGRAMS ctags distclean \ + distclean-compile distclean-generic distclean-libtool \ + distclean-tags distdir dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-info install-info-am install-man \ + install-pdf install-pdf-am install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + maintainer-clean maintainer-clean-generic mostlyclean \ + mostlyclean-compile mostlyclean-generic mostlyclean-libtool \ + pdf pdf-am ps ps-am tags uninstall uninstall-am + + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/examples/c++/Makefile.am b/libconfig-1.4.9/examples/c++/Makefile.am new file mode 100644 index 0000000000000000000000000000000000000000..5e0ae0d3ee7d0e2289ec55edc2703fe0fabeb99d --- /dev/null +++ b/libconfig-1.4.9/examples/c++/Makefile.am @@ -0,0 +1,18 @@ + +noinst_PROGRAMS = example1 example2 example3 example4 + +example1_SOURCES = example1.cpp + +example2_SOURCES = example2.cpp + +example3_SOURCES = example3.cpp + +example4_SOURCES = example4.cpp + +AM_CPPFLAGS = -I $(top_srcdir)/lib + +LDADD = $(top_builddir)/lib/libconfig++.la + +EXTRA_DIST = \ + example.cfg invalid.cfg \ + *.vcproj diff --git a/libconfig-1.4.9/examples/c++/Makefile.in b/libconfig-1.4.9/examples/c++/Makefile.in new file mode 100644 index 0000000000000000000000000000000000000000..535b48bc85dbf280583065f0f12bbc8f94f8ece5 --- /dev/null +++ b/libconfig-1.4.9/examples/c++/Makefile.in @@ -0,0 +1,519 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# @configure_input@ + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + +@SET_MAKE@ + +VPATH = @srcdir@ +pkgdatadir = $(datadir)/@PACKAGE@ +pkgincludedir = $(includedir)/@PACKAGE@ +pkglibdir = $(libdir)/@PACKAGE@ +pkglibexecdir = $(libexecdir)/@PACKAGE@ +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = @build@ +host_triplet = @host@ +target_triplet = @target@ +noinst_PROGRAMS = example1$(EXEEXT) example2$(EXEEXT) \ + example3$(EXEEXT) example4$(EXEEXT) +subdir = examples/c++ +DIST_COMMON = $(srcdir)/Makefile.am $(srcdir)/Makefile.in +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = +CONFIG_CLEAN_VPATH_FILES = +PROGRAMS = $(noinst_PROGRAMS) +am_example1_OBJECTS = example1.$(OBJEXT) +example1_OBJECTS = $(am_example1_OBJECTS) +example1_LDADD = $(LDADD) +example1_DEPENDENCIES = $(top_builddir)/lib/libconfig++.la +am_example2_OBJECTS = example2.$(OBJEXT) +example2_OBJECTS = $(am_example2_OBJECTS) +example2_LDADD = $(LDADD) +example2_DEPENDENCIES = $(top_builddir)/lib/libconfig++.la +am_example3_OBJECTS = example3.$(OBJEXT) +example3_OBJECTS = $(am_example3_OBJECTS) +example3_LDADD = $(LDADD) +example3_DEPENDENCIES = $(top_builddir)/lib/libconfig++.la +am_example4_OBJECTS = example4.$(OBJEXT) +example4_OBJECTS = $(am_example4_OBJECTS) +example4_LDADD = $(LDADD) +example4_DEPENDENCIES = $(top_builddir)/lib/libconfig++.la +DEFAULT_INCLUDES = -I.@am__isrc@ -I$(top_builddir) +depcomp = $(SHELL) $(top_srcdir)/aux-build/depcomp +am__depfiles_maybe = depfiles +am__mv = mv -f +CXXCOMPILE = $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS) +LTCXXCOMPILE = $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS) +CXXLD = $(CXX) +CXXLINK = $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=link $(CXXLD) $(AM_CXXFLAGS) $(CXXFLAGS) $(AM_LDFLAGS) \ + $(LDFLAGS) -o $@ +SOURCES = $(example1_SOURCES) $(example2_SOURCES) $(example3_SOURCES) \ + $(example4_SOURCES) +DIST_SOURCES = $(example1_SOURCES) $(example2_SOURCES) \ + $(example3_SOURCES) $(example4_SOURCES) +ETAGS = etags +CTAGS = ctags +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +ACLOCAL = @ACLOCAL@ +AMTAR = @AMTAR@ +AR = @AR@ +AS = @AS@ +AUTOCONF = @AUTOCONF@ +AUTOHEADER = @AUTOHEADER@ +AUTOMAKE = @AUTOMAKE@ +AWK = @AWK@ +CC = @CC@ +CCDEPMODE = @CCDEPMODE@ +CFLAGS = @CFLAGS@ +CPP = @CPP@ +CPPFLAGS = @CPPFLAGS@ +CXX = @CXX@ +CXXCPP = @CXXCPP@ +CXXDEPMODE = @CXXDEPMODE@ +CXXFLAGS = @CXXFLAGS@ +CYGPATH_W = @CYGPATH_W@ +DEFS = @DEFS@ +DEPDIR = @DEPDIR@ +DLLTOOL = @DLLTOOL@ +DSYMUTIL = @DSYMUTIL@ +DUMPBIN = @DUMPBIN@ +ECHO_C = @ECHO_C@ +ECHO_N = @ECHO_N@ +ECHO_T = @ECHO_T@ +EGREP = @EGREP@ +EXEEXT = @EXEEXT@ +FGREP = @FGREP@ +GREP = @GREP@ +INSTALL = @INSTALL@ +INSTALL_DATA = @INSTALL_DATA@ +INSTALL_PROGRAM = @INSTALL_PROGRAM@ +INSTALL_SCRIPT = @INSTALL_SCRIPT@ +INSTALL_STRIP_PROGRAM = @INSTALL_STRIP_PROGRAM@ +LD = @LD@ +LDFLAGS = @LDFLAGS@ +LEX = @LEX@ +LEXLIB = @LEXLIB@ +LEX_OUTPUT_ROOT = @LEX_OUTPUT_ROOT@ +LIBOBJS = @LIBOBJS@ +LIBS = @LIBS@ +LIBTOOL = @LIBTOOL@ +LIPO = @LIPO@ +LN_S = @LN_S@ +LTLIBOBJS = @LTLIBOBJS@ +MAKEINFO = @MAKEINFO@ +MANIFEST_TOOL = @MANIFEST_TOOL@ +MKDIR_P = @MKDIR_P@ +NM = @NM@ +NMEDIT = @NMEDIT@ +OBJDUMP = @OBJDUMP@ +OBJEXT = @OBJEXT@ +OTOOL = @OTOOL@ +OTOOL64 = @OTOOL64@ +PACKAGE = @PACKAGE@ +PACKAGE_BUGREPORT = @PACKAGE_BUGREPORT@ +PACKAGE_NAME = @PACKAGE_NAME@ +PACKAGE_STRING = @PACKAGE_STRING@ +PACKAGE_TARNAME = @PACKAGE_TARNAME@ +PACKAGE_URL = @PACKAGE_URL@ +PACKAGE_VERSION = @PACKAGE_VERSION@ +PATH_SEPARATOR = @PATH_SEPARATOR@ +RANLIB = @RANLIB@ +SED = @SED@ +SET_MAKE = @SET_MAKE@ +SHELL = @SHELL@ +STRIP = @STRIP@ +VERSION = @VERSION@ +YACC = @YACC@ +YFLAGS = @YFLAGS@ +abs_builddir = @abs_builddir@ +abs_srcdir = @abs_srcdir@ +abs_top_builddir = @abs_top_builddir@ +abs_top_srcdir = @abs_top_srcdir@ +ac_ct_AR = @ac_ct_AR@ +ac_ct_CC = @ac_ct_CC@ +ac_ct_CXX = @ac_ct_CXX@ +ac_ct_DUMPBIN = @ac_ct_DUMPBIN@ +am__include = @am__include@ +am__leading_dot = @am__leading_dot@ +am__quote = @am__quote@ +am__tar = @am__tar@ +am__untar = @am__untar@ +bindir = @bindir@ +build = @build@ +build_alias = @build_alias@ +build_cpu = @build_cpu@ +build_os = @build_os@ +build_vendor = @build_vendor@ +builddir = @builddir@ +datadir = @datadir@ +datarootdir = @datarootdir@ +docdir = @docdir@ +dvidir = @dvidir@ +exec_prefix = @exec_prefix@ +host = @host@ +host_alias = @host_alias@ +host_cpu = @host_cpu@ +host_os = @host_os@ +host_vendor = @host_vendor@ +htmldir = @htmldir@ +includedir = @includedir@ +infodir = @infodir@ +install_sh = @install_sh@ +libdir = @libdir@ +libexecdir = @libexecdir@ +localedir = @localedir@ +localstatedir = @localstatedir@ +mandir = @mandir@ +mkdir_p = @mkdir_p@ +oldincludedir = @oldincludedir@ +pdfdir = @pdfdir@ +prefix = @prefix@ +program_transform_name = @program_transform_name@ +psdir = @psdir@ +sbindir = @sbindir@ +sharedstatedir = @sharedstatedir@ +srcdir = @srcdir@ +sysconfdir = @sysconfdir@ +target = @target@ +target_alias = @target_alias@ +target_cpu = @target_cpu@ +target_os = @target_os@ +target_vendor = @target_vendor@ +top_build_prefix = @top_build_prefix@ +top_builddir = @top_builddir@ +top_srcdir = @top_srcdir@ +example1_SOURCES = example1.cpp +example2_SOURCES = example2.cpp +example3_SOURCES = example3.cpp +example4_SOURCES = example4.cpp +AM_CPPFLAGS = -I $(top_srcdir)/lib +LDADD = $(top_builddir)/lib/libconfig++.la +EXTRA_DIST = \ + example.cfg invalid.cfg \ + *.vcproj + +all: all-am + +.SUFFIXES: +.SUFFIXES: .cpp .lo .o .obj +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu examples/c++/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu examples/c++/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): + +clean-noinstPROGRAMS: + @list='$(noinst_PROGRAMS)'; test -n "$$list" || exit 0; \ + echo " rm -f" $$list; \ + rm -f $$list || exit $$?; \ + test -n "$(EXEEXT)" || exit 0; \ + list=`for p in $$list; do echo "$$p"; done | sed 's/$(EXEEXT)$$//'`; \ + echo " rm -f" $$list; \ + rm -f $$list +example1$(EXEEXT): $(example1_OBJECTS) $(example1_DEPENDENCIES) + @rm -f example1$(EXEEXT) + $(CXXLINK) $(example1_OBJECTS) $(example1_LDADD) $(LIBS) +example2$(EXEEXT): $(example2_OBJECTS) $(example2_DEPENDENCIES) + @rm -f example2$(EXEEXT) + $(CXXLINK) $(example2_OBJECTS) $(example2_LDADD) $(LIBS) +example3$(EXEEXT): $(example3_OBJECTS) $(example3_DEPENDENCIES) + @rm -f example3$(EXEEXT) + $(CXXLINK) $(example3_OBJECTS) $(example3_LDADD) $(LIBS) +example4$(EXEEXT): $(example4_OBJECTS) $(example4_DEPENDENCIES) + @rm -f example4$(EXEEXT) + $(CXXLINK) $(example4_OBJECTS) $(example4_LDADD) $(LIBS) + +mostlyclean-compile: + -rm -f *.$(OBJEXT) + +distclean-compile: + -rm -f *.tab.c + +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/example1.Po@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/example2.Po@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/example3.Po@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/example4.Po@am__quote@ + +.cpp.o: +@am__fastdepCXX_TRUE@ $(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< +@am__fastdepCXX_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ source='$<' object='$@' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCXX_FALSE@ $(CXXCOMPILE) -c -o $@ $< + +.cpp.obj: +@am__fastdepCXX_TRUE@ $(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'` +@am__fastdepCXX_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ source='$<' object='$@' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCXX_FALSE@ $(CXXCOMPILE) -c -o $@ `$(CYGPATH_W) '$<'` + +.cpp.lo: +@am__fastdepCXX_TRUE@ $(LTCXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< +@am__fastdepCXX_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ source='$<' object='$@' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCXX_FALSE@ $(LTCXXCOMPILE) -c -o $@ $< + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done +check-am: all-am +check: check-am +all-am: Makefile $(PROGRAMS) +installdirs: +install: install-am +install-exec: install-exec-am +install-data: install-data-am +uninstall: uninstall-am + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-am +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-am + +clean-am: clean-generic clean-libtool clean-noinstPROGRAMS \ + mostlyclean-am + +distclean: distclean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +distclean-am: clean-am distclean-compile distclean-generic \ + distclean-tags + +dvi: dvi-am + +dvi-am: + +html: html-am + +html-am: + +info: info-am + +info-am: + +install-data-am: + +install-dvi: install-dvi-am + +install-dvi-am: + +install-exec-am: + +install-html: install-html-am + +install-html-am: + +install-info: install-info-am + +install-info-am: + +install-man: + +install-pdf: install-pdf-am + +install-pdf-am: + +install-ps: install-ps-am + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-am + +mostlyclean-am: mostlyclean-compile mostlyclean-generic \ + mostlyclean-libtool + +pdf: pdf-am + +pdf-am: + +ps: ps-am + +ps-am: + +uninstall-am: + +.MAKE: install-am install-strip + +.PHONY: CTAGS GTAGS all all-am check check-am clean clean-generic \ + clean-libtool clean-noinstPROGRAMS ctags distclean \ + distclean-compile distclean-generic distclean-libtool \ + distclean-tags distdir dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-info install-info-am install-man \ + install-pdf install-pdf-am install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + maintainer-clean maintainer-clean-generic mostlyclean \ + mostlyclean-compile mostlyclean-generic mostlyclean-libtool \ + pdf pdf-am ps ps-am tags uninstall uninstall-am + + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/examples/c++/cxx_example1.vcproj b/libconfig-1.4.9/examples/c++/cxx_example1.vcproj new file mode 100644 index 0000000000000000000000000000000000000000..0a9207fcdc82749b49be80d5a4b93c078f06e6fb --- /dev/null +++ b/libconfig-1.4.9/examples/c++/cxx_example1.vcproj @@ -0,0 +1,185 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/libconfig-1.4.9/examples/c++/cxx_example2.vcproj b/libconfig-1.4.9/examples/c++/cxx_example2.vcproj new file mode 100644 index 0000000000000000000000000000000000000000..9b0f7fc4c3b0aa6fca4b6fb804f9bc161b9d5831 --- /dev/null +++ b/libconfig-1.4.9/examples/c++/cxx_example2.vcproj @@ -0,0 +1,185 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/libconfig-1.4.9/examples/c++/cxx_example3.vcproj b/libconfig-1.4.9/examples/c++/cxx_example3.vcproj new file mode 100644 index 0000000000000000000000000000000000000000..8c85b98e9273fc0ec4ee122732391e230739135c --- /dev/null +++ b/libconfig-1.4.9/examples/c++/cxx_example3.vcproj @@ -0,0 +1,185 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/libconfig-1.4.9/examples/c++/cxx_example4.vcproj b/libconfig-1.4.9/examples/c++/cxx_example4.vcproj new file mode 100644 index 0000000000000000000000000000000000000000..ad452ae14c65ee8ca23c278ecb8d6d94c9e557e9 --- /dev/null +++ b/libconfig-1.4.9/examples/c++/cxx_example4.vcproj @@ -0,0 +1,181 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/libconfig-1.4.9/examples/c++/example.cfg b/libconfig-1.4.9/examples/c++/example.cfg new file mode 100644 index 0000000000000000000000000000000000000000..8f11dc6751f37c85ffb28e9977d234dd761ec1cc --- /dev/null +++ b/libconfig-1.4.9/examples/c++/example.cfg @@ -0,0 +1,46 @@ +// An example configuration file that stores information about a store. + +// Basic store information: +name = "Books, Movies & More"; + +// Store inventory: +inventory = +{ + books = ( { title = "Treasure Island"; + author = "Robert Louis Stevenson"; + price = 29.99; + qty = 5; }, + { title = "Snow Crash"; + author = "Neal Stephenson"; + price = 9.99; + qty = 8; } + ); + + movies = ( { title = "Brazil"; + media = "DVD"; + price = 19.99; + qty = 11; }, + { title = "The City of Lost Children"; + media = "DVD"; + price = 18.99; + qty = 5; }, + { title = "Memento"; + media = "Blu-Ray"; + price = 24.99; + qty = 20; + }, + { title = "Howard the Duck"; } + ); +}; + +// Store hours: +hours = +{ + mon = { open = 9; close = 18; }; + tue = { open = 9; close = 18; }; + wed = { open = 9; close = 18; }; + thu = { open = 9; close = 18; }; + fri = { open = 9; close = 20; }; + sat = { open = 9; close = 20; }; + sun = { open = 11; close = 16; }; +}; diff --git a/libconfig-1.4.9/examples/c++/example1.cpp b/libconfig-1.4.9/examples/c++/example1.cpp new file mode 100644 index 0000000000000000000000000000000000000000..1fb5ff634e4dfe19ba8e347e9b0f1b096a71f598 --- /dev/null +++ b/libconfig-1.4.9/examples/c++/example1.cpp @@ -0,0 +1,151 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include +#include +#include +#include + +using namespace std; +using namespace libconfig; + +// This example reads the configuration file 'example.cfg' and displays +// some of its contents. + +int main(int argc, char **argv) +{ + Config cfg; + + // Read the file. If there is an error, report it and exit. + try + { + cfg.readFile("example.cfg"); + } + catch(const FileIOException &fioex) + { + std::cerr << "I/O error while reading file." << std::endl; + return(EXIT_FAILURE); + } + catch(const ParseException &pex) + { + std::cerr << "Parse error at " << pex.getFile() << ":" << pex.getLine() + << " - " << pex.getError() << std::endl; + return(EXIT_FAILURE); + } + + // Get the store name. + try + { + string name = cfg.lookup("name"); + cout << "Store name: " << name << endl << endl; + } + catch(const SettingNotFoundException &nfex) + { + cerr << "No 'name' setting in configuration file." << endl; + } + + const Setting& root = cfg.getRoot(); + + // Output a list of all books in the inventory. + try + { + const Setting &books = root["inventory"]["books"]; + int count = books.getLength(); + + cout << setw(30) << left << "TITLE" << " " + << setw(30) << left << "AUTHOR" << " " + << setw(6) << left << "PRICE" << " " + << "QTY" + << endl; + + for(int i = 0; i < count; ++i) + { + const Setting &book = books[i]; + + // Only output the record if all of the expected fields are present. + string title, author; + double price; + int qty; + + if(!(book.lookupValue("title", title) + && book.lookupValue("author", author) + && book.lookupValue("price", price) + && book.lookupValue("qty", qty))) + continue; + + cout << setw(30) << left << title << " " + << setw(30) << left << author << " " + << '$' << setw(6) << right << price << " " + << qty + << endl; + } + cout << endl; + } + catch(const SettingNotFoundException &nfex) + { + // Ignore. + } + + // Output a list of all books in the inventory. + try + { + const Setting &movies = root["inventory"]["movies"]; + int count = movies.getLength(); + + cout << setw(30) << left << "TITLE" << " " + << setw(10) << left << "MEDIA" << " " + << setw(6) << left << "PRICE" << " " + << "QTY" + << endl; + + for(int i = 0; i < count; ++i) + { + const Setting &movie = movies[i]; + + // Only output the record if all of the expected fields are present. + string title, media; + double price; + int qty; + + if(!(movie.lookupValue("title", title) + && movie.lookupValue("media", media) + && movie.lookupValue("price", price) + && movie.lookupValue("qty", qty))) + continue; + + cout << setw(30) << left << title << " " + << setw(10) << left << media << " " + << '$' << setw(6) << right << price << " " + << qty + << endl; + } + cout << endl; + } + catch(const SettingNotFoundException &nfex) + { + // Ignore. + } + + return(EXIT_SUCCESS); +} + +// eof diff --git a/libconfig-1.4.9/examples/c++/example2.cpp b/libconfig-1.4.9/examples/c++/example2.cpp new file mode 100644 index 0000000000000000000000000000000000000000..d0af0e874d529bb6d0823eecc7d4ec42f0838452 --- /dev/null +++ b/libconfig-1.4.9/examples/c++/example2.cpp @@ -0,0 +1,97 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include +#include +#include +#include + +using namespace std; +using namespace libconfig; + +// This example reads the configuration file 'example.cfg', adds a new +// movie record to the movies list, and writes the updated configuration to +// 'updated.cfg'. + +int main(int argc, char **argv) +{ + static const char *output_file = "updated.cfg"; + + Config cfg; + + // Read the file. If there is an error, report it and exit. + try + { + cfg.readFile("example.cfg"); + } + catch(const FileIOException &fioex) + { + std::cerr << "I/O error while reading file." << std::endl; + return(EXIT_FAILURE); + } + catch(const ParseException &pex) + { + std::cerr << "Parse error at " << pex.getFile() << ":" << pex.getLine() + << " - " << pex.getError() << std::endl; + return(EXIT_FAILURE); + } + + // Find the 'movies' setting. Add intermediate settings if they don't yet + // exist. + Setting &root = cfg.getRoot(); + + if(! root.exists("inventory")) + root.add("inventory", Setting::TypeGroup); + + Setting &inventory = root["inventory"]; + + if(! inventory.exists("movies")) + inventory.add("movies", Setting::TypeList); + + Setting &movies = inventory["movies"]; + + // Create the new movie entry. + Setting &movie = movies.add(Setting::TypeGroup); + + movie.add("title", Setting::TypeString) = "Buckaroo Banzai"; + movie.add("media", Setting::TypeString) = "DVD"; + movie.add("price", Setting::TypeFloat) = 12.99; + movie.add("qty", Setting::TypeInt) = 20; + + // Write out the updated configuration. + try + { + cfg.writeFile(output_file); + cerr << "Updated configuration successfully written to: " << output_file + << endl; + + } + catch(const FileIOException &fioex) + { + cerr << "I/O error while writing file: " << output_file << endl; + return(EXIT_FAILURE); + } + + return(EXIT_SUCCESS); +} + +// eof diff --git a/libconfig-1.4.9/examples/c++/example3.cpp b/libconfig-1.4.9/examples/c++/example3.cpp new file mode 100644 index 0000000000000000000000000000000000000000..da5caf52d0176d26f4c1958d50514176a2bac6a6 --- /dev/null +++ b/libconfig-1.4.9/examples/c++/example3.cpp @@ -0,0 +1,71 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include +#include +#include +#include + +using namespace std; +using namespace libconfig; + +// This example constructs a new configuration in memory and writes it to +// 'newconfig.cfg'. + +int main(int argc, char **argv) +{ + static const char *output_file = "newconfig.cfg"; + Config cfg; + + Setting &root = cfg.getRoot(); + + // Add some settings to the configuration. + Setting &address = root.add("address", Setting::TypeGroup); + + address.add("street", Setting::TypeString) = "1 Woz Way"; + address.add("city", Setting::TypeString) = "San Jose"; + address.add("state", Setting::TypeString) = "CA"; + address.add("zip", Setting::TypeInt) = 95110; + + Setting &array = root.add("array", Setting::TypeArray); + + for(int i = 0; i < 10; ++i) + array.add(Setting::TypeInt) = 10 * i; + + // Write out the new configuration. + try + { + cfg.writeFile(output_file); + cerr << "New configuration successfully written to: " << output_file + << endl; + + } + catch(const FileIOException &fioex) + { + cerr << "I/O error while writing file: " << output_file << endl; + return(EXIT_FAILURE); + } + + return(EXIT_SUCCESS); +} + +// eof diff --git a/libconfig-1.4.9/examples/c++/example4.cpp b/libconfig-1.4.9/examples/c++/example4.cpp new file mode 100644 index 0000000000000000000000000000000000000000..b23f4c5b8f617c1c3464a267d430a5696acec2a6 --- /dev/null +++ b/libconfig-1.4.9/examples/c++/example4.cpp @@ -0,0 +1,57 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include +#include +#include +#include + +using namespace std; +using namespace libconfig; + +// This example demonstrates the handling of parsing errors in +// 'invalid.cfg'. + +int main(int argc, char **argv) +{ + Config cfg; + + try + { + cfg.readFile("invalid.cfg"); + } + catch(const FileIOException &fioex) + { + std::cerr << "File I/O error" << std::endl; + return(EXIT_FAILURE); + } + catch(const ParseException &pex) + { + std::cerr << "Parse error at " << pex.getFile() << ":" << pex.getLine() + << " - " << pex.getError() << std::endl; + return(EXIT_FAILURE); + } + + return(EXIT_SUCCESS); +} + +// eof diff --git a/libconfig-1.4.9/examples/c++/invalid.cfg b/libconfig-1.4.9/examples/c++/invalid.cfg new file mode 100644 index 0000000000000000000000000000000000000000..764b44df9a1711c6ab9ede855a6e5c8ba9f69ad1 --- /dev/null +++ b/libconfig-1.4.9/examples/c++/invalid.cfg @@ -0,0 +1,8 @@ +// An example configuration file with an invalid @include. + + +pi = 3.141592654; + +@include "missing.cfg" + +e = 2.718281828; diff --git a/libconfig-1.4.9/examples/c/.deps/example1.Po b/libconfig-1.4.9/examples/c/.deps/example1.Po new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/examples/c/.deps/example1.Po @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/examples/c/.deps/example2.Po b/libconfig-1.4.9/examples/c/.deps/example2.Po new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/examples/c/.deps/example2.Po @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/examples/c/.deps/example3.Po b/libconfig-1.4.9/examples/c/.deps/example3.Po new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/examples/c/.deps/example3.Po @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/examples/c/Makefile b/libconfig-1.4.9/examples/c/Makefile new file mode 100644 index 0000000000000000000000000000000000000000..a2ccdcdad8dad20cdb4fcd808045a0d6209bcce9 --- /dev/null +++ b/libconfig-1.4.9/examples/c/Makefile @@ -0,0 +1,509 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# examples/c/Makefile. Generated from Makefile.in by configure. + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + + + + +pkgdatadir = $(datadir)/libconfig +pkgincludedir = $(includedir)/libconfig +pkglibdir = $(libdir)/libconfig +pkglibexecdir = $(libexecdir)/libconfig +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = x86_64-unknown-linux-gnu +host_triplet = x86_64-unknown-linux-gnu +target_triplet = x86_64-unknown-linux-gnu +noinst_PROGRAMS = example1$(EXEEXT) example2$(EXEEXT) \ + example3$(EXEEXT) +subdir = examples/c +DIST_COMMON = $(srcdir)/Makefile.am $(srcdir)/Makefile.in +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = +CONFIG_CLEAN_VPATH_FILES = +PROGRAMS = $(noinst_PROGRAMS) +am_example1_OBJECTS = example1.$(OBJEXT) +example1_OBJECTS = $(am_example1_OBJECTS) +example1_LDADD = $(LDADD) +example1_DEPENDENCIES = $(top_builddir)/lib/libconfig.la +am_example2_OBJECTS = example2.$(OBJEXT) +example2_OBJECTS = $(am_example2_OBJECTS) +example2_LDADD = $(LDADD) +example2_DEPENDENCIES = $(top_builddir)/lib/libconfig.la +am_example3_OBJECTS = example3.$(OBJEXT) +example3_OBJECTS = $(am_example3_OBJECTS) +example3_LDADD = $(LDADD) +example3_DEPENDENCIES = $(top_builddir)/lib/libconfig.la +DEFAULT_INCLUDES = -I. -I$(top_builddir) +depcomp = $(SHELL) $(top_srcdir)/aux-build/depcomp +am__depfiles_maybe = depfiles +am__mv = mv -f +COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +LTCOMPILE = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +CCLD = $(CC) +LINK = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) $(AM_LDFLAGS) \ + $(LDFLAGS) -o $@ +SOURCES = $(example1_SOURCES) $(example2_SOURCES) $(example3_SOURCES) +DIST_SOURCES = $(example1_SOURCES) $(example2_SOURCES) \ + $(example3_SOURCES) +ETAGS = etags +CTAGS = ctags +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +ACLOCAL = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run aclocal-1.11 +AMTAR = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run tar +AR = ar +AS = as +AUTOCONF = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoconf +AUTOHEADER = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoheader +AUTOMAKE = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run automake-1.11 +AWK = gawk +CC = gcc +CCDEPMODE = depmode=gcc3 +CFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter +CPP = gcc -E +CPPFLAGS = +CXX = g++ +CXXCPP = g++ -E +CXXDEPMODE = depmode=gcc3 +CXXFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wno-unused-parameter +CYGPATH_W = echo +DEFS = -DHAVE_CONFIG_H +DEPDIR = .deps +DLLTOOL = false +DSYMUTIL = +DUMPBIN = +ECHO_C = +ECHO_N = -n +ECHO_T = +EGREP = /usr/bin/grep -E +EXEEXT = +FGREP = /usr/bin/grep -F +GREP = /usr/bin/grep +INSTALL = /usr/bin/install -c +INSTALL_DATA = ${INSTALL} -m 644 +INSTALL_PROGRAM = ${INSTALL} +INSTALL_SCRIPT = ${INSTALL} +INSTALL_STRIP_PROGRAM = $(install_sh) -c -s +LD = /usr/bin/ld -m elf_x86_64 +LDFLAGS = +LEX = flex +LEXLIB = +LEX_OUTPUT_ROOT = lex.yy +LIBOBJS = +LIBS = +LIBTOOL = $(SHELL) $(top_builddir)/libtool +LIPO = +LN_S = ln -s +LTLIBOBJS = +MAKEINFO = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run makeinfo +MANIFEST_TOOL = : +MKDIR_P = /usr/bin/mkdir -p +NM = /usr/bin/nm -B +NMEDIT = +OBJDUMP = objdump +OBJEXT = o +OTOOL = +OTOOL64 = +PACKAGE = libconfig +PACKAGE_BUGREPORT = hyperrealm@gmail.com +PACKAGE_NAME = libconfig +PACKAGE_STRING = libconfig 1.4.9 +PACKAGE_TARNAME = libconfig +PACKAGE_URL = http://www.hyperrealm.com/main.php?s=libconfig +PACKAGE_VERSION = 1.4.9 +PATH_SEPARATOR = : +RANLIB = ranlib +SED = /usr/bin/sed +SET_MAKE = +SHELL = /bin/sh +STRIP = strip +VERSION = 1.4.9 +YACC = bison -y +YFLAGS = +abs_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/examples/c +abs_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/examples/c +abs_top_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +abs_top_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +ac_ct_AR = ar +ac_ct_CC = gcc +ac_ct_CXX = g++ +ac_ct_DUMPBIN = +am__include = include +am__leading_dot = . +am__quote = +am__tar = ${AMTAR} chof - "$$tardir" +am__untar = ${AMTAR} xf - +bindir = ${exec_prefix}/bin +build = x86_64-unknown-linux-gnu +build_alias = +build_cpu = x86_64 +build_os = linux-gnu +build_vendor = unknown +builddir = . +datadir = ${datarootdir} +datarootdir = ${prefix}/share +docdir = ${datarootdir}/doc/${PACKAGE_TARNAME} +dvidir = ${docdir} +exec_prefix = ${prefix} +host = x86_64-unknown-linux-gnu +host_alias = +host_cpu = x86_64 +host_os = linux-gnu +host_vendor = unknown +htmldir = ${docdir} +includedir = ${prefix}/include +infodir = ${datarootdir}/info +install_sh = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/install-sh +libdir = ${exec_prefix}/lib +libexecdir = ${exec_prefix}/libexec +localedir = ${datarootdir}/locale +localstatedir = ${prefix}/var +mandir = ${datarootdir}/man +mkdir_p = /usr/bin/mkdir -p +oldincludedir = /usr/include +pdfdir = ${docdir} +prefix = /usr/local +program_transform_name = s,x,x, +psdir = ${docdir} +sbindir = ${exec_prefix}/sbin +sharedstatedir = ${prefix}/com +srcdir = . +sysconfdir = ${prefix}/etc +target = x86_64-unknown-linux-gnu +target_alias = +target_cpu = x86_64 +target_os = linux-gnu +target_vendor = unknown +top_build_prefix = ../../ +top_builddir = ../.. +top_srcdir = ../.. +example1_SOURCES = example1.c +example2_SOURCES = example2.c +example3_SOURCES = example3.c +AM_CPPFLAGS = -I $(top_srcdir)/lib +LDADD = $(top_builddir)/lib/libconfig.la +EXTRA_DIST = \ + example.cfg \ + *.vcproj + +all: all-am + +.SUFFIXES: +.SUFFIXES: .c .lo .o .obj +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu examples/c/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu examples/c/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): + +clean-noinstPROGRAMS: + @list='$(noinst_PROGRAMS)'; test -n "$$list" || exit 0; \ + echo " rm -f" $$list; \ + rm -f $$list || exit $$?; \ + test -n "$(EXEEXT)" || exit 0; \ + list=`for p in $$list; do echo "$$p"; done | sed 's/$(EXEEXT)$$//'`; \ + echo " rm -f" $$list; \ + rm -f $$list +example1$(EXEEXT): $(example1_OBJECTS) $(example1_DEPENDENCIES) + @rm -f example1$(EXEEXT) + $(LINK) $(example1_OBJECTS) $(example1_LDADD) $(LIBS) +example2$(EXEEXT): $(example2_OBJECTS) $(example2_DEPENDENCIES) + @rm -f example2$(EXEEXT) + $(LINK) $(example2_OBJECTS) $(example2_LDADD) $(LIBS) +example3$(EXEEXT): $(example3_OBJECTS) $(example3_DEPENDENCIES) + @rm -f example3$(EXEEXT) + $(LINK) $(example3_OBJECTS) $(example3_LDADD) $(LIBS) + +mostlyclean-compile: + -rm -f *.$(OBJEXT) + +distclean-compile: + -rm -f *.tab.c + +include ./$(DEPDIR)/example1.Po +include ./$(DEPDIR)/example2.Po +include ./$(DEPDIR)/example3.Po + +.c.o: + $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +# source='$<' object='$@' libtool=no \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(COMPILE) -c $< + +.c.obj: + $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'` + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +# source='$<' object='$@' libtool=no \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(COMPILE) -c `$(CYGPATH_W) '$<'` + +.c.lo: + $(LTCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo +# source='$<' object='$@' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LTCOMPILE) -c -o $@ $< + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done +check-am: all-am +check: check-am +all-am: Makefile $(PROGRAMS) +installdirs: +install: install-am +install-exec: install-exec-am +install-data: install-data-am +uninstall: uninstall-am + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-am +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-am + +clean-am: clean-generic clean-libtool clean-noinstPROGRAMS \ + mostlyclean-am + +distclean: distclean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +distclean-am: clean-am distclean-compile distclean-generic \ + distclean-tags + +dvi: dvi-am + +dvi-am: + +html: html-am + +html-am: + +info: info-am + +info-am: + +install-data-am: + +install-dvi: install-dvi-am + +install-dvi-am: + +install-exec-am: + +install-html: install-html-am + +install-html-am: + +install-info: install-info-am + +install-info-am: + +install-man: + +install-pdf: install-pdf-am + +install-pdf-am: + +install-ps: install-ps-am + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-am + +mostlyclean-am: mostlyclean-compile mostlyclean-generic \ + mostlyclean-libtool + +pdf: pdf-am + +pdf-am: + +ps: ps-am + +ps-am: + +uninstall-am: + +.MAKE: install-am install-strip + +.PHONY: CTAGS GTAGS all all-am check check-am clean clean-generic \ + clean-libtool clean-noinstPROGRAMS ctags distclean \ + distclean-compile distclean-generic distclean-libtool \ + distclean-tags distdir dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-info install-info-am install-man \ + install-pdf install-pdf-am install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + maintainer-clean maintainer-clean-generic mostlyclean \ + mostlyclean-compile mostlyclean-generic mostlyclean-libtool \ + pdf pdf-am ps ps-am tags uninstall uninstall-am + + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/examples/c/Makefile.am b/libconfig-1.4.9/examples/c/Makefile.am new file mode 100644 index 0000000000000000000000000000000000000000..abbcdae0b4372877f928e385e43923871babd537 --- /dev/null +++ b/libconfig-1.4.9/examples/c/Makefile.am @@ -0,0 +1,16 @@ + +noinst_PROGRAMS = example1 example2 example3 + +example1_SOURCES = example1.c + +example2_SOURCES = example2.c + +example3_SOURCES = example3.c + +AM_CPPFLAGS = -I $(top_srcdir)/lib + +LDADD = $(top_builddir)/lib/libconfig.la + +EXTRA_DIST = \ + example.cfg \ + *.vcproj diff --git a/libconfig-1.4.9/examples/c/Makefile.in b/libconfig-1.4.9/examples/c/Makefile.in new file mode 100644 index 0000000000000000000000000000000000000000..b036d61f8d7d66a9cb7a84b28aa85548e5ba1b08 --- /dev/null +++ b/libconfig-1.4.9/examples/c/Makefile.in @@ -0,0 +1,509 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# @configure_input@ + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + +@SET_MAKE@ + +VPATH = @srcdir@ +pkgdatadir = $(datadir)/@PACKAGE@ +pkgincludedir = $(includedir)/@PACKAGE@ +pkglibdir = $(libdir)/@PACKAGE@ +pkglibexecdir = $(libexecdir)/@PACKAGE@ +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = @build@ +host_triplet = @host@ +target_triplet = @target@ +noinst_PROGRAMS = example1$(EXEEXT) example2$(EXEEXT) \ + example3$(EXEEXT) +subdir = examples/c +DIST_COMMON = $(srcdir)/Makefile.am $(srcdir)/Makefile.in +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = +CONFIG_CLEAN_VPATH_FILES = +PROGRAMS = $(noinst_PROGRAMS) +am_example1_OBJECTS = example1.$(OBJEXT) +example1_OBJECTS = $(am_example1_OBJECTS) +example1_LDADD = $(LDADD) +example1_DEPENDENCIES = $(top_builddir)/lib/libconfig.la +am_example2_OBJECTS = example2.$(OBJEXT) +example2_OBJECTS = $(am_example2_OBJECTS) +example2_LDADD = $(LDADD) +example2_DEPENDENCIES = $(top_builddir)/lib/libconfig.la +am_example3_OBJECTS = example3.$(OBJEXT) +example3_OBJECTS = $(am_example3_OBJECTS) +example3_LDADD = $(LDADD) +example3_DEPENDENCIES = $(top_builddir)/lib/libconfig.la +DEFAULT_INCLUDES = -I.@am__isrc@ -I$(top_builddir) +depcomp = $(SHELL) $(top_srcdir)/aux-build/depcomp +am__depfiles_maybe = depfiles +am__mv = mv -f +COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +LTCOMPILE = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +CCLD = $(CC) +LINK = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) $(AM_LDFLAGS) \ + $(LDFLAGS) -o $@ +SOURCES = $(example1_SOURCES) $(example2_SOURCES) $(example3_SOURCES) +DIST_SOURCES = $(example1_SOURCES) $(example2_SOURCES) \ + $(example3_SOURCES) +ETAGS = etags +CTAGS = ctags +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +ACLOCAL = @ACLOCAL@ +AMTAR = @AMTAR@ +AR = @AR@ +AS = @AS@ +AUTOCONF = @AUTOCONF@ +AUTOHEADER = @AUTOHEADER@ +AUTOMAKE = @AUTOMAKE@ +AWK = @AWK@ +CC = @CC@ +CCDEPMODE = @CCDEPMODE@ +CFLAGS = @CFLAGS@ +CPP = @CPP@ +CPPFLAGS = @CPPFLAGS@ +CXX = @CXX@ +CXXCPP = @CXXCPP@ +CXXDEPMODE = @CXXDEPMODE@ +CXXFLAGS = @CXXFLAGS@ +CYGPATH_W = @CYGPATH_W@ +DEFS = @DEFS@ +DEPDIR = @DEPDIR@ +DLLTOOL = @DLLTOOL@ +DSYMUTIL = @DSYMUTIL@ +DUMPBIN = @DUMPBIN@ +ECHO_C = @ECHO_C@ +ECHO_N = @ECHO_N@ +ECHO_T = @ECHO_T@ +EGREP = @EGREP@ +EXEEXT = @EXEEXT@ +FGREP = @FGREP@ +GREP = @GREP@ +INSTALL = @INSTALL@ +INSTALL_DATA = @INSTALL_DATA@ +INSTALL_PROGRAM = @INSTALL_PROGRAM@ +INSTALL_SCRIPT = @INSTALL_SCRIPT@ +INSTALL_STRIP_PROGRAM = @INSTALL_STRIP_PROGRAM@ +LD = @LD@ +LDFLAGS = @LDFLAGS@ +LEX = @LEX@ +LEXLIB = @LEXLIB@ +LEX_OUTPUT_ROOT = @LEX_OUTPUT_ROOT@ +LIBOBJS = @LIBOBJS@ +LIBS = @LIBS@ +LIBTOOL = @LIBTOOL@ +LIPO = @LIPO@ +LN_S = @LN_S@ +LTLIBOBJS = @LTLIBOBJS@ +MAKEINFO = @MAKEINFO@ +MANIFEST_TOOL = @MANIFEST_TOOL@ +MKDIR_P = @MKDIR_P@ +NM = @NM@ +NMEDIT = @NMEDIT@ +OBJDUMP = @OBJDUMP@ +OBJEXT = @OBJEXT@ +OTOOL = @OTOOL@ +OTOOL64 = @OTOOL64@ +PACKAGE = @PACKAGE@ +PACKAGE_BUGREPORT = @PACKAGE_BUGREPORT@ +PACKAGE_NAME = @PACKAGE_NAME@ +PACKAGE_STRING = @PACKAGE_STRING@ +PACKAGE_TARNAME = @PACKAGE_TARNAME@ +PACKAGE_URL = @PACKAGE_URL@ +PACKAGE_VERSION = @PACKAGE_VERSION@ +PATH_SEPARATOR = @PATH_SEPARATOR@ +RANLIB = @RANLIB@ +SED = @SED@ +SET_MAKE = @SET_MAKE@ +SHELL = @SHELL@ +STRIP = @STRIP@ +VERSION = @VERSION@ +YACC = @YACC@ +YFLAGS = @YFLAGS@ +abs_builddir = @abs_builddir@ +abs_srcdir = @abs_srcdir@ +abs_top_builddir = @abs_top_builddir@ +abs_top_srcdir = @abs_top_srcdir@ +ac_ct_AR = @ac_ct_AR@ +ac_ct_CC = @ac_ct_CC@ +ac_ct_CXX = @ac_ct_CXX@ +ac_ct_DUMPBIN = @ac_ct_DUMPBIN@ +am__include = @am__include@ +am__leading_dot = @am__leading_dot@ +am__quote = @am__quote@ +am__tar = @am__tar@ +am__untar = @am__untar@ +bindir = @bindir@ +build = @build@ +build_alias = @build_alias@ +build_cpu = @build_cpu@ +build_os = @build_os@ +build_vendor = @build_vendor@ +builddir = @builddir@ +datadir = @datadir@ +datarootdir = @datarootdir@ +docdir = @docdir@ +dvidir = @dvidir@ +exec_prefix = @exec_prefix@ +host = @host@ +host_alias = @host_alias@ +host_cpu = @host_cpu@ +host_os = @host_os@ +host_vendor = @host_vendor@ +htmldir = @htmldir@ +includedir = @includedir@ +infodir = @infodir@ +install_sh = @install_sh@ +libdir = @libdir@ +libexecdir = @libexecdir@ +localedir = @localedir@ +localstatedir = @localstatedir@ +mandir = @mandir@ +mkdir_p = @mkdir_p@ +oldincludedir = @oldincludedir@ +pdfdir = @pdfdir@ +prefix = @prefix@ +program_transform_name = @program_transform_name@ +psdir = @psdir@ +sbindir = @sbindir@ +sharedstatedir = @sharedstatedir@ +srcdir = @srcdir@ +sysconfdir = @sysconfdir@ +target = @target@ +target_alias = @target_alias@ +target_cpu = @target_cpu@ +target_os = @target_os@ +target_vendor = @target_vendor@ +top_build_prefix = @top_build_prefix@ +top_builddir = @top_builddir@ +top_srcdir = @top_srcdir@ +example1_SOURCES = example1.c +example2_SOURCES = example2.c +example3_SOURCES = example3.c +AM_CPPFLAGS = -I $(top_srcdir)/lib +LDADD = $(top_builddir)/lib/libconfig.la +EXTRA_DIST = \ + example.cfg \ + *.vcproj + +all: all-am + +.SUFFIXES: +.SUFFIXES: .c .lo .o .obj +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu examples/c/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu examples/c/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): + +clean-noinstPROGRAMS: + @list='$(noinst_PROGRAMS)'; test -n "$$list" || exit 0; \ + echo " rm -f" $$list; \ + rm -f $$list || exit $$?; \ + test -n "$(EXEEXT)" || exit 0; \ + list=`for p in $$list; do echo "$$p"; done | sed 's/$(EXEEXT)$$//'`; \ + echo " rm -f" $$list; \ + rm -f $$list +example1$(EXEEXT): $(example1_OBJECTS) $(example1_DEPENDENCIES) + @rm -f example1$(EXEEXT) + $(LINK) $(example1_OBJECTS) $(example1_LDADD) $(LIBS) +example2$(EXEEXT): $(example2_OBJECTS) $(example2_DEPENDENCIES) + @rm -f example2$(EXEEXT) + $(LINK) $(example2_OBJECTS) $(example2_LDADD) $(LIBS) +example3$(EXEEXT): $(example3_OBJECTS) $(example3_DEPENDENCIES) + @rm -f example3$(EXEEXT) + $(LINK) $(example3_OBJECTS) $(example3_LDADD) $(LIBS) + +mostlyclean-compile: + -rm -f *.$(OBJEXT) + +distclean-compile: + -rm -f *.tab.c + +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/example1.Po@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/example2.Po@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/example3.Po@am__quote@ + +.c.o: +@am__fastdepCC_TRUE@ $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='$<' object='$@' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(COMPILE) -c $< + +.c.obj: +@am__fastdepCC_TRUE@ $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'` +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='$<' object='$@' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(COMPILE) -c `$(CYGPATH_W) '$<'` + +.c.lo: +@am__fastdepCC_TRUE@ $(LTCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='$<' object='$@' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LTCOMPILE) -c -o $@ $< + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done +check-am: all-am +check: check-am +all-am: Makefile $(PROGRAMS) +installdirs: +install: install-am +install-exec: install-exec-am +install-data: install-data-am +uninstall: uninstall-am + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-am +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-am + +clean-am: clean-generic clean-libtool clean-noinstPROGRAMS \ + mostlyclean-am + +distclean: distclean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +distclean-am: clean-am distclean-compile distclean-generic \ + distclean-tags + +dvi: dvi-am + +dvi-am: + +html: html-am + +html-am: + +info: info-am + +info-am: + +install-data-am: + +install-dvi: install-dvi-am + +install-dvi-am: + +install-exec-am: + +install-html: install-html-am + +install-html-am: + +install-info: install-info-am + +install-info-am: + +install-man: + +install-pdf: install-pdf-am + +install-pdf-am: + +install-ps: install-ps-am + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-am + +mostlyclean-am: mostlyclean-compile mostlyclean-generic \ + mostlyclean-libtool + +pdf: pdf-am + +pdf-am: + +ps: ps-am + +ps-am: + +uninstall-am: + +.MAKE: install-am install-strip + +.PHONY: CTAGS GTAGS all all-am check check-am clean clean-generic \ + clean-libtool clean-noinstPROGRAMS ctags distclean \ + distclean-compile distclean-generic distclean-libtool \ + distclean-tags distdir dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-info install-info-am install-man \ + install-pdf install-pdf-am install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + maintainer-clean maintainer-clean-generic mostlyclean \ + mostlyclean-compile mostlyclean-generic mostlyclean-libtool \ + pdf pdf-am ps ps-am tags uninstall uninstall-am + + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/examples/c/example.cfg b/libconfig-1.4.9/examples/c/example.cfg new file mode 100644 index 0000000000000000000000000000000000000000..8f11dc6751f37c85ffb28e9977d234dd761ec1cc --- /dev/null +++ b/libconfig-1.4.9/examples/c/example.cfg @@ -0,0 +1,46 @@ +// An example configuration file that stores information about a store. + +// Basic store information: +name = "Books, Movies & More"; + +// Store inventory: +inventory = +{ + books = ( { title = "Treasure Island"; + author = "Robert Louis Stevenson"; + price = 29.99; + qty = 5; }, + { title = "Snow Crash"; + author = "Neal Stephenson"; + price = 9.99; + qty = 8; } + ); + + movies = ( { title = "Brazil"; + media = "DVD"; + price = 19.99; + qty = 11; }, + { title = "The City of Lost Children"; + media = "DVD"; + price = 18.99; + qty = 5; }, + { title = "Memento"; + media = "Blu-Ray"; + price = 24.99; + qty = 20; + }, + { title = "Howard the Duck"; } + ); +}; + +// Store hours: +hours = +{ + mon = { open = 9; close = 18; }; + tue = { open = 9; close = 18; }; + wed = { open = 9; close = 18; }; + thu = { open = 9; close = 18; }; + fri = { open = 9; close = 20; }; + sat = { open = 9; close = 20; }; + sun = { open = 11; close = 16; }; +}; diff --git a/libconfig-1.4.9/examples/c/example1.c b/libconfig-1.4.9/examples/c/example1.c new file mode 100644 index 0000000000000000000000000000000000000000..5c776a82088642196e19c58c82d4a04f5d37ed2e --- /dev/null +++ b/libconfig-1.4.9/examples/c/example1.c @@ -0,0 +1,115 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include +#include +#include + +/* This example reads the configuration file 'example.cfg' and displays + * some of its contents. + */ + +int main(int argc, char **argv) +{ + config_t cfg; + config_setting_t *setting; + const char *str; + + config_init(&cfg); + + /* Read the file. If there is an error, report it and exit. */ + if(! config_read_file(&cfg, "example.cfg")) + { + fprintf(stderr, "%s:%d - %s\n", config_error_file(&cfg), + config_error_line(&cfg), config_error_text(&cfg)); + config_destroy(&cfg); + return(EXIT_FAILURE); + } + + /* Get the store name. */ + if(config_lookup_string(&cfg, "name", &str)) + printf("Store name: %s\n\n", str); + else + fprintf(stderr, "No 'name' setting in configuration file.\n"); + + /* Output a list of all books in the inventory. */ + setting = config_lookup(&cfg, "inventory.books"); + if(setting != NULL) + { + int count = config_setting_length(setting); + int i; + + printf("%-30s %-30s %-6s %s\n", "TITLE", "AUTHOR", "PRICE", "QTY"); + + for(i = 0; i < count; ++i) + { + config_setting_t *book = config_setting_get_elem(setting, i); + + /* Only output the record if all of the expected fields are present. */ + const char *title, *author; + double price; + int qty; + + if(!(config_setting_lookup_string(book, "title", &title) + && config_setting_lookup_string(book, "author", &author) + && config_setting_lookup_float(book, "price", &price) + && config_setting_lookup_int(book, "qty", &qty))) + continue; + + printf("%-30s %-30s $%6.2f %3d\n", title, author, price, qty); + } + putchar('\n'); + } + + /* Output a list of all movies in the inventory. */ + setting = config_lookup(&cfg, "inventory.movies"); + if(setting != NULL) + { + unsigned int count = config_setting_length(setting); + unsigned int i; + + printf("%-30s %-10s %-6s %s\n", "TITLE", "MEDIA", "PRICE", "QTY"); + for(i = 0; i < count; ++i) + { + config_setting_t *movie = config_setting_get_elem(setting, i); + + /* Only output the record if all of the expected fields are present. */ + const char *title, *media; + double price; + int qty; + + if(!(config_setting_lookup_string(movie, "title", &title) + && config_setting_lookup_string(movie, "media", &media) + && config_setting_lookup_float(movie, "price", &price) + && config_setting_lookup_int(movie, "qty", &qty))) + continue; + + printf("%-30s %-10s $%6.2f %3d\n", title, media, price, qty); + } + putchar('\n'); + } + + config_destroy(&cfg); + return(EXIT_SUCCESS); +} + +/* eof */ diff --git a/libconfig-1.4.9/examples/c/example1.vcproj b/libconfig-1.4.9/examples/c/example1.vcproj new file mode 100644 index 0000000000000000000000000000000000000000..b515e3b690769e3aac8c1907b089324665954930 --- /dev/null +++ b/libconfig-1.4.9/examples/c/example1.vcproj @@ -0,0 +1,185 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/libconfig-1.4.9/examples/c/example2.c b/libconfig-1.4.9/examples/c/example2.c new file mode 100644 index 0000000000000000000000000000000000000000..f1886b9365a096012345836a0c266479b10d923f --- /dev/null +++ b/libconfig-1.4.9/examples/c/example2.c @@ -0,0 +1,92 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include +#include +#include + +/* This example reads the configuration file 'example.cfg', adds a new + * movie record to the movies list, and writes the updated configuration to + * 'updated.cfg'. + */ + +int main(int argc, char **argv) +{ + static const char *output_file = "updated.cfg"; + config_t cfg; + config_setting_t *root, *setting, *movie; + + config_init(&cfg); + + /* Read the file. If there is an error, report it and exit. */ + if(! config_read_file(&cfg, "example.cfg")) + { + fprintf(stderr, "%s:%d - %s\n", config_error_file(&cfg), + config_error_line(&cfg), config_error_text(&cfg)); + config_destroy(&cfg); + return(EXIT_FAILURE); + } + + /* Find the 'movies' setting. Add intermediate settings if they don't yet + * exist. + */ + root = config_root_setting(&cfg); + + setting = config_setting_get_member(root, "inventory"); + if(!setting) + setting = config_setting_add(root, "inventory", CONFIG_TYPE_GROUP); + + setting = config_setting_get_member(setting, "movies"); + if(!setting) + setting = config_setting_add(setting, "movies", CONFIG_TYPE_LIST); + + /* Create the new movie entry. */ + movie = config_setting_add(setting, NULL, CONFIG_TYPE_GROUP); + + setting = config_setting_add(movie, "title", CONFIG_TYPE_STRING); + config_setting_set_string(setting, "Buckaroo Banzai"); + + setting = config_setting_add(movie, "media", CONFIG_TYPE_STRING); + config_setting_set_string(setting, "DVD"); + + setting = config_setting_add(movie, "price", CONFIG_TYPE_FLOAT); + config_setting_set_float(setting, 12.99); + + setting = config_setting_add(movie, "qty", CONFIG_TYPE_INT); + config_setting_set_float(setting, 20); + + /* Write out the updated configuration. */ + if(! config_write_file(&cfg, output_file)) + { + fprintf(stderr, "Error while writing file.\n"); + config_destroy(&cfg); + return(EXIT_FAILURE); + } + + fprintf(stderr, "Updated configuration successfully written to: %s\n", + output_file); + + config_destroy(&cfg); + return(EXIT_SUCCESS); +} + +/* eof */ diff --git a/libconfig-1.4.9/examples/c/example2.vcproj b/libconfig-1.4.9/examples/c/example2.vcproj new file mode 100644 index 0000000000000000000000000000000000000000..0985ae5d981f0a266ade0815b19efcc306e6ed92 --- /dev/null +++ b/libconfig-1.4.9/examples/c/example2.vcproj @@ -0,0 +1,185 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/libconfig-1.4.9/examples/c/example3.c b/libconfig-1.4.9/examples/c/example3.c new file mode 100644 index 0000000000000000000000000000000000000000..0e614e08d86d2bc779767145b5953dbed4e111d2 --- /dev/null +++ b/libconfig-1.4.9/examples/c/example3.c @@ -0,0 +1,79 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include +#include +#include + +/* This example constructs a new configuration in memory and writes it to + * 'newconfig.cfg'. + */ + +int main(int argc, char **argv) +{ + static const char *output_file = "newconfig.cfg"; + config_t cfg; + config_setting_t *root, *setting, *group, *array; + int i; + + config_init(&cfg); + root = config_root_setting(&cfg); + + /* Add some settings to the configuration. */ + group = config_setting_add(root, "address", CONFIG_TYPE_GROUP); + + setting = config_setting_add(group, "street", CONFIG_TYPE_STRING); + config_setting_set_string(setting, "1 Woz Way"); + + setting = config_setting_add(group, "city", CONFIG_TYPE_STRING); + config_setting_set_string(setting, "San Jose"); + + setting = config_setting_add(group, "state", CONFIG_TYPE_STRING); + config_setting_set_string(setting, "CA"); + + setting = config_setting_add(group, "zip", CONFIG_TYPE_INT); + config_setting_set_int(setting, 95110); + + array = config_setting_add(root, "numbers", CONFIG_TYPE_ARRAY); + + for(i = 0; i < 10; ++i) + { + setting = config_setting_add(array, NULL, CONFIG_TYPE_INT); + config_setting_set_int(setting, 10 * i); + } + + /* Write out the new configuration. */ + if(! config_write_file(&cfg, output_file)) + { + fprintf(stderr, "Error while writing file.\n"); + config_destroy(&cfg); + return(EXIT_FAILURE); + } + + fprintf(stderr, "New configuration successfully written to: %s\n", + output_file); + + config_destroy(&cfg); + return(EXIT_SUCCESS); +} + +/* eof */ diff --git a/libconfig-1.4.9/examples/c/example3.vcproj b/libconfig-1.4.9/examples/c/example3.vcproj new file mode 100644 index 0000000000000000000000000000000000000000..132b089c42f3fe4ae1c9c8cb408e75a6007c4f99 --- /dev/null +++ b/libconfig-1.4.9/examples/c/example3.vcproj @@ -0,0 +1,185 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/libconfig-1.4.9/lib/.deps/libconfig___la-grammar.Plo b/libconfig-1.4.9/lib/.deps/libconfig___la-grammar.Plo new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/lib/.deps/libconfig___la-grammar.Plo @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/lib/.deps/libconfig___la-libconfig.Plo b/libconfig-1.4.9/lib/.deps/libconfig___la-libconfig.Plo new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/lib/.deps/libconfig___la-libconfig.Plo @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/lib/.deps/libconfig___la-libconfigcpp.Plo b/libconfig-1.4.9/lib/.deps/libconfig___la-libconfigcpp.Plo new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/lib/.deps/libconfig___la-libconfigcpp.Plo @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/lib/.deps/libconfig___la-scanctx.Plo b/libconfig-1.4.9/lib/.deps/libconfig___la-scanctx.Plo new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/lib/.deps/libconfig___la-scanctx.Plo @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/lib/.deps/libconfig___la-scanner.Plo b/libconfig-1.4.9/lib/.deps/libconfig___la-scanner.Plo new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/lib/.deps/libconfig___la-scanner.Plo @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/lib/.deps/libconfig___la-strbuf.Plo b/libconfig-1.4.9/lib/.deps/libconfig___la-strbuf.Plo new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/lib/.deps/libconfig___la-strbuf.Plo @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/lib/.deps/libconfig_la-grammar.Plo b/libconfig-1.4.9/lib/.deps/libconfig_la-grammar.Plo new file mode 100644 index 0000000000000000000000000000000000000000..f06840896bf31880ac7aeae3d77976e056cfe704 --- /dev/null +++ b/libconfig-1.4.9/lib/.deps/libconfig_la-grammar.Plo @@ -0,0 +1,107 @@ +libconfig_la-grammar.lo: grammar.c /usr/include/stdc-predef.h \ + /usr/include/string.h /usr/include/features.h /usr/include/sys/cdefs.h \ + /usr/include/bits/wordsize.h /usr/include/gnu/stubs.h \ + /usr/include/gnu/stubs-64.h \ + /usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stddef.h \ + /usr/include/xlocale.h /usr/include/bits/string.h \ + /usr/include/bits/string2.h /usr/include/endian.h \ + /usr/include/bits/endian.h /usr/include/bits/byteswap.h \ + /usr/include/bits/types.h /usr/include/bits/typesizes.h \ + /usr/include/bits/byteswap-16.h /usr/include/stdlib.h \ + /usr/include/bits/waitflags.h /usr/include/bits/waitstatus.h \ + /usr/include/sys/types.h /usr/include/time.h /usr/include/sys/select.h \ + /usr/include/bits/select.h /usr/include/bits/sigset.h \ + /usr/include/bits/time.h /usr/include/sys/sysmacros.h \ + /usr/include/bits/pthreadtypes.h /usr/include/alloca.h \ + /usr/include/bits/stdlib-bsearch.h /usr/include/bits/stdlib-float.h \ + libconfig.h /usr/include/stdio.h /usr/include/libio.h \ + /usr/include/_G_config.h /usr/include/wchar.h \ + /usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stdarg.h \ + /usr/include/bits/stdio_lim.h /usr/include/bits/sys_errlist.h \ + /usr/include/bits/stdio.h parsectx.h strbuf.h scanctx.h + +/usr/include/stdc-predef.h: + +/usr/include/string.h: + +/usr/include/features.h: + +/usr/include/sys/cdefs.h: + +/usr/include/bits/wordsize.h: + +/usr/include/gnu/stubs.h: + +/usr/include/gnu/stubs-64.h: + +/usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stddef.h: + +/usr/include/xlocale.h: + +/usr/include/bits/string.h: + +/usr/include/bits/string2.h: + +/usr/include/endian.h: + +/usr/include/bits/endian.h: + +/usr/include/bits/byteswap.h: + +/usr/include/bits/types.h: + +/usr/include/bits/typesizes.h: + +/usr/include/bits/byteswap-16.h: + +/usr/include/stdlib.h: + +/usr/include/bits/waitflags.h: + +/usr/include/bits/waitstatus.h: + +/usr/include/sys/types.h: + +/usr/include/time.h: + +/usr/include/sys/select.h: + +/usr/include/bits/select.h: + +/usr/include/bits/sigset.h: + +/usr/include/bits/time.h: + +/usr/include/sys/sysmacros.h: + +/usr/include/bits/pthreadtypes.h: + +/usr/include/alloca.h: + +/usr/include/bits/stdlib-bsearch.h: + +/usr/include/bits/stdlib-float.h: + +libconfig.h: + +/usr/include/stdio.h: + +/usr/include/libio.h: + +/usr/include/_G_config.h: + +/usr/include/wchar.h: + +/usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stdarg.h: + +/usr/include/bits/stdio_lim.h: + +/usr/include/bits/sys_errlist.h: + +/usr/include/bits/stdio.h: + +parsectx.h: + +strbuf.h: + +scanctx.h: diff --git a/libconfig-1.4.9/lib/.deps/libconfig_la-libconfig.Plo b/libconfig-1.4.9/lib/.deps/libconfig_la-libconfig.Plo new file mode 100644 index 0000000000000000000000000000000000000000..5eef4a2d5727c7a593f7ea8a44b4084daf523556 --- /dev/null +++ b/libconfig-1.4.9/lib/.deps/libconfig_la-libconfig.Plo @@ -0,0 +1,137 @@ +libconfig_la-libconfig.lo: libconfig.c /usr/include/stdc-predef.h \ + ../ac_config.h libconfig.h /usr/include/stdio.h /usr/include/features.h \ + /usr/include/sys/cdefs.h /usr/include/bits/wordsize.h \ + /usr/include/gnu/stubs.h /usr/include/gnu/stubs-64.h \ + /usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stddef.h \ + /usr/include/bits/types.h /usr/include/bits/typesizes.h \ + /usr/include/libio.h /usr/include/_G_config.h /usr/include/wchar.h \ + /usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stdarg.h \ + /usr/include/bits/stdio_lim.h /usr/include/bits/sys_errlist.h \ + /usr/include/bits/stdio.h grammar.h scanner.h /usr/include/string.h \ + /usr/include/xlocale.h /usr/include/bits/string.h \ + /usr/include/bits/string2.h /usr/include/endian.h \ + /usr/include/bits/endian.h /usr/include/bits/byteswap.h \ + /usr/include/bits/byteswap-16.h /usr/include/stdlib.h \ + /usr/include/errno.h /usr/include/bits/errno.h \ + /usr/include/linux/errno.h /usr/include/asm/errno.h \ + /usr/include/asm-generic/errno.h /usr/include/asm-generic/errno-base.h \ + /usr/include/bits/waitflags.h /usr/include/bits/waitstatus.h \ + /usr/include/sys/types.h /usr/include/time.h /usr/include/sys/select.h \ + /usr/include/bits/select.h /usr/include/bits/sigset.h \ + /usr/include/bits/time.h /usr/include/sys/sysmacros.h \ + /usr/include/bits/pthreadtypes.h /usr/include/alloca.h \ + /usr/include/bits/stdlib-bsearch.h /usr/include/bits/stdlib-float.h \ + scanctx.h strbuf.h parsectx.h wincompat.h /usr/include/locale.h \ + /usr/include/bits/locale.h /usr/include/ctype.h + +/usr/include/stdc-predef.h: + +../ac_config.h: + +libconfig.h: + +/usr/include/stdio.h: + +/usr/include/features.h: + +/usr/include/sys/cdefs.h: + +/usr/include/bits/wordsize.h: + +/usr/include/gnu/stubs.h: + +/usr/include/gnu/stubs-64.h: + +/usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stddef.h: + +/usr/include/bits/types.h: + +/usr/include/bits/typesizes.h: + +/usr/include/libio.h: + +/usr/include/_G_config.h: + +/usr/include/wchar.h: + +/usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stdarg.h: + +/usr/include/bits/stdio_lim.h: + +/usr/include/bits/sys_errlist.h: + +/usr/include/bits/stdio.h: + +grammar.h: + +scanner.h: + +/usr/include/string.h: + +/usr/include/xlocale.h: + +/usr/include/bits/string.h: + +/usr/include/bits/string2.h: + +/usr/include/endian.h: + +/usr/include/bits/endian.h: + +/usr/include/bits/byteswap.h: + +/usr/include/bits/byteswap-16.h: + +/usr/include/stdlib.h: + +/usr/include/errno.h: + +/usr/include/bits/errno.h: + +/usr/include/linux/errno.h: + +/usr/include/asm/errno.h: + +/usr/include/asm-generic/errno.h: + +/usr/include/asm-generic/errno-base.h: + +/usr/include/bits/waitflags.h: + +/usr/include/bits/waitstatus.h: + +/usr/include/sys/types.h: + +/usr/include/time.h: + +/usr/include/sys/select.h: + +/usr/include/bits/select.h: + +/usr/include/bits/sigset.h: + +/usr/include/bits/time.h: + +/usr/include/sys/sysmacros.h: + +/usr/include/bits/pthreadtypes.h: + +/usr/include/alloca.h: + +/usr/include/bits/stdlib-bsearch.h: + +/usr/include/bits/stdlib-float.h: + +scanctx.h: + +strbuf.h: + +parsectx.h: + +wincompat.h: + +/usr/include/locale.h: + +/usr/include/bits/locale.h: + +/usr/include/ctype.h: diff --git a/libconfig-1.4.9/lib/.deps/libconfig_la-scanctx.Plo b/libconfig-1.4.9/lib/.deps/libconfig_la-scanctx.Plo new file mode 100644 index 0000000000000000000000000000000000000000..45ff34626bad81a72497d13725b6a98d1c575cc3 --- /dev/null +++ b/libconfig-1.4.9/lib/.deps/libconfig_la-scanctx.Plo @@ -0,0 +1,107 @@ +libconfig_la-scanctx.lo: scanctx.c /usr/include/stdc-predef.h scanctx.h \ + libconfig.h /usr/include/stdio.h /usr/include/features.h \ + /usr/include/sys/cdefs.h /usr/include/bits/wordsize.h \ + /usr/include/gnu/stubs.h /usr/include/gnu/stubs-64.h \ + /usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stddef.h \ + /usr/include/bits/types.h /usr/include/bits/typesizes.h \ + /usr/include/libio.h /usr/include/_G_config.h /usr/include/wchar.h \ + /usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stdarg.h \ + /usr/include/bits/stdio_lim.h /usr/include/bits/sys_errlist.h \ + /usr/include/bits/stdio.h strbuf.h /usr/include/string.h \ + /usr/include/xlocale.h /usr/include/bits/string.h \ + /usr/include/bits/string2.h /usr/include/endian.h \ + /usr/include/bits/endian.h /usr/include/bits/byteswap.h \ + /usr/include/bits/byteswap-16.h /usr/include/stdlib.h \ + /usr/include/sys/types.h /usr/include/time.h /usr/include/sys/select.h \ + /usr/include/bits/select.h /usr/include/bits/sigset.h \ + /usr/include/bits/time.h /usr/include/sys/sysmacros.h \ + /usr/include/bits/pthreadtypes.h wincompat.h \ + /usr/include/bits/waitflags.h /usr/include/bits/waitstatus.h \ + /usr/include/alloca.h /usr/include/bits/stdlib-bsearch.h \ + /usr/include/bits/stdlib-float.h + +/usr/include/stdc-predef.h: + +scanctx.h: + +libconfig.h: + +/usr/include/stdio.h: + +/usr/include/features.h: + +/usr/include/sys/cdefs.h: + +/usr/include/bits/wordsize.h: + +/usr/include/gnu/stubs.h: + +/usr/include/gnu/stubs-64.h: + +/usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stddef.h: + +/usr/include/bits/types.h: + +/usr/include/bits/typesizes.h: + +/usr/include/libio.h: + +/usr/include/_G_config.h: + +/usr/include/wchar.h: + +/usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stdarg.h: + +/usr/include/bits/stdio_lim.h: + +/usr/include/bits/sys_errlist.h: + +/usr/include/bits/stdio.h: + +strbuf.h: + +/usr/include/string.h: + +/usr/include/xlocale.h: + +/usr/include/bits/string.h: + +/usr/include/bits/string2.h: + +/usr/include/endian.h: + +/usr/include/bits/endian.h: + +/usr/include/bits/byteswap.h: + +/usr/include/bits/byteswap-16.h: + +/usr/include/stdlib.h: + +/usr/include/sys/types.h: + +/usr/include/time.h: + +/usr/include/sys/select.h: + +/usr/include/bits/select.h: + +/usr/include/bits/sigset.h: + +/usr/include/bits/time.h: + +/usr/include/sys/sysmacros.h: + +/usr/include/bits/pthreadtypes.h: + +wincompat.h: + +/usr/include/bits/waitflags.h: + +/usr/include/bits/waitstatus.h: + +/usr/include/alloca.h: + +/usr/include/bits/stdlib-bsearch.h: + +/usr/include/bits/stdlib-float.h: diff --git a/libconfig-1.4.9/lib/.deps/libconfig_la-scanner.Plo b/libconfig-1.4.9/lib/.deps/libconfig_la-scanner.Plo new file mode 100644 index 0000000000000000000000000000000000000000..60497b43038d2490265687a0c3726ed18f59a4d5 --- /dev/null +++ b/libconfig-1.4.9/lib/.deps/libconfig_la-scanner.Plo @@ -0,0 +1,128 @@ +libconfig_la-scanner.lo: scanner.c /usr/include/stdc-predef.h \ + /usr/include/stdio.h /usr/include/features.h /usr/include/sys/cdefs.h \ + /usr/include/bits/wordsize.h /usr/include/gnu/stubs.h \ + /usr/include/gnu/stubs-64.h \ + /usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stddef.h \ + /usr/include/bits/types.h /usr/include/bits/typesizes.h \ + /usr/include/libio.h /usr/include/_G_config.h /usr/include/wchar.h \ + /usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stdarg.h \ + /usr/include/bits/stdio_lim.h /usr/include/bits/sys_errlist.h \ + /usr/include/bits/stdio.h /usr/include/string.h /usr/include/xlocale.h \ + /usr/include/bits/string.h /usr/include/bits/string2.h \ + /usr/include/endian.h /usr/include/bits/endian.h \ + /usr/include/bits/byteswap.h /usr/include/bits/byteswap-16.h \ + /usr/include/stdlib.h /usr/include/errno.h /usr/include/bits/errno.h \ + /usr/include/linux/errno.h /usr/include/asm/errno.h \ + /usr/include/asm-generic/errno.h /usr/include/asm-generic/errno-base.h \ + /usr/include/bits/waitflags.h /usr/include/bits/waitstatus.h \ + /usr/include/sys/types.h /usr/include/time.h /usr/include/sys/select.h \ + /usr/include/bits/select.h /usr/include/bits/sigset.h \ + /usr/include/bits/time.h /usr/include/sys/sysmacros.h \ + /usr/include/bits/pthreadtypes.h /usr/include/alloca.h \ + /usr/include/bits/stdlib-bsearch.h /usr/include/bits/stdlib-float.h \ + /usr/include/ctype.h grammar.h wincompat.h parsectx.h libconfig.h \ + strbuf.h scanctx.h + +/usr/include/stdc-predef.h: + +/usr/include/stdio.h: + +/usr/include/features.h: + +/usr/include/sys/cdefs.h: + +/usr/include/bits/wordsize.h: + +/usr/include/gnu/stubs.h: + +/usr/include/gnu/stubs-64.h: + +/usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stddef.h: + +/usr/include/bits/types.h: + +/usr/include/bits/typesizes.h: + +/usr/include/libio.h: + +/usr/include/_G_config.h: + +/usr/include/wchar.h: + +/usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stdarg.h: + +/usr/include/bits/stdio_lim.h: + +/usr/include/bits/sys_errlist.h: + +/usr/include/bits/stdio.h: + +/usr/include/string.h: + +/usr/include/xlocale.h: + +/usr/include/bits/string.h: + +/usr/include/bits/string2.h: + +/usr/include/endian.h: + +/usr/include/bits/endian.h: + +/usr/include/bits/byteswap.h: + +/usr/include/bits/byteswap-16.h: + +/usr/include/stdlib.h: + +/usr/include/errno.h: + +/usr/include/bits/errno.h: + +/usr/include/linux/errno.h: + +/usr/include/asm/errno.h: + +/usr/include/asm-generic/errno.h: + +/usr/include/asm-generic/errno-base.h: + +/usr/include/bits/waitflags.h: + +/usr/include/bits/waitstatus.h: + +/usr/include/sys/types.h: + +/usr/include/time.h: + +/usr/include/sys/select.h: + +/usr/include/bits/select.h: + +/usr/include/bits/sigset.h: + +/usr/include/bits/time.h: + +/usr/include/sys/sysmacros.h: + +/usr/include/bits/pthreadtypes.h: + +/usr/include/alloca.h: + +/usr/include/bits/stdlib-bsearch.h: + +/usr/include/bits/stdlib-float.h: + +/usr/include/ctype.h: + +grammar.h: + +wincompat.h: + +parsectx.h: + +libconfig.h: + +strbuf.h: + +scanctx.h: diff --git a/libconfig-1.4.9/lib/.deps/libconfig_la-strbuf.Plo b/libconfig-1.4.9/lib/.deps/libconfig_la-strbuf.Plo new file mode 100644 index 0000000000000000000000000000000000000000..aaab0628fe2a724fb04e50c5acf6467e8edccdcb --- /dev/null +++ b/libconfig-1.4.9/lib/.deps/libconfig_la-strbuf.Plo @@ -0,0 +1,80 @@ +libconfig_la-strbuf.lo: strbuf.c /usr/include/stdc-predef.h strbuf.h \ + /usr/include/string.h /usr/include/features.h /usr/include/sys/cdefs.h \ + /usr/include/bits/wordsize.h /usr/include/gnu/stubs.h \ + /usr/include/gnu/stubs-64.h \ + /usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stddef.h \ + /usr/include/xlocale.h /usr/include/bits/string.h \ + /usr/include/bits/string2.h /usr/include/endian.h \ + /usr/include/bits/endian.h /usr/include/bits/byteswap.h \ + /usr/include/bits/types.h /usr/include/bits/typesizes.h \ + /usr/include/bits/byteswap-16.h /usr/include/stdlib.h \ + /usr/include/sys/types.h /usr/include/time.h /usr/include/sys/select.h \ + /usr/include/bits/select.h /usr/include/bits/sigset.h \ + /usr/include/bits/time.h /usr/include/sys/sysmacros.h \ + /usr/include/bits/pthreadtypes.h /usr/include/bits/waitflags.h \ + /usr/include/bits/waitstatus.h /usr/include/alloca.h \ + /usr/include/bits/stdlib-bsearch.h /usr/include/bits/stdlib-float.h + +/usr/include/stdc-predef.h: + +strbuf.h: + +/usr/include/string.h: + +/usr/include/features.h: + +/usr/include/sys/cdefs.h: + +/usr/include/bits/wordsize.h: + +/usr/include/gnu/stubs.h: + +/usr/include/gnu/stubs-64.h: + +/usr/lib/gcc/x86_64-redhat-linux/4.8.3/include/stddef.h: + +/usr/include/xlocale.h: + +/usr/include/bits/string.h: + +/usr/include/bits/string2.h: + +/usr/include/endian.h: + +/usr/include/bits/endian.h: + +/usr/include/bits/byteswap.h: + +/usr/include/bits/types.h: + +/usr/include/bits/typesizes.h: + +/usr/include/bits/byteswap-16.h: + +/usr/include/stdlib.h: + +/usr/include/sys/types.h: + +/usr/include/time.h: + +/usr/include/sys/select.h: + +/usr/include/bits/select.h: + +/usr/include/bits/sigset.h: + +/usr/include/bits/time.h: + +/usr/include/sys/sysmacros.h: + +/usr/include/bits/pthreadtypes.h: + +/usr/include/bits/waitflags.h: + +/usr/include/bits/waitstatus.h: + +/usr/include/alloca.h: + +/usr/include/bits/stdlib-bsearch.h: + +/usr/include/bits/stdlib-float.h: diff --git a/libconfig-1.4.9/lib/Makefile b/libconfig-1.4.9/lib/Makefile new file mode 100644 index 0000000000000000000000000000000000000000..3917c653bce84cbafde4b3a0822d311e03947535 --- /dev/null +++ b/libconfig-1.4.9/lib/Makefile @@ -0,0 +1,795 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# lib/Makefile. Generated from Makefile.in by configure. + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + + + + + + +pkgdatadir = $(datadir)/libconfig +pkgincludedir = $(includedir)/libconfig +pkglibdir = $(libdir)/libconfig +pkglibexecdir = $(libexecdir)/libconfig +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = x86_64-unknown-linux-gnu +host_triplet = x86_64-unknown-linux-gnu +target_triplet = x86_64-unknown-linux-gnu +#am__append_1 = libconfig++.la +#am__append_2 = -DLIBCONFIG_EXPORTS +#am__append_3 = -DLIBCONFIGXX_EXPORTS -DLIBCONFIG_STATIC +#am__append_4 = $(libinc_cpp) +#am__append_5 = libconfig++.pc +subdir = lib +DIST_COMMON = $(am__include_HEADERS_DIST) $(srcdir)/Makefile.am \ + $(srcdir)/Makefile.in $(srcdir)/libconfig++.pc.in \ + $(srcdir)/libconfig.pc.in grammar.c grammar.h scanner.c +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = libconfig.pc libconfig++.pc +CONFIG_CLEAN_VPATH_FILES = +am__vpath_adj_setup = srcdirstrip=`echo "$(srcdir)" | sed 's|.|.|g'`; +am__vpath_adj = case $$p in \ + $(srcdir)/*) f=`echo "$$p" | sed "s|^$$srcdirstrip/||"`;; \ + *) f=$$p;; \ + esac; +am__strip_dir = f=`echo $$p | sed -e 's|^.*/||'`; +am__install_max = 40 +am__nobase_strip_setup = \ + srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*|]/\\\\&/g'` +am__nobase_strip = \ + for p in $$list; do echo "$$p"; done | sed -e "s|$$srcdirstrip/||" +am__nobase_list = $(am__nobase_strip_setup); \ + for p in $$list; do echo "$$p $$p"; done | \ + sed "s| $$srcdirstrip/| |;"' / .*\//!s/ .*/ ./; s,\( .*\)/[^/]*$$,\1,' | \ + $(AWK) 'BEGIN { files["."] = "" } { files[$$2] = files[$$2] " " $$1; \ + if (++n[$$2] == $(am__install_max)) \ + { print $$2, files[$$2]; n[$$2] = 0; files[$$2] = "" } } \ + END { for (dir in files) print dir, files[dir] }' +am__base_list = \ + sed '$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;s/\n/ /g' | \ + sed '$$!N;$$!N;$$!N;$$!N;s/\n/ /g' +am__installdirs = "$(DESTDIR)$(libdir)" "$(DESTDIR)$(pkgconfigdir)" \ + "$(DESTDIR)$(includedir)" +LTLIBRARIES = $(lib_LTLIBRARIES) +libconfig___la_LIBADD = +am__objects_1 = libconfig___la-libconfig.lo libconfig___la-scanner.lo \ + libconfig___la-grammar.lo libconfig___la-scanctx.lo \ + libconfig___la-strbuf.lo +am__objects_2 = $(am__objects_1) libconfig___la-libconfigcpp.lo +am_libconfig___la_OBJECTS = $(am__objects_2) +libconfig___la_OBJECTS = $(am_libconfig___la_OBJECTS) +libconfig___la_LINK = $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) \ + $(LIBTOOLFLAGS) --mode=link $(CXXLD) $(AM_CXXFLAGS) \ + $(CXXFLAGS) $(libconfig___la_LDFLAGS) $(LDFLAGS) -o $@ +#am_libconfig___la_rpath = -rpath $(libdir) +libconfig_la_LIBADD = +am__objects_3 = libconfig_la-libconfig.lo libconfig_la-scanner.lo \ + libconfig_la-grammar.lo libconfig_la-scanctx.lo \ + libconfig_la-strbuf.lo +am_libconfig_la_OBJECTS = $(am__objects_3) +libconfig_la_OBJECTS = $(am_libconfig_la_OBJECTS) +libconfig_la_LINK = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) \ + $(LIBTOOLFLAGS) --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ + $(libconfig_la_LDFLAGS) $(LDFLAGS) -o $@ +DEFAULT_INCLUDES = -I. -I$(top_builddir) +depcomp = $(SHELL) $(top_srcdir)/aux-build/depcomp +am__depfiles_maybe = depfiles +am__mv = mv -f +COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +LTCOMPILE = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +CCLD = $(CC) +LINK = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) $(AM_LDFLAGS) \ + $(LDFLAGS) -o $@ +CXXCOMPILE = $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS) +LTCXXCOMPILE = $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS) +CXXLD = $(CXX) +CXXLINK = $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=link $(CXXLD) $(AM_CXXFLAGS) $(CXXFLAGS) $(AM_LDFLAGS) \ + $(LDFLAGS) -o $@ +LEXCOMPILE = $(LEX) $(LFLAGS) $(AM_LFLAGS) +LTLEXCOMPILE = $(LIBTOOL) $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(LEX) $(LFLAGS) $(AM_LFLAGS) +YLWRAP = $(top_srcdir)/aux-build/ylwrap +YACCCOMPILE = $(YACC) $(YFLAGS) $(AM_YFLAGS) +LTYACCCOMPILE = $(LIBTOOL) $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(YACC) $(YFLAGS) $(AM_YFLAGS) +SOURCES = $(libconfig___la_SOURCES) $(libconfig_la_SOURCES) +DIST_SOURCES = $(libconfig___la_SOURCES) $(libconfig_la_SOURCES) +DATA = $(pkgconfig_DATA) +am__include_HEADERS_DIST = libconfig.h libconfig.h++ +HEADERS = $(include_HEADERS) +ETAGS = etags +CTAGS = ctags +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +ACLOCAL = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run aclocal-1.11 +AMTAR = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run tar +AR = ar +AS = as +AUTOCONF = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoconf +AUTOHEADER = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoheader +AUTOMAKE = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run automake-1.11 +AWK = gawk +CC = gcc +CCDEPMODE = depmode=gcc3 +CFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter +CPP = gcc -E +CPPFLAGS = +CXX = g++ +CXXCPP = g++ -E +CXXDEPMODE = depmode=gcc3 +CXXFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wno-unused-parameter +CYGPATH_W = echo +DEFS = -DHAVE_CONFIG_H +DEPDIR = .deps +DLLTOOL = false +DSYMUTIL = +DUMPBIN = +ECHO_C = +ECHO_N = -n +ECHO_T = +EGREP = /usr/bin/grep -E +EXEEXT = +FGREP = /usr/bin/grep -F +GREP = /usr/bin/grep +INSTALL = /usr/bin/install -c +INSTALL_DATA = ${INSTALL} -m 644 +INSTALL_PROGRAM = ${INSTALL} +INSTALL_SCRIPT = ${INSTALL} +INSTALL_STRIP_PROGRAM = $(install_sh) -c -s +LD = /usr/bin/ld -m elf_x86_64 +LDFLAGS = +LEX = flex +LEXLIB = +LEX_OUTPUT_ROOT = lex.yy +LIBOBJS = +LIBS = +LIBTOOL = $(SHELL) $(top_builddir)/libtool +LIPO = +LN_S = ln -s +LTLIBOBJS = +MAKEINFO = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run makeinfo +MANIFEST_TOOL = : +MKDIR_P = /usr/bin/mkdir -p +NM = /usr/bin/nm -B +NMEDIT = +OBJDUMP = objdump +OBJEXT = o +OTOOL = +OTOOL64 = +PACKAGE = libconfig +PACKAGE_BUGREPORT = hyperrealm@gmail.com +PACKAGE_NAME = libconfig +PACKAGE_STRING = libconfig 1.4.9 +PACKAGE_TARNAME = libconfig +PACKAGE_URL = http://www.hyperrealm.com/main.php?s=libconfig +PACKAGE_VERSION = 1.4.9 +PATH_SEPARATOR = : +RANLIB = ranlib +SED = /usr/bin/sed +SET_MAKE = +SHELL = /bin/sh +STRIP = strip +VERSION = 1.4.9 +YACC = bison -y +YFLAGS = +abs_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/lib +abs_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/lib +abs_top_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +abs_top_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +ac_ct_AR = ar +ac_ct_CC = gcc +ac_ct_CXX = g++ +ac_ct_DUMPBIN = +am__include = include +am__leading_dot = . +am__quote = +am__tar = ${AMTAR} chof - "$$tardir" +am__untar = ${AMTAR} xf - +bindir = ${exec_prefix}/bin +build = x86_64-unknown-linux-gnu +build_alias = +build_cpu = x86_64 +build_os = linux-gnu +build_vendor = unknown +builddir = . +datadir = ${datarootdir} +datarootdir = ${prefix}/share +docdir = ${datarootdir}/doc/${PACKAGE_TARNAME} +dvidir = ${docdir} +exec_prefix = ${prefix} +host = x86_64-unknown-linux-gnu +host_alias = +host_cpu = x86_64 +host_os = linux-gnu +host_vendor = unknown +htmldir = ${docdir} +includedir = ${prefix}/include +infodir = ${datarootdir}/info +install_sh = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/install-sh +libdir = ${exec_prefix}/lib +libexecdir = ${exec_prefix}/libexec +localedir = ${datarootdir}/locale +localstatedir = ${prefix}/var +mandir = ${datarootdir}/man +mkdir_p = /usr/bin/mkdir -p +oldincludedir = /usr/include +pdfdir = ${docdir} +prefix = /usr/local +program_transform_name = s,x,x, +psdir = ${docdir} +sbindir = ${exec_prefix}/sbin +sharedstatedir = ${prefix}/com +srcdir = . +sysconfdir = ${prefix}/etc +target = x86_64-unknown-linux-gnu +target_alias = +target_cpu = x86_64 +target_os = linux-gnu +target_vendor = unknown +top_build_prefix = ../ +top_builddir = .. +top_srcdir = .. +lib_LTLIBRARIES = libconfig.la $(am__append_1) + +# Versioning rules ( C:R:A ) +# +# Perform EACH step that applies. +# +# 1. Start with version 0:0:0. +# 2. If any of the sources have changed, increment R. This is a new revision +# of the current interface. +# 3. If the interface has changed, increment C and set R to 0. This is the +# first revision of a new interface. +# 4. If the interface has changed, and the new interface is a superset of the +# previous interface (that is, if the previous interface has not been +# broken by the changes in this new release), increment A. This release is +# backwards compatible with the previous release. +# 5. If the new interface has removed elements with respect to the +# previous interface, then backward compatibility is broken; set A to 0. +# This release has a new, but backwards incompatible interface. +# +# For more info see section 6.3 of the GNU Libtool Manual. +VERINFO = -version-info 10:3:1 +PARSER_PREFIX = libconfig_yy +libconfig_la_LDFLAGS = $(VERINFO) -no-undefined +libconfig___la_LDFLAGS = $(VERINFO) -no-undefined +libsrc = libconfig.c scanner.l grammar.y parsectx.h wincompat.h \ + scanctx.c scanctx.h strbuf.c strbuf.h + +libinc = libconfig.h +libsrc_cpp = $(libsrc) libconfigcpp.c++ +libinc_cpp = libconfig.h++ +BUILT_SOURCES = scanner.c scanner.h grammar.c grammar.h +libconfig_la_SOURCES = $(libsrc) +libconfig___la_SOURCES = $(libsrc_cpp) +libcppflags = -D_REENTRANT $(am__append_2) +libcppxxflags = -D_REENTRANT $(am__append_3) +libconfig_la_CPPFLAGS = -DPARSER_PREFIX=\"$(PARSER_PREFIX)\" $(libcppflags) +libconfig___la_CPPFLAGS = -DPARSER_PREFIX=\"$(PARSER_PREFIX)\" $(libcppxxflags) +include_HEADERS = $(libinc) $(am__append_4) +AM_YFLAGS = -d -p $(PARSER_PREFIX) +AM_LFLAGS = --header-file=scanner.h --prefix=$(PARSER_PREFIX) +EXTRA_DIST = \ + $(BUILT_SOURCES) \ + libconfigcpp.cc libconfig.hh \ + *.vcproj + +pkgconfigdir = $(libdir)/pkgconfig +pkgconfig_DATA = libconfig.pc $(am__append_5) +all: $(BUILT_SOURCES) + $(MAKE) $(AM_MAKEFLAGS) all-am + +.SUFFIXES: +.SUFFIXES: .c .c++ .l .lo .o .obj .y +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu lib/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu lib/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): +libconfig.pc: $(top_builddir)/config.status $(srcdir)/libconfig.pc.in + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ +libconfig++.pc: $(top_builddir)/config.status $(srcdir)/libconfig++.pc.in + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ +install-libLTLIBRARIES: $(lib_LTLIBRARIES) + @$(NORMAL_INSTALL) + test -z "$(libdir)" || $(MKDIR_P) "$(DESTDIR)$(libdir)" + @list='$(lib_LTLIBRARIES)'; test -n "$(libdir)" || list=; \ + list2=; for p in $$list; do \ + if test -f $$p; then \ + list2="$$list2 $$p"; \ + else :; fi; \ + done; \ + test -z "$$list2" || { \ + echo " $(LIBTOOL) $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=install $(INSTALL) $(INSTALL_STRIP_FLAG) $$list2 '$(DESTDIR)$(libdir)'"; \ + $(LIBTOOL) $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=install $(INSTALL) $(INSTALL_STRIP_FLAG) $$list2 "$(DESTDIR)$(libdir)"; \ + } + +uninstall-libLTLIBRARIES: + @$(NORMAL_UNINSTALL) + @list='$(lib_LTLIBRARIES)'; test -n "$(libdir)" || list=; \ + for p in $$list; do \ + $(am__strip_dir) \ + echo " $(LIBTOOL) $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=uninstall rm -f '$(DESTDIR)$(libdir)/$$f'"; \ + $(LIBTOOL) $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=uninstall rm -f "$(DESTDIR)$(libdir)/$$f"; \ + done + +clean-libLTLIBRARIES: + -test -z "$(lib_LTLIBRARIES)" || rm -f $(lib_LTLIBRARIES) + @list='$(lib_LTLIBRARIES)'; for p in $$list; do \ + dir="`echo $$p | sed -e 's|/[^/]*$$||'`"; \ + test "$$dir" != "$$p" || dir=.; \ + echo "rm -f \"$${dir}/so_locations\""; \ + rm -f "$${dir}/so_locations"; \ + done +grammar.h: grammar.c + @if test ! -f $@; then \ + rm -f grammar.c; \ + $(MAKE) $(AM_MAKEFLAGS) grammar.c; \ + else :; fi +libconfig++.la: $(libconfig___la_OBJECTS) $(libconfig___la_DEPENDENCIES) + $(libconfig___la_LINK) $(am_libconfig___la_rpath) $(libconfig___la_OBJECTS) $(libconfig___la_LIBADD) $(LIBS) +libconfig.la: $(libconfig_la_OBJECTS) $(libconfig_la_DEPENDENCIES) + $(libconfig_la_LINK) -rpath $(libdir) $(libconfig_la_OBJECTS) $(libconfig_la_LIBADD) $(LIBS) + +mostlyclean-compile: + -rm -f *.$(OBJEXT) + +distclean-compile: + -rm -f *.tab.c + +include ./$(DEPDIR)/libconfig___la-grammar.Plo +include ./$(DEPDIR)/libconfig___la-libconfig.Plo +include ./$(DEPDIR)/libconfig___la-libconfigcpp.Plo +include ./$(DEPDIR)/libconfig___la-scanctx.Plo +include ./$(DEPDIR)/libconfig___la-scanner.Plo +include ./$(DEPDIR)/libconfig___la-strbuf.Plo +include ./$(DEPDIR)/libconfig_la-grammar.Plo +include ./$(DEPDIR)/libconfig_la-libconfig.Plo +include ./$(DEPDIR)/libconfig_la-scanctx.Plo +include ./$(DEPDIR)/libconfig_la-scanner.Plo +include ./$(DEPDIR)/libconfig_la-strbuf.Plo + +.c.o: + $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +# source='$<' object='$@' libtool=no \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(COMPILE) -c $< + +.c.obj: + $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'` + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +# source='$<' object='$@' libtool=no \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(COMPILE) -c `$(CYGPATH_W) '$<'` + +.c.lo: + $(LTCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo +# source='$<' object='$@' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LTCOMPILE) -c -o $@ $< + +libconfig___la-libconfig.lo: libconfig.c + $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig___la-libconfig.lo -MD -MP -MF $(DEPDIR)/libconfig___la-libconfig.Tpo -c -o libconfig___la-libconfig.lo `test -f 'libconfig.c' || echo '$(srcdir)/'`libconfig.c + $(am__mv) $(DEPDIR)/libconfig___la-libconfig.Tpo $(DEPDIR)/libconfig___la-libconfig.Plo +# source='libconfig.c' object='libconfig___la-libconfig.lo' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig___la-libconfig.lo `test -f 'libconfig.c' || echo '$(srcdir)/'`libconfig.c + +libconfig___la-scanner.lo: scanner.c + $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig___la-scanner.lo -MD -MP -MF $(DEPDIR)/libconfig___la-scanner.Tpo -c -o libconfig___la-scanner.lo `test -f 'scanner.c' || echo '$(srcdir)/'`scanner.c + $(am__mv) $(DEPDIR)/libconfig___la-scanner.Tpo $(DEPDIR)/libconfig___la-scanner.Plo +# source='scanner.c' object='libconfig___la-scanner.lo' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig___la-scanner.lo `test -f 'scanner.c' || echo '$(srcdir)/'`scanner.c + +libconfig___la-grammar.lo: grammar.c + $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig___la-grammar.lo -MD -MP -MF $(DEPDIR)/libconfig___la-grammar.Tpo -c -o libconfig___la-grammar.lo `test -f 'grammar.c' || echo '$(srcdir)/'`grammar.c + $(am__mv) $(DEPDIR)/libconfig___la-grammar.Tpo $(DEPDIR)/libconfig___la-grammar.Plo +# source='grammar.c' object='libconfig___la-grammar.lo' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig___la-grammar.lo `test -f 'grammar.c' || echo '$(srcdir)/'`grammar.c + +libconfig___la-scanctx.lo: scanctx.c + $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig___la-scanctx.lo -MD -MP -MF $(DEPDIR)/libconfig___la-scanctx.Tpo -c -o libconfig___la-scanctx.lo `test -f 'scanctx.c' || echo '$(srcdir)/'`scanctx.c + $(am__mv) $(DEPDIR)/libconfig___la-scanctx.Tpo $(DEPDIR)/libconfig___la-scanctx.Plo +# source='scanctx.c' object='libconfig___la-scanctx.lo' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig___la-scanctx.lo `test -f 'scanctx.c' || echo '$(srcdir)/'`scanctx.c + +libconfig___la-strbuf.lo: strbuf.c + $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig___la-strbuf.lo -MD -MP -MF $(DEPDIR)/libconfig___la-strbuf.Tpo -c -o libconfig___la-strbuf.lo `test -f 'strbuf.c' || echo '$(srcdir)/'`strbuf.c + $(am__mv) $(DEPDIR)/libconfig___la-strbuf.Tpo $(DEPDIR)/libconfig___la-strbuf.Plo +# source='strbuf.c' object='libconfig___la-strbuf.lo' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig___la-strbuf.lo `test -f 'strbuf.c' || echo '$(srcdir)/'`strbuf.c + +libconfig_la-libconfig.lo: libconfig.c + $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_la-libconfig.lo -MD -MP -MF $(DEPDIR)/libconfig_la-libconfig.Tpo -c -o libconfig_la-libconfig.lo `test -f 'libconfig.c' || echo '$(srcdir)/'`libconfig.c + $(am__mv) $(DEPDIR)/libconfig_la-libconfig.Tpo $(DEPDIR)/libconfig_la-libconfig.Plo +# source='libconfig.c' object='libconfig_la-libconfig.lo' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_la-libconfig.lo `test -f 'libconfig.c' || echo '$(srcdir)/'`libconfig.c + +libconfig_la-scanner.lo: scanner.c + $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_la-scanner.lo -MD -MP -MF $(DEPDIR)/libconfig_la-scanner.Tpo -c -o libconfig_la-scanner.lo `test -f 'scanner.c' || echo '$(srcdir)/'`scanner.c + $(am__mv) $(DEPDIR)/libconfig_la-scanner.Tpo $(DEPDIR)/libconfig_la-scanner.Plo +# source='scanner.c' object='libconfig_la-scanner.lo' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_la-scanner.lo `test -f 'scanner.c' || echo '$(srcdir)/'`scanner.c + +libconfig_la-grammar.lo: grammar.c + $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_la-grammar.lo -MD -MP -MF $(DEPDIR)/libconfig_la-grammar.Tpo -c -o libconfig_la-grammar.lo `test -f 'grammar.c' || echo '$(srcdir)/'`grammar.c + $(am__mv) $(DEPDIR)/libconfig_la-grammar.Tpo $(DEPDIR)/libconfig_la-grammar.Plo +# source='grammar.c' object='libconfig_la-grammar.lo' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_la-grammar.lo `test -f 'grammar.c' || echo '$(srcdir)/'`grammar.c + +libconfig_la-scanctx.lo: scanctx.c + $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_la-scanctx.lo -MD -MP -MF $(DEPDIR)/libconfig_la-scanctx.Tpo -c -o libconfig_la-scanctx.lo `test -f 'scanctx.c' || echo '$(srcdir)/'`scanctx.c + $(am__mv) $(DEPDIR)/libconfig_la-scanctx.Tpo $(DEPDIR)/libconfig_la-scanctx.Plo +# source='scanctx.c' object='libconfig_la-scanctx.lo' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_la-scanctx.lo `test -f 'scanctx.c' || echo '$(srcdir)/'`scanctx.c + +libconfig_la-strbuf.lo: strbuf.c + $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_la-strbuf.lo -MD -MP -MF $(DEPDIR)/libconfig_la-strbuf.Tpo -c -o libconfig_la-strbuf.lo `test -f 'strbuf.c' || echo '$(srcdir)/'`strbuf.c + $(am__mv) $(DEPDIR)/libconfig_la-strbuf.Tpo $(DEPDIR)/libconfig_la-strbuf.Plo +# source='strbuf.c' object='libconfig_la-strbuf.lo' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_la-strbuf.lo `test -f 'strbuf.c' || echo '$(srcdir)/'`strbuf.c + +.c++.o: + $(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +# source='$<' object='$@' libtool=no \ +# DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) \ +# $(CXXCOMPILE) -c -o $@ $< + +.c++.obj: + $(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'` + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +# source='$<' object='$@' libtool=no \ +# DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) \ +# $(CXXCOMPILE) -c -o $@ `$(CYGPATH_W) '$<'` + +.c++.lo: + $(LTCXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo +# source='$<' object='$@' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) \ +# $(LTCXXCOMPILE) -c -o $@ $< + +libconfig___la-libconfigcpp.lo: libconfigcpp.c++ + $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS) -MT libconfig___la-libconfigcpp.lo -MD -MP -MF $(DEPDIR)/libconfig___la-libconfigcpp.Tpo -c -o libconfig___la-libconfigcpp.lo `test -f 'libconfigcpp.c++' || echo '$(srcdir)/'`libconfigcpp.c++ + $(am__mv) $(DEPDIR)/libconfig___la-libconfigcpp.Tpo $(DEPDIR)/libconfig___la-libconfigcpp.Plo +# source='libconfigcpp.c++' object='libconfig___la-libconfigcpp.lo' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) \ +# $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS) -c -o libconfig___la-libconfigcpp.lo `test -f 'libconfigcpp.c++' || echo '$(srcdir)/'`libconfigcpp.c++ + +.l.c: + $(am__skiplex) $(SHELL) $(YLWRAP) $< $(LEX_OUTPUT_ROOT).c $@ -- $(LEXCOMPILE) + +.y.c: + $(am__skipyacc) $(SHELL) $(YLWRAP) $< y.tab.c $@ y.tab.h $*.h y.output $*.output -- $(YACCCOMPILE) + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs +install-pkgconfigDATA: $(pkgconfig_DATA) + @$(NORMAL_INSTALL) + test -z "$(pkgconfigdir)" || $(MKDIR_P) "$(DESTDIR)$(pkgconfigdir)" + @list='$(pkgconfig_DATA)'; test -n "$(pkgconfigdir)" || list=; \ + for p in $$list; do \ + if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \ + echo "$$d$$p"; \ + done | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_DATA) $$files '$(DESTDIR)$(pkgconfigdir)'"; \ + $(INSTALL_DATA) $$files "$(DESTDIR)$(pkgconfigdir)" || exit $$?; \ + done + +uninstall-pkgconfigDATA: + @$(NORMAL_UNINSTALL) + @list='$(pkgconfig_DATA)'; test -n "$(pkgconfigdir)" || list=; \ + files=`for p in $$list; do echo $$p; done | sed -e 's|^.*/||'`; \ + test -n "$$files" || exit 0; \ + echo " ( cd '$(DESTDIR)$(pkgconfigdir)' && rm -f" $$files ")"; \ + cd "$(DESTDIR)$(pkgconfigdir)" && rm -f $$files +install-includeHEADERS: $(include_HEADERS) + @$(NORMAL_INSTALL) + test -z "$(includedir)" || $(MKDIR_P) "$(DESTDIR)$(includedir)" + @list='$(include_HEADERS)'; test -n "$(includedir)" || list=; \ + for p in $$list; do \ + if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \ + echo "$$d$$p"; \ + done | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_HEADER) $$files '$(DESTDIR)$(includedir)'"; \ + $(INSTALL_HEADER) $$files "$(DESTDIR)$(includedir)" || exit $$?; \ + done + +uninstall-includeHEADERS: + @$(NORMAL_UNINSTALL) + @list='$(include_HEADERS)'; test -n "$(includedir)" || list=; \ + files=`for p in $$list; do echo $$p; done | sed -e 's|^.*/||'`; \ + test -n "$$files" || exit 0; \ + echo " ( cd '$(DESTDIR)$(includedir)' && rm -f" $$files ")"; \ + cd "$(DESTDIR)$(includedir)" && rm -f $$files + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done +check-am: all-am +check: $(BUILT_SOURCES) + $(MAKE) $(AM_MAKEFLAGS) check-am +all-am: Makefile $(LTLIBRARIES) $(DATA) $(HEADERS) +installdirs: + for dir in "$(DESTDIR)$(libdir)" "$(DESTDIR)$(pkgconfigdir)" "$(DESTDIR)$(includedir)"; do \ + test -z "$$dir" || $(MKDIR_P) "$$dir"; \ + done +install: $(BUILT_SOURCES) + $(MAKE) $(AM_MAKEFLAGS) install-am +install-exec: install-exec-am +install-data: install-data-am +uninstall: uninstall-am + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-am +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." + -rm -f grammar.c + -rm -f grammar.h + -rm -f scanner.c + -test -z "$(BUILT_SOURCES)" || rm -f $(BUILT_SOURCES) +clean: clean-am + +clean-am: clean-generic clean-libLTLIBRARIES clean-libtool \ + mostlyclean-am + +distclean: distclean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +distclean-am: clean-am distclean-compile distclean-generic \ + distclean-tags + +dvi: dvi-am + +dvi-am: + +html: html-am + +html-am: + +info: info-am + +info-am: + +install-data-am: install-includeHEADERS install-pkgconfigDATA + +install-dvi: install-dvi-am + +install-dvi-am: + +install-exec-am: install-libLTLIBRARIES + +install-html: install-html-am + +install-html-am: + +install-info: install-info-am + +install-info-am: + +install-man: + +install-pdf: install-pdf-am + +install-pdf-am: + +install-ps: install-ps-am + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-am + +mostlyclean-am: mostlyclean-compile mostlyclean-generic \ + mostlyclean-libtool + +pdf: pdf-am + +pdf-am: + +ps: ps-am + +ps-am: + +uninstall-am: uninstall-includeHEADERS uninstall-libLTLIBRARIES \ + uninstall-pkgconfigDATA + +.MAKE: all check install install-am install-strip + +.PHONY: CTAGS GTAGS all all-am check check-am clean clean-generic \ + clean-libLTLIBRARIES clean-libtool ctags distclean \ + distclean-compile distclean-generic distclean-libtool \ + distclean-tags distdir dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-includeHEADERS install-info \ + install-info-am install-libLTLIBRARIES install-man install-pdf \ + install-pdf-am install-pkgconfigDATA install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + maintainer-clean maintainer-clean-generic mostlyclean \ + mostlyclean-compile mostlyclean-generic mostlyclean-libtool \ + pdf pdf-am ps ps-am tags uninstall uninstall-am \ + uninstall-includeHEADERS uninstall-libLTLIBRARIES \ + uninstall-pkgconfigDATA + + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/lib/Makefile.am b/libconfig-1.4.9/lib/Makefile.am new file mode 100644 index 0000000000000000000000000000000000000000..5c1c4e06f85de874e058abc5bd68200afccc675d --- /dev/null +++ b/libconfig-1.4.9/lib/Makefile.am @@ -0,0 +1,80 @@ + +lib_LTLIBRARIES = libconfig.la + +if BUILDCXX +lib_LTLIBRARIES += libconfig++.la +endif + +# Versioning rules ( C:R:A ) +# +# Perform EACH step that applies. +# +# 1. Start with version 0:0:0. +# 2. If any of the sources have changed, increment R. This is a new revision +# of the current interface. +# 3. If the interface has changed, increment C and set R to 0. This is the +# first revision of a new interface. +# 4. If the interface has changed, and the new interface is a superset of the +# previous interface (that is, if the previous interface has not been +# broken by the changes in this new release), increment A. This release is +# backwards compatible with the previous release. +# 5. If the new interface has removed elements with respect to the +# previous interface, then backward compatibility is broken; set A to 0. +# This release has a new, but backwards incompatible interface. +# +# For more info see section 6.3 of the GNU Libtool Manual. + +VERINFO = -version-info 10:3:1 + +PARSER_PREFIX = libconfig_yy + +libconfig_la_LDFLAGS = $(VERINFO) -no-undefined + +libconfig___la_LDFLAGS = $(VERINFO) -no-undefined + +libsrc = libconfig.c scanner.l grammar.y parsectx.h wincompat.h \ + scanctx.c scanctx.h strbuf.c strbuf.h +libinc = libconfig.h + +libsrc_cpp = $(libsrc) libconfigcpp.c++ +libinc_cpp = libconfig.h++ + +BUILT_SOURCES = scanner.c scanner.h grammar.c grammar.h + +libconfig_la_SOURCES = $(libsrc) + +libconfig___la_SOURCES = $(libsrc_cpp) + +libcppflags = -D_REENTRANT +libcppxxflags = -D_REENTRANT + +if GNU_WIN +libcppflags += -DLIBCONFIG_EXPORTS +libcppxxflags += -DLIBCONFIGXX_EXPORTS -DLIBCONFIG_STATIC +endif + +libconfig_la_CPPFLAGS = -DPARSER_PREFIX=\"$(PARSER_PREFIX)\" $(libcppflags) +libconfig___la_CPPFLAGS = -DPARSER_PREFIX=\"$(PARSER_PREFIX)\" $(libcppxxflags) + +include_HEADERS = $(libinc) + +if BUILDCXX +include_HEADERS += $(libinc_cpp) +endif + +AM_YFLAGS = -d -p $(PARSER_PREFIX) + +AM_LFLAGS = --header-file=scanner.h --prefix=$(PARSER_PREFIX) + +EXTRA_DIST = \ + $(BUILT_SOURCES) \ + libconfigcpp.cc libconfig.hh \ + *.vcproj + +pkgconfigdir = $(libdir)/pkgconfig + +pkgconfig_DATA = libconfig.pc + +if BUILDCXX +pkgconfig_DATA += libconfig++.pc +endif diff --git a/libconfig-1.4.9/lib/Makefile.in b/libconfig-1.4.9/lib/Makefile.in new file mode 100644 index 0000000000000000000000000000000000000000..3ff722ba4b1d853ee5ee821543e3d5c16a80b194 --- /dev/null +++ b/libconfig-1.4.9/lib/Makefile.in @@ -0,0 +1,795 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# @configure_input@ + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + +@SET_MAKE@ + + + +VPATH = @srcdir@ +pkgdatadir = $(datadir)/@PACKAGE@ +pkgincludedir = $(includedir)/@PACKAGE@ +pkglibdir = $(libdir)/@PACKAGE@ +pkglibexecdir = $(libexecdir)/@PACKAGE@ +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = @build@ +host_triplet = @host@ +target_triplet = @target@ +@BUILDCXX_TRUE@am__append_1 = libconfig++.la +@GNU_WIN_TRUE@am__append_2 = -DLIBCONFIG_EXPORTS +@GNU_WIN_TRUE@am__append_3 = -DLIBCONFIGXX_EXPORTS -DLIBCONFIG_STATIC +@BUILDCXX_TRUE@am__append_4 = $(libinc_cpp) +@BUILDCXX_TRUE@am__append_5 = libconfig++.pc +subdir = lib +DIST_COMMON = $(am__include_HEADERS_DIST) $(srcdir)/Makefile.am \ + $(srcdir)/Makefile.in $(srcdir)/libconfig++.pc.in \ + $(srcdir)/libconfig.pc.in grammar.c grammar.h scanner.c +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = libconfig.pc libconfig++.pc +CONFIG_CLEAN_VPATH_FILES = +am__vpath_adj_setup = srcdirstrip=`echo "$(srcdir)" | sed 's|.|.|g'`; +am__vpath_adj = case $$p in \ + $(srcdir)/*) f=`echo "$$p" | sed "s|^$$srcdirstrip/||"`;; \ + *) f=$$p;; \ + esac; +am__strip_dir = f=`echo $$p | sed -e 's|^.*/||'`; +am__install_max = 40 +am__nobase_strip_setup = \ + srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*|]/\\\\&/g'` +am__nobase_strip = \ + for p in $$list; do echo "$$p"; done | sed -e "s|$$srcdirstrip/||" +am__nobase_list = $(am__nobase_strip_setup); \ + for p in $$list; do echo "$$p $$p"; done | \ + sed "s| $$srcdirstrip/| |;"' / .*\//!s/ .*/ ./; s,\( .*\)/[^/]*$$,\1,' | \ + $(AWK) 'BEGIN { files["."] = "" } { files[$$2] = files[$$2] " " $$1; \ + if (++n[$$2] == $(am__install_max)) \ + { print $$2, files[$$2]; n[$$2] = 0; files[$$2] = "" } } \ + END { for (dir in files) print dir, files[dir] }' +am__base_list = \ + sed '$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;$$!N;s/\n/ /g' | \ + sed '$$!N;$$!N;$$!N;$$!N;s/\n/ /g' +am__installdirs = "$(DESTDIR)$(libdir)" "$(DESTDIR)$(pkgconfigdir)" \ + "$(DESTDIR)$(includedir)" +LTLIBRARIES = $(lib_LTLIBRARIES) +libconfig___la_LIBADD = +am__objects_1 = libconfig___la-libconfig.lo libconfig___la-scanner.lo \ + libconfig___la-grammar.lo libconfig___la-scanctx.lo \ + libconfig___la-strbuf.lo +am__objects_2 = $(am__objects_1) libconfig___la-libconfigcpp.lo +am_libconfig___la_OBJECTS = $(am__objects_2) +libconfig___la_OBJECTS = $(am_libconfig___la_OBJECTS) +libconfig___la_LINK = $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) \ + $(LIBTOOLFLAGS) --mode=link $(CXXLD) $(AM_CXXFLAGS) \ + $(CXXFLAGS) $(libconfig___la_LDFLAGS) $(LDFLAGS) -o $@ +@BUILDCXX_TRUE@am_libconfig___la_rpath = -rpath $(libdir) +libconfig_la_LIBADD = +am__objects_3 = libconfig_la-libconfig.lo libconfig_la-scanner.lo \ + libconfig_la-grammar.lo libconfig_la-scanctx.lo \ + libconfig_la-strbuf.lo +am_libconfig_la_OBJECTS = $(am__objects_3) +libconfig_la_OBJECTS = $(am_libconfig_la_OBJECTS) +libconfig_la_LINK = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) \ + $(LIBTOOLFLAGS) --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) \ + $(libconfig_la_LDFLAGS) $(LDFLAGS) -o $@ +DEFAULT_INCLUDES = -I.@am__isrc@ -I$(top_builddir) +depcomp = $(SHELL) $(top_srcdir)/aux-build/depcomp +am__depfiles_maybe = depfiles +am__mv = mv -f +COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +LTCOMPILE = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +CCLD = $(CC) +LINK = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) $(AM_LDFLAGS) \ + $(LDFLAGS) -o $@ +CXXCOMPILE = $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS) +LTCXXCOMPILE = $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS) +CXXLD = $(CXX) +CXXLINK = $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=link $(CXXLD) $(AM_CXXFLAGS) $(CXXFLAGS) $(AM_LDFLAGS) \ + $(LDFLAGS) -o $@ +LEXCOMPILE = $(LEX) $(LFLAGS) $(AM_LFLAGS) +LTLEXCOMPILE = $(LIBTOOL) $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(LEX) $(LFLAGS) $(AM_LFLAGS) +YLWRAP = $(top_srcdir)/aux-build/ylwrap +YACCCOMPILE = $(YACC) $(YFLAGS) $(AM_YFLAGS) +LTYACCCOMPILE = $(LIBTOOL) $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(YACC) $(YFLAGS) $(AM_YFLAGS) +SOURCES = $(libconfig___la_SOURCES) $(libconfig_la_SOURCES) +DIST_SOURCES = $(libconfig___la_SOURCES) $(libconfig_la_SOURCES) +DATA = $(pkgconfig_DATA) +am__include_HEADERS_DIST = libconfig.h libconfig.h++ +HEADERS = $(include_HEADERS) +ETAGS = etags +CTAGS = ctags +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +ACLOCAL = @ACLOCAL@ +AMTAR = @AMTAR@ +AR = @AR@ +AS = @AS@ +AUTOCONF = @AUTOCONF@ +AUTOHEADER = @AUTOHEADER@ +AUTOMAKE = @AUTOMAKE@ +AWK = @AWK@ +CC = @CC@ +CCDEPMODE = @CCDEPMODE@ +CFLAGS = @CFLAGS@ +CPP = @CPP@ +CPPFLAGS = @CPPFLAGS@ +CXX = @CXX@ +CXXCPP = @CXXCPP@ +CXXDEPMODE = @CXXDEPMODE@ +CXXFLAGS = @CXXFLAGS@ +CYGPATH_W = @CYGPATH_W@ +DEFS = @DEFS@ +DEPDIR = @DEPDIR@ +DLLTOOL = @DLLTOOL@ +DSYMUTIL = @DSYMUTIL@ +DUMPBIN = @DUMPBIN@ +ECHO_C = @ECHO_C@ +ECHO_N = @ECHO_N@ +ECHO_T = @ECHO_T@ +EGREP = @EGREP@ +EXEEXT = @EXEEXT@ +FGREP = @FGREP@ +GREP = @GREP@ +INSTALL = @INSTALL@ +INSTALL_DATA = @INSTALL_DATA@ +INSTALL_PROGRAM = @INSTALL_PROGRAM@ +INSTALL_SCRIPT = @INSTALL_SCRIPT@ +INSTALL_STRIP_PROGRAM = @INSTALL_STRIP_PROGRAM@ +LD = @LD@ +LDFLAGS = @LDFLAGS@ +LEX = @LEX@ +LEXLIB = @LEXLIB@ +LEX_OUTPUT_ROOT = @LEX_OUTPUT_ROOT@ +LIBOBJS = @LIBOBJS@ +LIBS = @LIBS@ +LIBTOOL = @LIBTOOL@ +LIPO = @LIPO@ +LN_S = @LN_S@ +LTLIBOBJS = @LTLIBOBJS@ +MAKEINFO = @MAKEINFO@ +MANIFEST_TOOL = @MANIFEST_TOOL@ +MKDIR_P = @MKDIR_P@ +NM = @NM@ +NMEDIT = @NMEDIT@ +OBJDUMP = @OBJDUMP@ +OBJEXT = @OBJEXT@ +OTOOL = @OTOOL@ +OTOOL64 = @OTOOL64@ +PACKAGE = @PACKAGE@ +PACKAGE_BUGREPORT = @PACKAGE_BUGREPORT@ +PACKAGE_NAME = @PACKAGE_NAME@ +PACKAGE_STRING = @PACKAGE_STRING@ +PACKAGE_TARNAME = @PACKAGE_TARNAME@ +PACKAGE_URL = @PACKAGE_URL@ +PACKAGE_VERSION = @PACKAGE_VERSION@ +PATH_SEPARATOR = @PATH_SEPARATOR@ +RANLIB = @RANLIB@ +SED = @SED@ +SET_MAKE = @SET_MAKE@ +SHELL = @SHELL@ +STRIP = @STRIP@ +VERSION = @VERSION@ +YACC = @YACC@ +YFLAGS = @YFLAGS@ +abs_builddir = @abs_builddir@ +abs_srcdir = @abs_srcdir@ +abs_top_builddir = @abs_top_builddir@ +abs_top_srcdir = @abs_top_srcdir@ +ac_ct_AR = @ac_ct_AR@ +ac_ct_CC = @ac_ct_CC@ +ac_ct_CXX = @ac_ct_CXX@ +ac_ct_DUMPBIN = @ac_ct_DUMPBIN@ +am__include = @am__include@ +am__leading_dot = @am__leading_dot@ +am__quote = @am__quote@ +am__tar = @am__tar@ +am__untar = @am__untar@ +bindir = @bindir@ +build = @build@ +build_alias = @build_alias@ +build_cpu = @build_cpu@ +build_os = @build_os@ +build_vendor = @build_vendor@ +builddir = @builddir@ +datadir = @datadir@ +datarootdir = @datarootdir@ +docdir = @docdir@ +dvidir = @dvidir@ +exec_prefix = @exec_prefix@ +host = @host@ +host_alias = @host_alias@ +host_cpu = @host_cpu@ +host_os = @host_os@ +host_vendor = @host_vendor@ +htmldir = @htmldir@ +includedir = @includedir@ +infodir = @infodir@ +install_sh = @install_sh@ +libdir = @libdir@ +libexecdir = @libexecdir@ +localedir = @localedir@ +localstatedir = @localstatedir@ +mandir = @mandir@ +mkdir_p = @mkdir_p@ +oldincludedir = @oldincludedir@ +pdfdir = @pdfdir@ +prefix = @prefix@ +program_transform_name = @program_transform_name@ +psdir = @psdir@ +sbindir = @sbindir@ +sharedstatedir = @sharedstatedir@ +srcdir = @srcdir@ +sysconfdir = @sysconfdir@ +target = @target@ +target_alias = @target_alias@ +target_cpu = @target_cpu@ +target_os = @target_os@ +target_vendor = @target_vendor@ +top_build_prefix = @top_build_prefix@ +top_builddir = @top_builddir@ +top_srcdir = @top_srcdir@ +lib_LTLIBRARIES = libconfig.la $(am__append_1) + +# Versioning rules ( C:R:A ) +# +# Perform EACH step that applies. +# +# 1. Start with version 0:0:0. +# 2. If any of the sources have changed, increment R. This is a new revision +# of the current interface. +# 3. If the interface has changed, increment C and set R to 0. This is the +# first revision of a new interface. +# 4. If the interface has changed, and the new interface is a superset of the +# previous interface (that is, if the previous interface has not been +# broken by the changes in this new release), increment A. This release is +# backwards compatible with the previous release. +# 5. If the new interface has removed elements with respect to the +# previous interface, then backward compatibility is broken; set A to 0. +# This release has a new, but backwards incompatible interface. +# +# For more info see section 6.3 of the GNU Libtool Manual. +VERINFO = -version-info 10:3:1 +PARSER_PREFIX = libconfig_yy +libconfig_la_LDFLAGS = $(VERINFO) -no-undefined +libconfig___la_LDFLAGS = $(VERINFO) -no-undefined +libsrc = libconfig.c scanner.l grammar.y parsectx.h wincompat.h \ + scanctx.c scanctx.h strbuf.c strbuf.h + +libinc = libconfig.h +libsrc_cpp = $(libsrc) libconfigcpp.c++ +libinc_cpp = libconfig.h++ +BUILT_SOURCES = scanner.c scanner.h grammar.c grammar.h +libconfig_la_SOURCES = $(libsrc) +libconfig___la_SOURCES = $(libsrc_cpp) +libcppflags = -D_REENTRANT $(am__append_2) +libcppxxflags = -D_REENTRANT $(am__append_3) +libconfig_la_CPPFLAGS = -DPARSER_PREFIX=\"$(PARSER_PREFIX)\" $(libcppflags) +libconfig___la_CPPFLAGS = -DPARSER_PREFIX=\"$(PARSER_PREFIX)\" $(libcppxxflags) +include_HEADERS = $(libinc) $(am__append_4) +AM_YFLAGS = -d -p $(PARSER_PREFIX) +AM_LFLAGS = --header-file=scanner.h --prefix=$(PARSER_PREFIX) +EXTRA_DIST = \ + $(BUILT_SOURCES) \ + libconfigcpp.cc libconfig.hh \ + *.vcproj + +pkgconfigdir = $(libdir)/pkgconfig +pkgconfig_DATA = libconfig.pc $(am__append_5) +all: $(BUILT_SOURCES) + $(MAKE) $(AM_MAKEFLAGS) all-am + +.SUFFIXES: +.SUFFIXES: .c .c++ .l .lo .o .obj .y +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu lib/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu lib/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): +libconfig.pc: $(top_builddir)/config.status $(srcdir)/libconfig.pc.in + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ +libconfig++.pc: $(top_builddir)/config.status $(srcdir)/libconfig++.pc.in + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ +install-libLTLIBRARIES: $(lib_LTLIBRARIES) + @$(NORMAL_INSTALL) + test -z "$(libdir)" || $(MKDIR_P) "$(DESTDIR)$(libdir)" + @list='$(lib_LTLIBRARIES)'; test -n "$(libdir)" || list=; \ + list2=; for p in $$list; do \ + if test -f $$p; then \ + list2="$$list2 $$p"; \ + else :; fi; \ + done; \ + test -z "$$list2" || { \ + echo " $(LIBTOOL) $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=install $(INSTALL) $(INSTALL_STRIP_FLAG) $$list2 '$(DESTDIR)$(libdir)'"; \ + $(LIBTOOL) $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=install $(INSTALL) $(INSTALL_STRIP_FLAG) $$list2 "$(DESTDIR)$(libdir)"; \ + } + +uninstall-libLTLIBRARIES: + @$(NORMAL_UNINSTALL) + @list='$(lib_LTLIBRARIES)'; test -n "$(libdir)" || list=; \ + for p in $$list; do \ + $(am__strip_dir) \ + echo " $(LIBTOOL) $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=uninstall rm -f '$(DESTDIR)$(libdir)/$$f'"; \ + $(LIBTOOL) $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=uninstall rm -f "$(DESTDIR)$(libdir)/$$f"; \ + done + +clean-libLTLIBRARIES: + -test -z "$(lib_LTLIBRARIES)" || rm -f $(lib_LTLIBRARIES) + @list='$(lib_LTLIBRARIES)'; for p in $$list; do \ + dir="`echo $$p | sed -e 's|/[^/]*$$||'`"; \ + test "$$dir" != "$$p" || dir=.; \ + echo "rm -f \"$${dir}/so_locations\""; \ + rm -f "$${dir}/so_locations"; \ + done +grammar.h: grammar.c + @if test ! -f $@; then \ + rm -f grammar.c; \ + $(MAKE) $(AM_MAKEFLAGS) grammar.c; \ + else :; fi +libconfig++.la: $(libconfig___la_OBJECTS) $(libconfig___la_DEPENDENCIES) + $(libconfig___la_LINK) $(am_libconfig___la_rpath) $(libconfig___la_OBJECTS) $(libconfig___la_LIBADD) $(LIBS) +libconfig.la: $(libconfig_la_OBJECTS) $(libconfig_la_DEPENDENCIES) + $(libconfig_la_LINK) -rpath $(libdir) $(libconfig_la_OBJECTS) $(libconfig_la_LIBADD) $(LIBS) + +mostlyclean-compile: + -rm -f *.$(OBJEXT) + +distclean-compile: + -rm -f *.tab.c + +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/libconfig___la-grammar.Plo@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/libconfig___la-libconfig.Plo@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/libconfig___la-libconfigcpp.Plo@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/libconfig___la-scanctx.Plo@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/libconfig___la-scanner.Plo@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/libconfig___la-strbuf.Plo@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/libconfig_la-grammar.Plo@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/libconfig_la-libconfig.Plo@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/libconfig_la-scanctx.Plo@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/libconfig_la-scanner.Plo@am__quote@ +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/libconfig_la-strbuf.Plo@am__quote@ + +.c.o: +@am__fastdepCC_TRUE@ $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='$<' object='$@' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(COMPILE) -c $< + +.c.obj: +@am__fastdepCC_TRUE@ $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'` +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='$<' object='$@' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(COMPILE) -c `$(CYGPATH_W) '$<'` + +.c.lo: +@am__fastdepCC_TRUE@ $(LTCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='$<' object='$@' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LTCOMPILE) -c -o $@ $< + +libconfig___la-libconfig.lo: libconfig.c +@am__fastdepCC_TRUE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig___la-libconfig.lo -MD -MP -MF $(DEPDIR)/libconfig___la-libconfig.Tpo -c -o libconfig___la-libconfig.lo `test -f 'libconfig.c' || echo '$(srcdir)/'`libconfig.c +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/libconfig___la-libconfig.Tpo $(DEPDIR)/libconfig___la-libconfig.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='libconfig.c' object='libconfig___la-libconfig.lo' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig___la-libconfig.lo `test -f 'libconfig.c' || echo '$(srcdir)/'`libconfig.c + +libconfig___la-scanner.lo: scanner.c +@am__fastdepCC_TRUE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig___la-scanner.lo -MD -MP -MF $(DEPDIR)/libconfig___la-scanner.Tpo -c -o libconfig___la-scanner.lo `test -f 'scanner.c' || echo '$(srcdir)/'`scanner.c +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/libconfig___la-scanner.Tpo $(DEPDIR)/libconfig___la-scanner.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='scanner.c' object='libconfig___la-scanner.lo' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig___la-scanner.lo `test -f 'scanner.c' || echo '$(srcdir)/'`scanner.c + +libconfig___la-grammar.lo: grammar.c +@am__fastdepCC_TRUE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig___la-grammar.lo -MD -MP -MF $(DEPDIR)/libconfig___la-grammar.Tpo -c -o libconfig___la-grammar.lo `test -f 'grammar.c' || echo '$(srcdir)/'`grammar.c +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/libconfig___la-grammar.Tpo $(DEPDIR)/libconfig___la-grammar.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='grammar.c' object='libconfig___la-grammar.lo' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig___la-grammar.lo `test -f 'grammar.c' || echo '$(srcdir)/'`grammar.c + +libconfig___la-scanctx.lo: scanctx.c +@am__fastdepCC_TRUE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig___la-scanctx.lo -MD -MP -MF $(DEPDIR)/libconfig___la-scanctx.Tpo -c -o libconfig___la-scanctx.lo `test -f 'scanctx.c' || echo '$(srcdir)/'`scanctx.c +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/libconfig___la-scanctx.Tpo $(DEPDIR)/libconfig___la-scanctx.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='scanctx.c' object='libconfig___la-scanctx.lo' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig___la-scanctx.lo `test -f 'scanctx.c' || echo '$(srcdir)/'`scanctx.c + +libconfig___la-strbuf.lo: strbuf.c +@am__fastdepCC_TRUE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig___la-strbuf.lo -MD -MP -MF $(DEPDIR)/libconfig___la-strbuf.Tpo -c -o libconfig___la-strbuf.lo `test -f 'strbuf.c' || echo '$(srcdir)/'`strbuf.c +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/libconfig___la-strbuf.Tpo $(DEPDIR)/libconfig___la-strbuf.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='strbuf.c' object='libconfig___la-strbuf.lo' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig___la-strbuf.lo `test -f 'strbuf.c' || echo '$(srcdir)/'`strbuf.c + +libconfig_la-libconfig.lo: libconfig.c +@am__fastdepCC_TRUE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_la-libconfig.lo -MD -MP -MF $(DEPDIR)/libconfig_la-libconfig.Tpo -c -o libconfig_la-libconfig.lo `test -f 'libconfig.c' || echo '$(srcdir)/'`libconfig.c +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/libconfig_la-libconfig.Tpo $(DEPDIR)/libconfig_la-libconfig.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='libconfig.c' object='libconfig_la-libconfig.lo' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_la-libconfig.lo `test -f 'libconfig.c' || echo '$(srcdir)/'`libconfig.c + +libconfig_la-scanner.lo: scanner.c +@am__fastdepCC_TRUE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_la-scanner.lo -MD -MP -MF $(DEPDIR)/libconfig_la-scanner.Tpo -c -o libconfig_la-scanner.lo `test -f 'scanner.c' || echo '$(srcdir)/'`scanner.c +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/libconfig_la-scanner.Tpo $(DEPDIR)/libconfig_la-scanner.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='scanner.c' object='libconfig_la-scanner.lo' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_la-scanner.lo `test -f 'scanner.c' || echo '$(srcdir)/'`scanner.c + +libconfig_la-grammar.lo: grammar.c +@am__fastdepCC_TRUE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_la-grammar.lo -MD -MP -MF $(DEPDIR)/libconfig_la-grammar.Tpo -c -o libconfig_la-grammar.lo `test -f 'grammar.c' || echo '$(srcdir)/'`grammar.c +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/libconfig_la-grammar.Tpo $(DEPDIR)/libconfig_la-grammar.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='grammar.c' object='libconfig_la-grammar.lo' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_la-grammar.lo `test -f 'grammar.c' || echo '$(srcdir)/'`grammar.c + +libconfig_la-scanctx.lo: scanctx.c +@am__fastdepCC_TRUE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_la-scanctx.lo -MD -MP -MF $(DEPDIR)/libconfig_la-scanctx.Tpo -c -o libconfig_la-scanctx.lo `test -f 'scanctx.c' || echo '$(srcdir)/'`scanctx.c +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/libconfig_la-scanctx.Tpo $(DEPDIR)/libconfig_la-scanctx.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='scanctx.c' object='libconfig_la-scanctx.lo' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_la-scanctx.lo `test -f 'scanctx.c' || echo '$(srcdir)/'`scanctx.c + +libconfig_la-strbuf.lo: strbuf.c +@am__fastdepCC_TRUE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_la-strbuf.lo -MD -MP -MF $(DEPDIR)/libconfig_la-strbuf.Tpo -c -o libconfig_la-strbuf.lo `test -f 'strbuf.c' || echo '$(srcdir)/'`strbuf.c +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/libconfig_la-strbuf.Tpo $(DEPDIR)/libconfig_la-strbuf.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='strbuf.c' object='libconfig_la-strbuf.lo' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_la_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_la-strbuf.lo `test -f 'strbuf.c' || echo '$(srcdir)/'`strbuf.c + +.c++.o: +@am__fastdepCXX_TRUE@ $(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< +@am__fastdepCXX_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ source='$<' object='$@' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCXX_FALSE@ $(CXXCOMPILE) -c -o $@ $< + +.c++.obj: +@am__fastdepCXX_TRUE@ $(CXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'` +@am__fastdepCXX_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ source='$<' object='$@' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCXX_FALSE@ $(CXXCOMPILE) -c -o $@ `$(CYGPATH_W) '$<'` + +.c++.lo: +@am__fastdepCXX_TRUE@ $(LTCXXCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< +@am__fastdepCXX_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ source='$<' object='$@' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCXX_FALSE@ $(LTCXXCOMPILE) -c -o $@ $< + +libconfig___la-libconfigcpp.lo: libconfigcpp.c++ +@am__fastdepCXX_TRUE@ $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS) -MT libconfig___la-libconfigcpp.lo -MD -MP -MF $(DEPDIR)/libconfig___la-libconfigcpp.Tpo -c -o libconfig___la-libconfigcpp.lo `test -f 'libconfigcpp.c++' || echo '$(srcdir)/'`libconfigcpp.c++ +@am__fastdepCXX_TRUE@ $(am__mv) $(DEPDIR)/libconfig___la-libconfigcpp.Tpo $(DEPDIR)/libconfig___la-libconfigcpp.Plo +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ source='libconfigcpp.c++' object='libconfig___la-libconfigcpp.lo' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCXX_FALSE@ DEPDIR=$(DEPDIR) $(CXXDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCXX_FALSE@ $(LIBTOOL) --tag=CXX $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) --mode=compile $(CXX) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig___la_CPPFLAGS) $(CPPFLAGS) $(AM_CXXFLAGS) $(CXXFLAGS) -c -o libconfig___la-libconfigcpp.lo `test -f 'libconfigcpp.c++' || echo '$(srcdir)/'`libconfigcpp.c++ + +.l.c: + $(am__skiplex) $(SHELL) $(YLWRAP) $< $(LEX_OUTPUT_ROOT).c $@ -- $(LEXCOMPILE) + +.y.c: + $(am__skipyacc) $(SHELL) $(YLWRAP) $< y.tab.c $@ y.tab.h $*.h y.output $*.output -- $(YACCCOMPILE) + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs +install-pkgconfigDATA: $(pkgconfig_DATA) + @$(NORMAL_INSTALL) + test -z "$(pkgconfigdir)" || $(MKDIR_P) "$(DESTDIR)$(pkgconfigdir)" + @list='$(pkgconfig_DATA)'; test -n "$(pkgconfigdir)" || list=; \ + for p in $$list; do \ + if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \ + echo "$$d$$p"; \ + done | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_DATA) $$files '$(DESTDIR)$(pkgconfigdir)'"; \ + $(INSTALL_DATA) $$files "$(DESTDIR)$(pkgconfigdir)" || exit $$?; \ + done + +uninstall-pkgconfigDATA: + @$(NORMAL_UNINSTALL) + @list='$(pkgconfig_DATA)'; test -n "$(pkgconfigdir)" || list=; \ + files=`for p in $$list; do echo $$p; done | sed -e 's|^.*/||'`; \ + test -n "$$files" || exit 0; \ + echo " ( cd '$(DESTDIR)$(pkgconfigdir)' && rm -f" $$files ")"; \ + cd "$(DESTDIR)$(pkgconfigdir)" && rm -f $$files +install-includeHEADERS: $(include_HEADERS) + @$(NORMAL_INSTALL) + test -z "$(includedir)" || $(MKDIR_P) "$(DESTDIR)$(includedir)" + @list='$(include_HEADERS)'; test -n "$(includedir)" || list=; \ + for p in $$list; do \ + if test -f "$$p"; then d=; else d="$(srcdir)/"; fi; \ + echo "$$d$$p"; \ + done | $(am__base_list) | \ + while read files; do \ + echo " $(INSTALL_HEADER) $$files '$(DESTDIR)$(includedir)'"; \ + $(INSTALL_HEADER) $$files "$(DESTDIR)$(includedir)" || exit $$?; \ + done + +uninstall-includeHEADERS: + @$(NORMAL_UNINSTALL) + @list='$(include_HEADERS)'; test -n "$(includedir)" || list=; \ + files=`for p in $$list; do echo $$p; done | sed -e 's|^.*/||'`; \ + test -n "$$files" || exit 0; \ + echo " ( cd '$(DESTDIR)$(includedir)' && rm -f" $$files ")"; \ + cd "$(DESTDIR)$(includedir)" && rm -f $$files + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done +check-am: all-am +check: $(BUILT_SOURCES) + $(MAKE) $(AM_MAKEFLAGS) check-am +all-am: Makefile $(LTLIBRARIES) $(DATA) $(HEADERS) +installdirs: + for dir in "$(DESTDIR)$(libdir)" "$(DESTDIR)$(pkgconfigdir)" "$(DESTDIR)$(includedir)"; do \ + test -z "$$dir" || $(MKDIR_P) "$$dir"; \ + done +install: $(BUILT_SOURCES) + $(MAKE) $(AM_MAKEFLAGS) install-am +install-exec: install-exec-am +install-data: install-data-am +uninstall: uninstall-am + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-am +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." + -rm -f grammar.c + -rm -f grammar.h + -rm -f scanner.c + -test -z "$(BUILT_SOURCES)" || rm -f $(BUILT_SOURCES) +clean: clean-am + +clean-am: clean-generic clean-libLTLIBRARIES clean-libtool \ + mostlyclean-am + +distclean: distclean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +distclean-am: clean-am distclean-compile distclean-generic \ + distclean-tags + +dvi: dvi-am + +dvi-am: + +html: html-am + +html-am: + +info: info-am + +info-am: + +install-data-am: install-includeHEADERS install-pkgconfigDATA + +install-dvi: install-dvi-am + +install-dvi-am: + +install-exec-am: install-libLTLIBRARIES + +install-html: install-html-am + +install-html-am: + +install-info: install-info-am + +install-info-am: + +install-man: + +install-pdf: install-pdf-am + +install-pdf-am: + +install-ps: install-ps-am + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-am + +mostlyclean-am: mostlyclean-compile mostlyclean-generic \ + mostlyclean-libtool + +pdf: pdf-am + +pdf-am: + +ps: ps-am + +ps-am: + +uninstall-am: uninstall-includeHEADERS uninstall-libLTLIBRARIES \ + uninstall-pkgconfigDATA + +.MAKE: all check install install-am install-strip + +.PHONY: CTAGS GTAGS all all-am check check-am clean clean-generic \ + clean-libLTLIBRARIES clean-libtool ctags distclean \ + distclean-compile distclean-generic distclean-libtool \ + distclean-tags distdir dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-includeHEADERS install-info \ + install-info-am install-libLTLIBRARIES install-man install-pdf \ + install-pdf-am install-pkgconfigDATA install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + maintainer-clean maintainer-clean-generic mostlyclean \ + mostlyclean-compile mostlyclean-generic mostlyclean-libtool \ + pdf pdf-am ps ps-am tags uninstall uninstall-am \ + uninstall-includeHEADERS uninstall-libLTLIBRARIES \ + uninstall-pkgconfigDATA + + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/lib/grammar.c b/libconfig-1.4.9/lib/grammar.c new file mode 100644 index 0000000000000000000000000000000000000000..e95a569f6d62a96b8195ffa587cf9b4940fa0a72 --- /dev/null +++ b/libconfig-1.4.9/lib/grammar.c @@ -0,0 +1,2001 @@ + +/* A Bison parser, made by GNU Bison 2.4.1. */ + +/* Skeleton implementation for Bison's Yacc-like parsers in C + + Copyright (C) 1984, 1989, 1990, 2000, 2001, 2002, 2003, 2004, 2005, 2006 + Free Software Foundation, Inc. + + This program is free software: you can redistribute it and/or modify + it under the terms of the GNU General Public License as published by + the Free Software Foundation, either version 3 of the License, or + (at your option) any later version. + + This program is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + GNU General Public License for more details. + + You should have received a copy of the GNU General Public License + along with this program. If not, see . */ + +/* As a special exception, you may create a larger work that contains + part or all of the Bison parser skeleton and distribute that work + under terms of your choice, so long as that work isn't itself a + parser generator using the skeleton or a modified version thereof + as a parser skeleton. Alternatively, if you modify or redistribute + the parser skeleton itself, you may (at your option) remove this + special exception, which will cause the skeleton and the resulting + Bison output files to be licensed under the GNU General Public + License without this special exception. + + This special exception was added by the Free Software Foundation in + version 2.2 of Bison. */ + +/* C LALR(1) parser skeleton written by Richard Stallman, by + simplifying the original so-called "semantic" parser. */ + +/* All symbols defined below should begin with yy or YY, to avoid + infringing on user name space. This should be done even for local + variables, as they might otherwise be expanded by user macros. + There are some unavoidable exceptions within include files to + define necessary library symbols; they are noted "INFRINGES ON + USER NAME SPACE" below. */ + +/* Identify Bison output. */ +#define YYBISON 1 + +/* Bison version. */ +#define YYBISON_VERSION "2.4.1" + +/* Skeleton name. */ +#define YYSKELETON_NAME "yacc.c" + +/* Pure parsers. */ +#define YYPURE 1 + +/* Push parsers. */ +#define YYPUSH 0 + +/* Pull parsers. */ +#define YYPULL 1 + +/* Using locations. */ +#define YYLSP_NEEDED 0 + +/* Substitute the variable and function names. */ +#define yyparse libconfig_yyparse +#define yylex libconfig_yylex +#define yyerror libconfig_yyerror +#define yylval libconfig_yylval +#define yychar libconfig_yychar +#define yydebug libconfig_yydebug +#define yynerrs libconfig_yynerrs + + +/* Copy the first part of user declarations. */ + +/* Line 189 of yacc.c */ +#line 32 "grammar.y" + +#include +#include +#include "libconfig.h" +#ifdef WIN32 +#include "wincompat.h" + +/* prevent warnings about redefined malloc/free in generated code: */ +#ifndef _STDLIB_H +#define _STDLIB_H +#endif + +#include +#endif +#include "parsectx.h" +#include "scanctx.h" + +/* these delcarations are provided to suppress compiler warnings */ +extern int libconfig_yylex(); +extern int libconfig_yyget_lineno(); + +static const char *err_array_elem_type = "mismatched element type in array"; +static const char *err_duplicate_setting = "duplicate setting name"; + +#define _delete(P) free((void *)(P)) + +#define IN_ARRAY() \ + (ctx->parent && (ctx->parent->type == CONFIG_TYPE_ARRAY)) + +#define IN_LIST() \ + (ctx->parent && (ctx->parent->type == CONFIG_TYPE_LIST)) + +static void capture_parse_pos(void *scanner, struct scan_context *scan_ctx, + config_setting_t *setting) +{ + setting->line = (unsigned int)libconfig_yyget_lineno(scanner); + setting->file = scanctx_current_filename(scan_ctx); +} + +#define CAPTURE_PARSE_POS(S) \ + capture_parse_pos(scanner, scan_ctx, (S)) + +void libconfig_yyerror(void *scanner, struct parse_context *ctx, + struct scan_context *scan_ctx, char const *s) +{ + if(ctx->config->error_text) return; + ctx->config->error_line = libconfig_yyget_lineno(scanner); + ctx->config->error_text = s; +} + + + +/* Line 189 of yacc.c */ +#line 134 "grammar.c" + +/* Enabling traces. */ +#ifndef YYDEBUG +# define YYDEBUG 0 +#endif + +/* Enabling verbose error messages. */ +#ifdef YYERROR_VERBOSE +# undef YYERROR_VERBOSE +# define YYERROR_VERBOSE 1 +#else +# define YYERROR_VERBOSE 0 +#endif + +/* Enabling the token table. */ +#ifndef YYTOKEN_TABLE +# define YYTOKEN_TABLE 0 +#endif + + +/* Tokens. */ +#ifndef YYTOKENTYPE +# define YYTOKENTYPE + /* Put the tokens into the symbol table, so that GDB and other debuggers + know about them. */ + enum yytokentype { + TOK_BOOLEAN = 258, + TOK_INTEGER = 259, + TOK_HEX = 260, + TOK_INTEGER64 = 261, + TOK_HEX64 = 262, + TOK_FLOAT = 263, + TOK_STRING = 264, + TOK_NAME = 265, + TOK_EQUALS = 266, + TOK_NEWLINE = 267, + TOK_ARRAY_START = 268, + TOK_ARRAY_END = 269, + TOK_LIST_START = 270, + TOK_LIST_END = 271, + TOK_COMMA = 272, + TOK_GROUP_START = 273, + TOK_GROUP_END = 274, + TOK_SEMICOLON = 275, + TOK_GARBAGE = 276, + TOK_ERROR = 277 + }; +#endif +/* Tokens. */ +#define TOK_BOOLEAN 258 +#define TOK_INTEGER 259 +#define TOK_HEX 260 +#define TOK_INTEGER64 261 +#define TOK_HEX64 262 +#define TOK_FLOAT 263 +#define TOK_STRING 264 +#define TOK_NAME 265 +#define TOK_EQUALS 266 +#define TOK_NEWLINE 267 +#define TOK_ARRAY_START 268 +#define TOK_ARRAY_END 269 +#define TOK_LIST_START 270 +#define TOK_LIST_END 271 +#define TOK_COMMA 272 +#define TOK_GROUP_START 273 +#define TOK_GROUP_END 274 +#define TOK_SEMICOLON 275 +#define TOK_GARBAGE 276 +#define TOK_ERROR 277 + + + + +#if ! defined YYSTYPE && ! defined YYSTYPE_IS_DECLARED +typedef union YYSTYPE +{ + +/* Line 214 of yacc.c */ +#line 85 "grammar.y" + + int ival; + long long llval; + double fval; + char *sval; + + + +/* Line 214 of yacc.c */ +#line 223 "grammar.c" +} YYSTYPE; +# define YYSTYPE_IS_TRIVIAL 1 +# define yystype YYSTYPE /* obsolescent; will be withdrawn */ +# define YYSTYPE_IS_DECLARED 1 +#endif + + +/* Copy the second part of user declarations. */ + + +/* Line 264 of yacc.c */ +#line 235 "grammar.c" + +#ifdef short +# undef short +#endif + +#ifdef YYTYPE_UINT8 +typedef YYTYPE_UINT8 yytype_uint8; +#else +typedef unsigned char yytype_uint8; +#endif + +#ifdef YYTYPE_INT8 +typedef YYTYPE_INT8 yytype_int8; +#elif (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +typedef signed char yytype_int8; +#else +typedef short int yytype_int8; +#endif + +#ifdef YYTYPE_UINT16 +typedef YYTYPE_UINT16 yytype_uint16; +#else +typedef unsigned short int yytype_uint16; +#endif + +#ifdef YYTYPE_INT16 +typedef YYTYPE_INT16 yytype_int16; +#else +typedef short int yytype_int16; +#endif + +#ifndef YYSIZE_T +# ifdef __SIZE_TYPE__ +# define YYSIZE_T __SIZE_TYPE__ +# elif defined size_t +# define YYSIZE_T size_t +# elif ! defined YYSIZE_T && (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +# include /* INFRINGES ON USER NAME SPACE */ +# define YYSIZE_T size_t +# else +# define YYSIZE_T unsigned int +# endif +#endif + +#define YYSIZE_MAXIMUM ((YYSIZE_T) -1) + +#ifndef YY_ +# if YYENABLE_NLS +# if ENABLE_NLS +# include /* INFRINGES ON USER NAME SPACE */ +# define YY_(msgid) dgettext ("bison-runtime", msgid) +# endif +# endif +# ifndef YY_ +# define YY_(msgid) msgid +# endif +#endif + +/* Suppress unused-variable warnings by "using" E. */ +#if ! defined lint || defined __GNUC__ +# define YYUSE(e) ((void) (e)) +#else +# define YYUSE(e) /* empty */ +#endif + +/* Identity function, used to suppress warnings about constant conditions. */ +#ifndef lint +# define YYID(n) (n) +#else +#if (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +static int +YYID (int yyi) +#else +static int +YYID (yyi) + int yyi; +#endif +{ + return yyi; +} +#endif + +#if ! defined yyoverflow || YYERROR_VERBOSE + +/* The parser invokes alloca or malloc; define the necessary symbols. */ + +# ifdef YYSTACK_USE_ALLOCA +# if YYSTACK_USE_ALLOCA +# ifdef __GNUC__ +# define YYSTACK_ALLOC __builtin_alloca +# elif defined __BUILTIN_VA_ARG_INCR +# include /* INFRINGES ON USER NAME SPACE */ +# elif defined _AIX +# define YYSTACK_ALLOC __alloca +# elif defined _MSC_VER +# include /* INFRINGES ON USER NAME SPACE */ +# define alloca _alloca +# else +# define YYSTACK_ALLOC alloca +# if ! defined _ALLOCA_H && ! defined _STDLIB_H && (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +# include /* INFRINGES ON USER NAME SPACE */ +# ifndef _STDLIB_H +# define _STDLIB_H 1 +# endif +# endif +# endif +# endif +# endif + +# ifdef YYSTACK_ALLOC + /* Pacify GCC's `empty if-body' warning. */ +# define YYSTACK_FREE(Ptr) do { /* empty */; } while (YYID (0)) +# ifndef YYSTACK_ALLOC_MAXIMUM + /* The OS might guarantee only one guard page at the bottom of the stack, + and a page size can be as small as 4096 bytes. So we cannot safely + invoke alloca (N) if N exceeds 4096. Use a slightly smaller number + to allow for a few compiler-allocated temporary stack slots. */ +# define YYSTACK_ALLOC_MAXIMUM 4032 /* reasonable circa 2006 */ +# endif +# else +# define YYSTACK_ALLOC YYMALLOC +# define YYSTACK_FREE YYFREE +# ifndef YYSTACK_ALLOC_MAXIMUM +# define YYSTACK_ALLOC_MAXIMUM YYSIZE_MAXIMUM +# endif +# if (defined __cplusplus && ! defined _STDLIB_H \ + && ! ((defined YYMALLOC || defined malloc) \ + && (defined YYFREE || defined free))) +# include /* INFRINGES ON USER NAME SPACE */ +# ifndef _STDLIB_H +# define _STDLIB_H 1 +# endif +# endif +# ifndef YYMALLOC +# define YYMALLOC malloc +# if ! defined malloc && ! defined _STDLIB_H && (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +void *malloc (YYSIZE_T); /* INFRINGES ON USER NAME SPACE */ +# endif +# endif +# ifndef YYFREE +# define YYFREE free +# if ! defined free && ! defined _STDLIB_H && (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +void free (void *); /* INFRINGES ON USER NAME SPACE */ +# endif +# endif +# endif +#endif /* ! defined yyoverflow || YYERROR_VERBOSE */ + + +#if (! defined yyoverflow \ + && (! defined __cplusplus \ + || (defined YYSTYPE_IS_TRIVIAL && YYSTYPE_IS_TRIVIAL))) + +/* A type that is properly aligned for any stack member. */ +union yyalloc +{ + yytype_int16 yyss_alloc; + YYSTYPE yyvs_alloc; +}; + +/* The size of the maximum gap between one aligned stack and the next. */ +# define YYSTACK_GAP_MAXIMUM (sizeof (union yyalloc) - 1) + +/* The size of an array large to enough to hold all stacks, each with + N elements. */ +# define YYSTACK_BYTES(N) \ + ((N) * (sizeof (yytype_int16) + sizeof (YYSTYPE)) \ + + YYSTACK_GAP_MAXIMUM) + +/* Copy COUNT objects from FROM to TO. The source and destination do + not overlap. */ +# ifndef YYCOPY +# if defined __GNUC__ && 1 < __GNUC__ +# define YYCOPY(To, From, Count) \ + __builtin_memcpy (To, From, (Count) * sizeof (*(From))) +# else +# define YYCOPY(To, From, Count) \ + do \ + { \ + YYSIZE_T yyi; \ + for (yyi = 0; yyi < (Count); yyi++) \ + (To)[yyi] = (From)[yyi]; \ + } \ + while (YYID (0)) +# endif +# endif + +/* Relocate STACK from its old location to the new one. The + local variables YYSIZE and YYSTACKSIZE give the old and new number of + elements in the stack, and YYPTR gives the new location of the + stack. Advance YYPTR to a properly aligned location for the next + stack. */ +# define YYSTACK_RELOCATE(Stack_alloc, Stack) \ + do \ + { \ + YYSIZE_T yynewbytes; \ + YYCOPY (&yyptr->Stack_alloc, Stack, yysize); \ + Stack = &yyptr->Stack_alloc; \ + yynewbytes = yystacksize * sizeof (*Stack) + YYSTACK_GAP_MAXIMUM; \ + yyptr += yynewbytes / sizeof (*yyptr); \ + } \ + while (YYID (0)) + +#endif + +/* YYFINAL -- State number of the termination state. */ +#define YYFINAL 6 +/* YYLAST -- Last index in YYTABLE. */ +#define YYLAST 35 + +/* YYNTOKENS -- Number of terminals. */ +#define YYNTOKENS 23 +/* YYNNTS -- Number of nonterminals. */ +#define YYNNTS 20 +/* YYNRULES -- Number of rules. */ +#define YYNRULES 39 +/* YYNRULES -- Number of states. */ +#define YYNSTATES 47 + +/* YYTRANSLATE(YYLEX) -- Bison symbol number corresponding to YYLEX. */ +#define YYUNDEFTOK 2 +#define YYMAXUTOK 277 + +#define YYTRANSLATE(YYX) \ + ((unsigned int) (YYX) <= YYMAXUTOK ? yytranslate[YYX] : YYUNDEFTOK) + +/* YYTRANSLATE[YYLEX] -- Bison symbol number corresponding to YYLEX. */ +static const yytype_uint8 yytranslate[] = +{ + 0, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 2, 2, 2, 2, + 2, 2, 2, 2, 2, 2, 1, 2, 3, 4, + 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, + 15, 16, 17, 18, 19, 20, 21, 22 +}; + +#if YYDEBUG +/* YYPRHS[YYN] -- Index of the first RHS symbol of rule number YYN in + YYRHS. */ +static const yytype_uint8 yyprhs[] = +{ + 0, 0, 3, 4, 6, 8, 11, 12, 14, 15, + 17, 19, 20, 26, 27, 32, 33, 38, 40, 42, + 44, 46, 48, 51, 53, 55, 57, 59, 61, 63, + 65, 67, 71, 72, 74, 76, 80, 81, 83, 84 +}; + +/* YYRHS -- A `-1'-separated list of the rules' RHS. */ +static const yytype_int8 yyrhs[] = +{ + 24, 0, -1, -1, 25, -1, 28, -1, 25, 28, + -1, -1, 25, -1, -1, 20, -1, 17, -1, -1, + 10, 29, 11, 34, 27, -1, -1, 13, 31, 40, + 14, -1, -1, 15, 33, 38, 16, -1, 36, -1, + 30, -1, 32, -1, 41, -1, 9, -1, 35, 9, + -1, 3, -1, 4, -1, 6, -1, 5, -1, 7, + -1, 8, -1, 35, -1, 34, -1, 37, 17, 34, + -1, -1, 37, -1, 36, -1, 39, 17, 36, -1, + -1, 39, -1, -1, 18, 42, 26, 19, -1 +}; + +/* YYRLINE[YYN] -- source line where rule number YYN was defined. */ +static const yytype_uint16 yyrline[] = +{ + 0, 100, 100, 102, 106, 107, 110, 112, 115, 117, + 118, 123, 122, 142, 141, 165, 164, 187, 188, 189, + 190, 194, 195, 199, 219, 241, 263, 285, 307, 325, + 353, 354, 357, 359, 363, 364, 367, 369, 374, 373 +}; +#endif + +#if YYDEBUG || YYERROR_VERBOSE || YYTOKEN_TABLE +/* YYTNAME[SYMBOL-NUM] -- String name of the symbol SYMBOL-NUM. + First, the terminals, then, starting at YYNTOKENS, nonterminals. */ +static const char *const yytname[] = +{ + "$end", "error", "$undefined", "TOK_BOOLEAN", "TOK_INTEGER", "TOK_HEX", + "TOK_INTEGER64", "TOK_HEX64", "TOK_FLOAT", "TOK_STRING", "TOK_NAME", + "TOK_EQUALS", "TOK_NEWLINE", "TOK_ARRAY_START", "TOK_ARRAY_END", + "TOK_LIST_START", "TOK_LIST_END", "TOK_COMMA", "TOK_GROUP_START", + "TOK_GROUP_END", "TOK_SEMICOLON", "TOK_GARBAGE", "TOK_ERROR", "$accept", + "configuration", "setting_list", "setting_list_optional", + "setting_terminator", "setting", "$@1", "array", "$@2", "list", "$@3", + "value", "string", "simple_value", "value_list", "value_list_optional", + "simple_value_list", "simple_value_list_optional", "group", "$@4", 0 +}; +#endif + +# ifdef YYPRINT +/* YYTOKNUM[YYLEX-NUM] -- Internal token number corresponding to + token YYLEX-NUM. */ +static const yytype_uint16 yytoknum[] = +{ + 0, 256, 257, 258, 259, 260, 261, 262, 263, 264, + 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, + 275, 276, 277 +}; +# endif + +/* YYR1[YYN] -- Symbol number of symbol that rule YYN derives. */ +static const yytype_uint8 yyr1[] = +{ + 0, 23, 24, 24, 25, 25, 26, 26, 27, 27, + 27, 29, 28, 31, 30, 33, 32, 34, 34, 34, + 34, 35, 35, 36, 36, 36, 36, 36, 36, 36, + 37, 37, 38, 38, 39, 39, 40, 40, 42, 41 +}; + +/* YYR2[YYN] -- Number of symbols composing right hand side of rule YYN. */ +static const yytype_uint8 yyr2[] = +{ + 0, 2, 0, 1, 1, 2, 0, 1, 0, 1, + 1, 0, 5, 0, 4, 0, 4, 1, 1, 1, + 1, 1, 2, 1, 1, 1, 1, 1, 1, 1, + 1, 3, 0, 1, 1, 3, 0, 1, 0, 4 +}; + +/* YYDEFACT[STATE-NAME] -- Default rule to reduce with in state + STATE-NUM when YYTABLE doesn't specify something else to do. Zero + means the default is an error. */ +static const yytype_uint8 yydefact[] = +{ + 2, 11, 0, 3, 4, 0, 1, 5, 0, 23, + 24, 26, 25, 27, 28, 21, 13, 15, 38, 18, + 19, 8, 29, 17, 20, 36, 32, 6, 10, 9, + 12, 22, 34, 37, 0, 30, 33, 0, 7, 0, + 0, 14, 0, 16, 39, 35, 31 +}; + +/* YYDEFGOTO[NTERM-NUM]. */ +static const yytype_int8 yydefgoto[] = +{ + -1, 2, 3, 39, 30, 4, 5, 19, 25, 20, + 26, 21, 22, 23, 36, 37, 33, 34, 24, 27 +}; + +/* YYPACT[STATE-NUM] -- Index in YYTABLE of the portion describing + STATE-NUM. */ +#define YYPACT_NINF -26 +static const yytype_int8 yypact[] = +{ + -8, -26, 12, -8, -26, 5, -26, -26, 0, -26, + -26, -26, -26, -26, -26, -26, -26, -26, -26, -26, + -26, -6, 10, -26, -26, 23, 0, -8, -26, -26, + -26, -26, -26, 3, 7, -26, 6, 8, -8, 14, + 23, -26, 0, -26, -26, -26, -26 +}; + +/* YYPGOTO[NTERM-NUM]. */ +static const yytype_int8 yypgoto[] = +{ + -26, -26, -5, -26, -26, -3, -26, -26, -26, -26, + -26, -25, -26, -15, -26, -26, -26, -26, -26, -26 +}; + +/* YYTABLE[YYPACT[STATE-NUM]]. What to do in state STATE-NUM. If + positive, shift that token. If negative, reduce the rule which + number is the opposite. If zero, do what YYDEFACT says. + If YYTABLE_NINF, syntax error. */ +#define YYTABLE_NINF -1 +static const yytype_uint8 yytable[] = +{ + 7, 35, 1, 9, 10, 11, 12, 13, 14, 15, + 32, 28, 6, 16, 29, 17, 8, 46, 18, 31, + 40, 41, 38, 42, 43, 45, 9, 10, 11, 12, + 13, 14, 15, 44, 0, 7 +}; + +static const yytype_int8 yycheck[] = +{ + 3, 26, 10, 3, 4, 5, 6, 7, 8, 9, + 25, 17, 0, 13, 20, 15, 11, 42, 18, 9, + 17, 14, 27, 17, 16, 40, 3, 4, 5, 6, + 7, 8, 9, 19, -1, 38 +}; + +/* YYSTOS[STATE-NUM] -- The (internal number of the) accessing + symbol of state STATE-NUM. */ +static const yytype_uint8 yystos[] = +{ + 0, 10, 24, 25, 28, 29, 0, 28, 11, 3, + 4, 5, 6, 7, 8, 9, 13, 15, 18, 30, + 32, 34, 35, 36, 41, 31, 33, 42, 17, 20, + 27, 9, 36, 39, 40, 34, 37, 38, 25, 26, + 17, 14, 17, 16, 19, 36, 34 +}; + +#define yyerrok (yyerrstatus = 0) +#define yyclearin (yychar = YYEMPTY) +#define YYEMPTY (-2) +#define YYEOF 0 + +#define YYACCEPT goto yyacceptlab +#define YYABORT goto yyabortlab +#define YYERROR goto yyerrorlab + + +/* Like YYERROR except do call yyerror. This remains here temporarily + to ease the transition to the new meaning of YYERROR, for GCC. + Once GCC version 2 has supplanted version 1, this can go. */ + +#define YYFAIL goto yyerrlab + +#define YYRECOVERING() (!!yyerrstatus) + +#define YYBACKUP(Token, Value) \ +do \ + if (yychar == YYEMPTY && yylen == 1) \ + { \ + yychar = (Token); \ + yylval = (Value); \ + yytoken = YYTRANSLATE (yychar); \ + YYPOPSTACK (1); \ + goto yybackup; \ + } \ + else \ + { \ + yyerror (scanner, ctx, scan_ctx, YY_("syntax error: cannot back up")); \ + YYERROR; \ + } \ +while (YYID (0)) + + +#define YYTERROR 1 +#define YYERRCODE 256 + + +/* YYLLOC_DEFAULT -- Set CURRENT to span from RHS[1] to RHS[N]. + If N is 0, then set CURRENT to the empty location which ends + the previous symbol: RHS[0] (always defined). */ + +#define YYRHSLOC(Rhs, K) ((Rhs)[K]) +#ifndef YYLLOC_DEFAULT +# define YYLLOC_DEFAULT(Current, Rhs, N) \ + do \ + if (YYID (N)) \ + { \ + (Current).first_line = YYRHSLOC (Rhs, 1).first_line; \ + (Current).first_column = YYRHSLOC (Rhs, 1).first_column; \ + (Current).last_line = YYRHSLOC (Rhs, N).last_line; \ + (Current).last_column = YYRHSLOC (Rhs, N).last_column; \ + } \ + else \ + { \ + (Current).first_line = (Current).last_line = \ + YYRHSLOC (Rhs, 0).last_line; \ + (Current).first_column = (Current).last_column = \ + YYRHSLOC (Rhs, 0).last_column; \ + } \ + while (YYID (0)) +#endif + + +/* YY_LOCATION_PRINT -- Print the location on the stream. + This macro was not mandated originally: define only if we know + we won't break user code: when these are the locations we know. */ + +#ifndef YY_LOCATION_PRINT +# if YYLTYPE_IS_TRIVIAL +# define YY_LOCATION_PRINT(File, Loc) \ + fprintf (File, "%d.%d-%d.%d", \ + (Loc).first_line, (Loc).first_column, \ + (Loc).last_line, (Loc).last_column) +# else +# define YY_LOCATION_PRINT(File, Loc) ((void) 0) +# endif +#endif + + +/* YYLEX -- calling `yylex' with the right arguments. */ + +#ifdef YYLEX_PARAM +# define YYLEX yylex (&yylval, YYLEX_PARAM) +#else +# define YYLEX yylex (&yylval, scanner) +#endif + +/* Enable debugging if requested. */ +#if YYDEBUG + +# ifndef YYFPRINTF +# include /* INFRINGES ON USER NAME SPACE */ +# define YYFPRINTF fprintf +# endif + +# define YYDPRINTF(Args) \ +do { \ + if (yydebug) \ + YYFPRINTF Args; \ +} while (YYID (0)) + +# define YY_SYMBOL_PRINT(Title, Type, Value, Location) \ +do { \ + if (yydebug) \ + { \ + YYFPRINTF (stderr, "%s ", Title); \ + yy_symbol_print (stderr, \ + Type, Value, scanner, ctx, scan_ctx); \ + YYFPRINTF (stderr, "\n"); \ + } \ +} while (YYID (0)) + + +/*--------------------------------. +| Print this symbol on YYOUTPUT. | +`--------------------------------*/ + +/*ARGSUSED*/ +#if (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +static void +yy_symbol_value_print (FILE *yyoutput, int yytype, YYSTYPE const * const yyvaluep, void *scanner, struct parse_context *ctx, struct scan_context *scan_ctx) +#else +static void +yy_symbol_value_print (yyoutput, yytype, yyvaluep, scanner, ctx, scan_ctx) + FILE *yyoutput; + int yytype; + YYSTYPE const * const yyvaluep; + void *scanner; + struct parse_context *ctx; + struct scan_context *scan_ctx; +#endif +{ + if (!yyvaluep) + return; + YYUSE (scanner); + YYUSE (ctx); + YYUSE (scan_ctx); +# ifdef YYPRINT + if (yytype < YYNTOKENS) + YYPRINT (yyoutput, yytoknum[yytype], *yyvaluep); +# else + YYUSE (yyoutput); +# endif + switch (yytype) + { + default: + break; + } +} + + +/*--------------------------------. +| Print this symbol on YYOUTPUT. | +`--------------------------------*/ + +#if (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +static void +yy_symbol_print (FILE *yyoutput, int yytype, YYSTYPE const * const yyvaluep, void *scanner, struct parse_context *ctx, struct scan_context *scan_ctx) +#else +static void +yy_symbol_print (yyoutput, yytype, yyvaluep, scanner, ctx, scan_ctx) + FILE *yyoutput; + int yytype; + YYSTYPE const * const yyvaluep; + void *scanner; + struct parse_context *ctx; + struct scan_context *scan_ctx; +#endif +{ + if (yytype < YYNTOKENS) + YYFPRINTF (yyoutput, "token %s (", yytname[yytype]); + else + YYFPRINTF (yyoutput, "nterm %s (", yytname[yytype]); + + yy_symbol_value_print (yyoutput, yytype, yyvaluep, scanner, ctx, scan_ctx); + YYFPRINTF (yyoutput, ")"); +} + +/*------------------------------------------------------------------. +| yy_stack_print -- Print the state stack from its BOTTOM up to its | +| TOP (included). | +`------------------------------------------------------------------*/ + +#if (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +static void +yy_stack_print (yytype_int16 *yybottom, yytype_int16 *yytop) +#else +static void +yy_stack_print (yybottom, yytop) + yytype_int16 *yybottom; + yytype_int16 *yytop; +#endif +{ + YYFPRINTF (stderr, "Stack now"); + for (; yybottom <= yytop; yybottom++) + { + int yybot = *yybottom; + YYFPRINTF (stderr, " %d", yybot); + } + YYFPRINTF (stderr, "\n"); +} + +# define YY_STACK_PRINT(Bottom, Top) \ +do { \ + if (yydebug) \ + yy_stack_print ((Bottom), (Top)); \ +} while (YYID (0)) + + +/*------------------------------------------------. +| Report that the YYRULE is going to be reduced. | +`------------------------------------------------*/ + +#if (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +static void +yy_reduce_print (YYSTYPE *yyvsp, int yyrule, void *scanner, struct parse_context *ctx, struct scan_context *scan_ctx) +#else +static void +yy_reduce_print (yyvsp, yyrule, scanner, ctx, scan_ctx) + YYSTYPE *yyvsp; + int yyrule; + void *scanner; + struct parse_context *ctx; + struct scan_context *scan_ctx; +#endif +{ + int yynrhs = yyr2[yyrule]; + int yyi; + unsigned long int yylno = yyrline[yyrule]; + YYFPRINTF (stderr, "Reducing stack by rule %d (line %lu):\n", + yyrule - 1, yylno); + /* The symbols being reduced. */ + for (yyi = 0; yyi < yynrhs; yyi++) + { + YYFPRINTF (stderr, " $%d = ", yyi + 1); + yy_symbol_print (stderr, yyrhs[yyprhs[yyrule] + yyi], + &(yyvsp[(yyi + 1) - (yynrhs)]) + , scanner, ctx, scan_ctx); + YYFPRINTF (stderr, "\n"); + } +} + +# define YY_REDUCE_PRINT(Rule) \ +do { \ + if (yydebug) \ + yy_reduce_print (yyvsp, Rule, scanner, ctx, scan_ctx); \ +} while (YYID (0)) + +/* Nonzero means print parse trace. It is left uninitialized so that + multiple parsers can coexist. */ +int yydebug; +#else /* !YYDEBUG */ +# define YYDPRINTF(Args) +# define YY_SYMBOL_PRINT(Title, Type, Value, Location) +# define YY_STACK_PRINT(Bottom, Top) +# define YY_REDUCE_PRINT(Rule) +#endif /* !YYDEBUG */ + + +/* YYINITDEPTH -- initial size of the parser's stacks. */ +#ifndef YYINITDEPTH +# define YYINITDEPTH 200 +#endif + +/* YYMAXDEPTH -- maximum size the stacks can grow to (effective only + if the built-in stack extension method is used). + + Do not make this value too large; the results are undefined if + YYSTACK_ALLOC_MAXIMUM < YYSTACK_BYTES (YYMAXDEPTH) + evaluated with infinite-precision integer arithmetic. */ + +#ifndef YYMAXDEPTH +# define YYMAXDEPTH 10000 +#endif + + + +#if YYERROR_VERBOSE + +# ifndef yystrlen +# if defined __GLIBC__ && defined _STRING_H +# define yystrlen strlen +# else +/* Return the length of YYSTR. */ +#if (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +static YYSIZE_T +yystrlen (const char *yystr) +#else +static YYSIZE_T +yystrlen (yystr) + const char *yystr; +#endif +{ + YYSIZE_T yylen; + for (yylen = 0; yystr[yylen]; yylen++) + continue; + return yylen; +} +# endif +# endif + +# ifndef yystpcpy +# if defined __GLIBC__ && defined _STRING_H && defined _GNU_SOURCE +# define yystpcpy stpcpy +# else +/* Copy YYSRC to YYDEST, returning the address of the terminating '\0' in + YYDEST. */ +#if (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +static char * +yystpcpy (char *yydest, const char *yysrc) +#else +static char * +yystpcpy (yydest, yysrc) + char *yydest; + const char *yysrc; +#endif +{ + char *yyd = yydest; + const char *yys = yysrc; + + while ((*yyd++ = *yys++) != '\0') + continue; + + return yyd - 1; +} +# endif +# endif + +# ifndef yytnamerr +/* Copy to YYRES the contents of YYSTR after stripping away unnecessary + quotes and backslashes, so that it's suitable for yyerror. The + heuristic is that double-quoting is unnecessary unless the string + contains an apostrophe, a comma, or backslash (other than + backslash-backslash). YYSTR is taken from yytname. If YYRES is + null, do not copy; instead, return the length of what the result + would have been. */ +static YYSIZE_T +yytnamerr (char *yyres, const char *yystr) +{ + if (*yystr == '"') + { + YYSIZE_T yyn = 0; + char const *yyp = yystr; + + for (;;) + switch (*++yyp) + { + case '\'': + case ',': + goto do_not_strip_quotes; + + case '\\': + if (*++yyp != '\\') + goto do_not_strip_quotes; + /* Fall through. */ + default: + if (yyres) + yyres[yyn] = *yyp; + yyn++; + break; + + case '"': + if (yyres) + yyres[yyn] = '\0'; + return yyn; + } + do_not_strip_quotes: ; + } + + if (! yyres) + return yystrlen (yystr); + + return yystpcpy (yyres, yystr) - yyres; +} +# endif + +/* Copy into YYRESULT an error message about the unexpected token + YYCHAR while in state YYSTATE. Return the number of bytes copied, + including the terminating null byte. If YYRESULT is null, do not + copy anything; just return the number of bytes that would be + copied. As a special case, return 0 if an ordinary "syntax error" + message will do. Return YYSIZE_MAXIMUM if overflow occurs during + size calculation. */ +static YYSIZE_T +yysyntax_error (char *yyresult, int yystate, int yychar) +{ + int yyn = yypact[yystate]; + + if (! (YYPACT_NINF < yyn && yyn <= YYLAST)) + return 0; + else + { + int yytype = YYTRANSLATE (yychar); + YYSIZE_T yysize0 = yytnamerr (0, yytname[yytype]); + YYSIZE_T yysize = yysize0; + YYSIZE_T yysize1; + int yysize_overflow = 0; + enum { YYERROR_VERBOSE_ARGS_MAXIMUM = 5 }; + char const *yyarg[YYERROR_VERBOSE_ARGS_MAXIMUM]; + int yyx; + +# if 0 + /* This is so xgettext sees the translatable formats that are + constructed on the fly. */ + YY_("syntax error, unexpected %s"); + YY_("syntax error, unexpected %s, expecting %s"); + YY_("syntax error, unexpected %s, expecting %s or %s"); + YY_("syntax error, unexpected %s, expecting %s or %s or %s"); + YY_("syntax error, unexpected %s, expecting %s or %s or %s or %s"); +# endif + char *yyfmt; + char const *yyf; + static char const yyunexpected[] = "syntax error, unexpected %s"; + static char const yyexpecting[] = ", expecting %s"; + static char const yyor[] = " or %s"; + char yyformat[sizeof yyunexpected + + sizeof yyexpecting - 1 + + ((YYERROR_VERBOSE_ARGS_MAXIMUM - 2) + * (sizeof yyor - 1))]; + char const *yyprefix = yyexpecting; + + /* Start YYX at -YYN if negative to avoid negative indexes in + YYCHECK. */ + int yyxbegin = yyn < 0 ? -yyn : 0; + + /* Stay within bounds of both yycheck and yytname. */ + int yychecklim = YYLAST - yyn + 1; + int yyxend = yychecklim < YYNTOKENS ? yychecklim : YYNTOKENS; + int yycount = 1; + + yyarg[0] = yytname[yytype]; + yyfmt = yystpcpy (yyformat, yyunexpected); + + for (yyx = yyxbegin; yyx < yyxend; ++yyx) + if (yycheck[yyx + yyn] == yyx && yyx != YYTERROR) + { + if (yycount == YYERROR_VERBOSE_ARGS_MAXIMUM) + { + yycount = 1; + yysize = yysize0; + yyformat[sizeof yyunexpected - 1] = '\0'; + break; + } + yyarg[yycount++] = yytname[yyx]; + yysize1 = yysize + yytnamerr (0, yytname[yyx]); + yysize_overflow |= (yysize1 < yysize); + yysize = yysize1; + yyfmt = yystpcpy (yyfmt, yyprefix); + yyprefix = yyor; + } + + yyf = YY_(yyformat); + yysize1 = yysize + yystrlen (yyf); + yysize_overflow |= (yysize1 < yysize); + yysize = yysize1; + + if (yysize_overflow) + return YYSIZE_MAXIMUM; + + if (yyresult) + { + /* Avoid sprintf, as that infringes on the user's name space. + Don't have undefined behavior even if the translation + produced a string with the wrong number of "%s"s. */ + char *yyp = yyresult; + int yyi = 0; + while ((*yyp = *yyf) != '\0') + { + if (*yyp == '%' && yyf[1] == 's' && yyi < yycount) + { + yyp += yytnamerr (yyp, yyarg[yyi++]); + yyf += 2; + } + else + { + yyp++; + yyf++; + } + } + } + return yysize; + } +} +#endif /* YYERROR_VERBOSE */ + + +/*-----------------------------------------------. +| Release the memory associated to this symbol. | +`-----------------------------------------------*/ + +/*ARGSUSED*/ +#if (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +static void +yydestruct (const char *yymsg, int yytype, YYSTYPE *yyvaluep, void *scanner, struct parse_context *ctx, struct scan_context *scan_ctx) +#else +static void +yydestruct (yymsg, yytype, yyvaluep, scanner, ctx, scan_ctx) + const char *yymsg; + int yytype; + YYSTYPE *yyvaluep; + void *scanner; + struct parse_context *ctx; + struct scan_context *scan_ctx; +#endif +{ + YYUSE (yyvaluep); + YYUSE (scanner); + YYUSE (ctx); + YYUSE (scan_ctx); + + if (!yymsg) + yymsg = "Deleting"; + YY_SYMBOL_PRINT (yymsg, yytype, yyvaluep, yylocationp); + + switch (yytype) + { + + default: + break; + } +} + +/* Prevent warnings from -Wmissing-prototypes. */ +#ifdef YYPARSE_PARAM +#if defined __STDC__ || defined __cplusplus +int yyparse (void *YYPARSE_PARAM); +#else +int yyparse (); +#endif +#else /* ! YYPARSE_PARAM */ +#if defined __STDC__ || defined __cplusplus +int yyparse (void *scanner, struct parse_context *ctx, struct scan_context *scan_ctx); +#else +int yyparse (); +#endif +#endif /* ! YYPARSE_PARAM */ + + + + + +/*-------------------------. +| yyparse or yypush_parse. | +`-------------------------*/ + +#ifdef YYPARSE_PARAM +#if (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +int +yyparse (void *YYPARSE_PARAM) +#else +int +yyparse (YYPARSE_PARAM) + void *YYPARSE_PARAM; +#endif +#else /* ! YYPARSE_PARAM */ +#if (defined __STDC__ || defined __C99__FUNC__ \ + || defined __cplusplus || defined _MSC_VER) +int +yyparse (void *scanner, struct parse_context *ctx, struct scan_context *scan_ctx) +#else +int +yyparse (scanner, ctx, scan_ctx) + void *scanner; + struct parse_context *ctx; + struct scan_context *scan_ctx; +#endif +#endif +{ +/* The lookahead symbol. */ +int yychar; + +/* The semantic value of the lookahead symbol. */ +YYSTYPE yylval; + + /* Number of syntax errors so far. */ + int yynerrs; + + int yystate; + /* Number of tokens to shift before error messages enabled. */ + int yyerrstatus; + + /* The stacks and their tools: + `yyss': related to states. + `yyvs': related to semantic values. + + Refer to the stacks thru separate pointers, to allow yyoverflow + to reallocate them elsewhere. */ + + /* The state stack. */ + yytype_int16 yyssa[YYINITDEPTH]; + yytype_int16 *yyss; + yytype_int16 *yyssp; + + /* The semantic value stack. */ + YYSTYPE yyvsa[YYINITDEPTH]; + YYSTYPE *yyvs; + YYSTYPE *yyvsp; + + YYSIZE_T yystacksize; + + int yyn; + int yyresult; + /* Lookahead token as an internal (translated) token number. */ + int yytoken; + /* The variables used to return semantic value and location from the + action routines. */ + YYSTYPE yyval; + +#if YYERROR_VERBOSE + /* Buffer for error messages, and its allocated size. */ + char yymsgbuf[128]; + char *yymsg = yymsgbuf; + YYSIZE_T yymsg_alloc = sizeof yymsgbuf; +#endif + +#define YYPOPSTACK(N) (yyvsp -= (N), yyssp -= (N)) + + /* The number of symbols on the RHS of the reduced rule. + Keep to zero when no symbol should be popped. */ + int yylen = 0; + + yytoken = 0; + yyss = yyssa; + yyvs = yyvsa; + yystacksize = YYINITDEPTH; + + YYDPRINTF ((stderr, "Starting parse\n")); + + yystate = 0; + yyerrstatus = 0; + yynerrs = 0; + yychar = YYEMPTY; /* Cause a token to be read. */ + + /* Initialize stack pointers. + Waste one element of value and location stack + so that they stay on the same level as the state stack. + The wasted elements are never initialized. */ + yyssp = yyss; + yyvsp = yyvs; + + goto yysetstate; + +/*------------------------------------------------------------. +| yynewstate -- Push a new state, which is found in yystate. | +`------------------------------------------------------------*/ + yynewstate: + /* In all cases, when you get here, the value and location stacks + have just been pushed. So pushing a state here evens the stacks. */ + yyssp++; + + yysetstate: + *yyssp = yystate; + + if (yyss + yystacksize - 1 <= yyssp) + { + /* Get the current used size of the three stacks, in elements. */ + YYSIZE_T yysize = yyssp - yyss + 1; + +#ifdef yyoverflow + { + /* Give user a chance to reallocate the stack. Use copies of + these so that the &'s don't force the real ones into + memory. */ + YYSTYPE *yyvs1 = yyvs; + yytype_int16 *yyss1 = yyss; + + /* Each stack pointer address is followed by the size of the + data in use in that stack, in bytes. This used to be a + conditional around just the two extra args, but that might + be undefined if yyoverflow is a macro. */ + yyoverflow (YY_("memory exhausted"), + &yyss1, yysize * sizeof (*yyssp), + &yyvs1, yysize * sizeof (*yyvsp), + &yystacksize); + + yyss = yyss1; + yyvs = yyvs1; + } +#else /* no yyoverflow */ +# ifndef YYSTACK_RELOCATE + goto yyexhaustedlab; +# else + /* Extend the stack our own way. */ + if (YYMAXDEPTH <= yystacksize) + goto yyexhaustedlab; + yystacksize *= 2; + if (YYMAXDEPTH < yystacksize) + yystacksize = YYMAXDEPTH; + + { + yytype_int16 *yyss1 = yyss; + union yyalloc *yyptr = + (union yyalloc *) YYSTACK_ALLOC (YYSTACK_BYTES (yystacksize)); + if (! yyptr) + goto yyexhaustedlab; + YYSTACK_RELOCATE (yyss_alloc, yyss); + YYSTACK_RELOCATE (yyvs_alloc, yyvs); +# undef YYSTACK_RELOCATE + if (yyss1 != yyssa) + YYSTACK_FREE (yyss1); + } +# endif +#endif /* no yyoverflow */ + + yyssp = yyss + yysize - 1; + yyvsp = yyvs + yysize - 1; + + YYDPRINTF ((stderr, "Stack size increased to %lu\n", + (unsigned long int) yystacksize)); + + if (yyss + yystacksize - 1 <= yyssp) + YYABORT; + } + + YYDPRINTF ((stderr, "Entering state %d\n", yystate)); + + if (yystate == YYFINAL) + YYACCEPT; + + goto yybackup; + +/*-----------. +| yybackup. | +`-----------*/ +yybackup: + + /* Do appropriate processing given the current state. Read a + lookahead token if we need one and don't already have one. */ + + /* First try to decide what to do without reference to lookahead token. */ + yyn = yypact[yystate]; + if (yyn == YYPACT_NINF) + goto yydefault; + + /* Not known => get a lookahead token if don't already have one. */ + + /* YYCHAR is either YYEMPTY or YYEOF or a valid lookahead symbol. */ + if (yychar == YYEMPTY) + { + YYDPRINTF ((stderr, "Reading a token: ")); + yychar = YYLEX; + } + + if (yychar <= YYEOF) + { + yychar = yytoken = YYEOF; + YYDPRINTF ((stderr, "Now at end of input.\n")); + } + else + { + yytoken = YYTRANSLATE (yychar); + YY_SYMBOL_PRINT ("Next token is", yytoken, &yylval, &yylloc); + } + + /* If the proper action on seeing token YYTOKEN is to reduce or to + detect an error, take that action. */ + yyn += yytoken; + if (yyn < 0 || YYLAST < yyn || yycheck[yyn] != yytoken) + goto yydefault; + yyn = yytable[yyn]; + if (yyn <= 0) + { + if (yyn == 0 || yyn == YYTABLE_NINF) + goto yyerrlab; + yyn = -yyn; + goto yyreduce; + } + + /* Count tokens shifted since error; after three, turn off error + status. */ + if (yyerrstatus) + yyerrstatus--; + + /* Shift the lookahead token. */ + YY_SYMBOL_PRINT ("Shifting", yytoken, &yylval, &yylloc); + + /* Discard the shifted token. */ + yychar = YYEMPTY; + + yystate = yyn; + *++yyvsp = yylval; + + goto yynewstate; + + +/*-----------------------------------------------------------. +| yydefault -- do the default action for the current state. | +`-----------------------------------------------------------*/ +yydefault: + yyn = yydefact[yystate]; + if (yyn == 0) + goto yyerrlab; + goto yyreduce; + + +/*-----------------------------. +| yyreduce -- Do a reduction. | +`-----------------------------*/ +yyreduce: + /* yyn is the number of a rule to reduce with. */ + yylen = yyr2[yyn]; + + /* If YYLEN is nonzero, implement the default value of the action: + `$$ = $1'. + + Otherwise, the following line sets YYVAL to garbage. + This behavior is undocumented and Bison + users should not rely upon it. Assigning to YYVAL + unconditionally makes the parser a bit smaller, and it avoids a + GCC warning that YYVAL may be used uninitialized. */ + yyval = yyvsp[1-yylen]; + + + YY_REDUCE_PRINT (yyn); + switch (yyn) + { + case 11: + +/* Line 1455 of yacc.c */ +#line 123 "grammar.y" + { + ctx->setting = config_setting_add(ctx->parent, (yyvsp[(1) - (1)].sval), CONFIG_TYPE_NONE); + + if(ctx->setting == NULL) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_duplicate_setting); + YYABORT; + } + else + { + CAPTURE_PARSE_POS(ctx->setting); + } + } + break; + + case 13: + +/* Line 1455 of yacc.c */ +#line 142 "grammar.y" + { + if(IN_LIST()) + { + ctx->parent = config_setting_add(ctx->parent, NULL, CONFIG_TYPE_ARRAY); + CAPTURE_PARSE_POS(ctx->parent); + } + else + { + ctx->setting->type = CONFIG_TYPE_ARRAY; + ctx->parent = ctx->setting; + ctx->setting = NULL; + } + } + break; + + case 14: + +/* Line 1455 of yacc.c */ +#line 157 "grammar.y" + { + if(ctx->parent) + ctx->parent = ctx->parent->parent; + } + break; + + case 15: + +/* Line 1455 of yacc.c */ +#line 165 "grammar.y" + { + if(IN_LIST()) + { + ctx->parent = config_setting_add(ctx->parent, NULL, CONFIG_TYPE_LIST); + CAPTURE_PARSE_POS(ctx->parent); + } + else + { + ctx->setting->type = CONFIG_TYPE_LIST; + ctx->parent = ctx->setting; + ctx->setting = NULL; + } + } + break; + + case 16: + +/* Line 1455 of yacc.c */ +#line 180 "grammar.y" + { + if(ctx->parent) + ctx->parent = ctx->parent->parent; + } + break; + + case 21: + +/* Line 1455 of yacc.c */ +#line 194 "grammar.y" + { parsectx_append_string(ctx, (yyvsp[(1) - (1)].sval)); free((yyvsp[(1) - (1)].sval)); } + break; + + case 22: + +/* Line 1455 of yacc.c */ +#line 195 "grammar.y" + { parsectx_append_string(ctx, (yyvsp[(2) - (2)].sval)); free((yyvsp[(2) - (2)].sval)); } + break; + + case 23: + +/* Line 1455 of yacc.c */ +#line 200 "grammar.y" + { + if(IN_ARRAY() || IN_LIST()) + { + config_setting_t *e = config_setting_set_bool_elem(ctx->parent, -1, + (int)(yyvsp[(1) - (1)].ival)); + + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + CAPTURE_PARSE_POS(e); + } + } + else + config_setting_set_bool(ctx->setting, (int)(yyvsp[(1) - (1)].ival)); + } + break; + + case 24: + +/* Line 1455 of yacc.c */ +#line 220 "grammar.y" + { + if(IN_ARRAY() || IN_LIST()) + { + config_setting_t *e = config_setting_set_int_elem(ctx->parent, -1, (yyvsp[(1) - (1)].ival)); + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + config_setting_set_format(e, CONFIG_FORMAT_DEFAULT); + CAPTURE_PARSE_POS(e); + } + } + else + { + config_setting_set_int(ctx->setting, (yyvsp[(1) - (1)].ival)); + config_setting_set_format(ctx->setting, CONFIG_FORMAT_DEFAULT); + } + } + break; + + case 25: + +/* Line 1455 of yacc.c */ +#line 242 "grammar.y" + { + if(IN_ARRAY() || IN_LIST()) + { + config_setting_t *e = config_setting_set_int64_elem(ctx->parent, -1, (yyvsp[(1) - (1)].llval)); + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + config_setting_set_format(e, CONFIG_FORMAT_DEFAULT); + CAPTURE_PARSE_POS(e); + } + } + else + { + config_setting_set_int64(ctx->setting, (yyvsp[(1) - (1)].llval)); + config_setting_set_format(ctx->setting, CONFIG_FORMAT_DEFAULT); + } + } + break; + + case 26: + +/* Line 1455 of yacc.c */ +#line 264 "grammar.y" + { + if(IN_ARRAY() || IN_LIST()) + { + config_setting_t *e = config_setting_set_int_elem(ctx->parent, -1, (yyvsp[(1) - (1)].ival)); + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + config_setting_set_format(e, CONFIG_FORMAT_HEX); + CAPTURE_PARSE_POS(e); + } + } + else + { + config_setting_set_int(ctx->setting, (yyvsp[(1) - (1)].ival)); + config_setting_set_format(ctx->setting, CONFIG_FORMAT_HEX); + } + } + break; + + case 27: + +/* Line 1455 of yacc.c */ +#line 286 "grammar.y" + { + if(IN_ARRAY() || IN_LIST()) + { + config_setting_t *e = config_setting_set_int64_elem(ctx->parent, -1, (yyvsp[(1) - (1)].llval)); + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + config_setting_set_format(e, CONFIG_FORMAT_HEX); + CAPTURE_PARSE_POS(e); + } + } + else + { + config_setting_set_int64(ctx->setting, (yyvsp[(1) - (1)].llval)); + config_setting_set_format(ctx->setting, CONFIG_FORMAT_HEX); + } + } + break; + + case 28: + +/* Line 1455 of yacc.c */ +#line 308 "grammar.y" + { + if(IN_ARRAY() || IN_LIST()) + { + config_setting_t *e = config_setting_set_float_elem(ctx->parent, -1, (yyvsp[(1) - (1)].fval)); + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + CAPTURE_PARSE_POS(e); + } + } + else + config_setting_set_float(ctx->setting, (yyvsp[(1) - (1)].fval)); + } + break; + + case 29: + +/* Line 1455 of yacc.c */ +#line 326 "grammar.y" + { + if(IN_ARRAY() || IN_LIST()) + { + const char *s = parsectx_take_string(ctx); + config_setting_t *e = config_setting_set_string_elem(ctx->parent, -1, s); + _delete(s); + + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + CAPTURE_PARSE_POS(e); + } + } + else + { + const char *s = parsectx_take_string(ctx); + config_setting_set_string(ctx->setting, s); + _delete(s); + } + } + break; + + case 38: + +/* Line 1455 of yacc.c */ +#line 374 "grammar.y" + { + if(IN_LIST()) + { + ctx->parent = config_setting_add(ctx->parent, NULL, CONFIG_TYPE_GROUP); + CAPTURE_PARSE_POS(ctx->parent); + } + else + { + ctx->setting->type = CONFIG_TYPE_GROUP; + ctx->parent = ctx->setting; + ctx->setting = NULL; + } + } + break; + + case 39: + +/* Line 1455 of yacc.c */ +#line 389 "grammar.y" + { + if(ctx->parent) + ctx->parent = ctx->parent->parent; + } + break; + + + +/* Line 1455 of yacc.c */ +#line 1788 "grammar.c" + default: break; + } + YY_SYMBOL_PRINT ("-> $$ =", yyr1[yyn], &yyval, &yyloc); + + YYPOPSTACK (yylen); + yylen = 0; + YY_STACK_PRINT (yyss, yyssp); + + *++yyvsp = yyval; + + /* Now `shift' the result of the reduction. Determine what state + that goes to, based on the state we popped back to and the rule + number reduced by. */ + + yyn = yyr1[yyn]; + + yystate = yypgoto[yyn - YYNTOKENS] + *yyssp; + if (0 <= yystate && yystate <= YYLAST && yycheck[yystate] == *yyssp) + yystate = yytable[yystate]; + else + yystate = yydefgoto[yyn - YYNTOKENS]; + + goto yynewstate; + + +/*------------------------------------. +| yyerrlab -- here on detecting error | +`------------------------------------*/ +yyerrlab: + /* If not already recovering from an error, report this error. */ + if (!yyerrstatus) + { + ++yynerrs; +#if ! YYERROR_VERBOSE + yyerror (scanner, ctx, scan_ctx, YY_("syntax error")); +#else + { + YYSIZE_T yysize = yysyntax_error (0, yystate, yychar); + if (yymsg_alloc < yysize && yymsg_alloc < YYSTACK_ALLOC_MAXIMUM) + { + YYSIZE_T yyalloc = 2 * yysize; + if (! (yysize <= yyalloc && yyalloc <= YYSTACK_ALLOC_MAXIMUM)) + yyalloc = YYSTACK_ALLOC_MAXIMUM; + if (yymsg != yymsgbuf) + YYSTACK_FREE (yymsg); + yymsg = (char *) YYSTACK_ALLOC (yyalloc); + if (yymsg) + yymsg_alloc = yyalloc; + else + { + yymsg = yymsgbuf; + yymsg_alloc = sizeof yymsgbuf; + } + } + + if (0 < yysize && yysize <= yymsg_alloc) + { + (void) yysyntax_error (yymsg, yystate, yychar); + yyerror (scanner, ctx, scan_ctx, yymsg); + } + else + { + yyerror (scanner, ctx, scan_ctx, YY_("syntax error")); + if (yysize != 0) + goto yyexhaustedlab; + } + } +#endif + } + + + + if (yyerrstatus == 3) + { + /* If just tried and failed to reuse lookahead token after an + error, discard it. */ + + if (yychar <= YYEOF) + { + /* Return failure if at end of input. */ + if (yychar == YYEOF) + YYABORT; + } + else + { + yydestruct ("Error: discarding", + yytoken, &yylval, scanner, ctx, scan_ctx); + yychar = YYEMPTY; + } + } + + /* Else will try to reuse lookahead token after shifting the error + token. */ + goto yyerrlab1; + + +/*---------------------------------------------------. +| yyerrorlab -- error raised explicitly by YYERROR. | +`---------------------------------------------------*/ +yyerrorlab: + + /* Pacify compilers like GCC when the user code never invokes + YYERROR and the label yyerrorlab therefore never appears in user + code. */ + if (/*CONSTCOND*/ 0) + goto yyerrorlab; + + /* Do not reclaim the symbols of the rule which action triggered + this YYERROR. */ + YYPOPSTACK (yylen); + yylen = 0; + YY_STACK_PRINT (yyss, yyssp); + yystate = *yyssp; + goto yyerrlab1; + + +/*-------------------------------------------------------------. +| yyerrlab1 -- common code for both syntax error and YYERROR. | +`-------------------------------------------------------------*/ +yyerrlab1: + yyerrstatus = 3; /* Each real token shifted decrements this. */ + + for (;;) + { + yyn = yypact[yystate]; + if (yyn != YYPACT_NINF) + { + yyn += YYTERROR; + if (0 <= yyn && yyn <= YYLAST && yycheck[yyn] == YYTERROR) + { + yyn = yytable[yyn]; + if (0 < yyn) + break; + } + } + + /* Pop the current state because it cannot handle the error token. */ + if (yyssp == yyss) + YYABORT; + + + yydestruct ("Error: popping", + yystos[yystate], yyvsp, scanner, ctx, scan_ctx); + YYPOPSTACK (1); + yystate = *yyssp; + YY_STACK_PRINT (yyss, yyssp); + } + + *++yyvsp = yylval; + + + /* Shift the error token. */ + YY_SYMBOL_PRINT ("Shifting", yystos[yyn], yyvsp, yylsp); + + yystate = yyn; + goto yynewstate; + + +/*-------------------------------------. +| yyacceptlab -- YYACCEPT comes here. | +`-------------------------------------*/ +yyacceptlab: + yyresult = 0; + goto yyreturn; + +/*-----------------------------------. +| yyabortlab -- YYABORT comes here. | +`-----------------------------------*/ +yyabortlab: + yyresult = 1; + goto yyreturn; + +#if !defined(yyoverflow) || YYERROR_VERBOSE +/*-------------------------------------------------. +| yyexhaustedlab -- memory exhaustion comes here. | +`-------------------------------------------------*/ +yyexhaustedlab: + yyerror (scanner, ctx, scan_ctx, YY_("memory exhausted")); + yyresult = 2; + /* Fall through. */ +#endif + +yyreturn: + if (yychar != YYEMPTY) + yydestruct ("Cleanup: discarding lookahead", + yytoken, &yylval, scanner, ctx, scan_ctx); + /* Do not reclaim the symbols of the rule which action triggered + this YYABORT or YYACCEPT. */ + YYPOPSTACK (yylen); + YY_STACK_PRINT (yyss, yyssp); + while (yyssp != yyss) + { + yydestruct ("Cleanup: popping", + yystos[*yyssp], yyvsp, scanner, ctx, scan_ctx); + YYPOPSTACK (1); + } +#ifndef yyoverflow + if (yyss != yyssa) + YYSTACK_FREE (yyss); +#endif +#if YYERROR_VERBOSE + if (yymsg != yymsgbuf) + YYSTACK_FREE (yymsg); +#endif + /* Make sure YYID is used. */ + return YYID (yyresult); +} + + + +/* Line 1675 of yacc.c */ +#line 395 "grammar.y" + + diff --git a/libconfig-1.4.9/lib/grammar.h b/libconfig-1.4.9/lib/grammar.h new file mode 100644 index 0000000000000000000000000000000000000000..2ce199ddeb387f8cab5c937adefb2c954308e27c --- /dev/null +++ b/libconfig-1.4.9/lib/grammar.h @@ -0,0 +1,113 @@ + +/* A Bison parser, made by GNU Bison 2.4.1. */ + +/* Skeleton interface for Bison's Yacc-like parsers in C + + Copyright (C) 1984, 1989, 1990, 2000, 2001, 2002, 2003, 2004, 2005, 2006 + Free Software Foundation, Inc. + + This program is free software: you can redistribute it and/or modify + it under the terms of the GNU General Public License as published by + the Free Software Foundation, either version 3 of the License, or + (at your option) any later version. + + This program is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + GNU General Public License for more details. + + You should have received a copy of the GNU General Public License + along with this program. If not, see . */ + +/* As a special exception, you may create a larger work that contains + part or all of the Bison parser skeleton and distribute that work + under terms of your choice, so long as that work isn't itself a + parser generator using the skeleton or a modified version thereof + as a parser skeleton. Alternatively, if you modify or redistribute + the parser skeleton itself, you may (at your option) remove this + special exception, which will cause the skeleton and the resulting + Bison output files to be licensed under the GNU General Public + License without this special exception. + + This special exception was added by the Free Software Foundation in + version 2.2 of Bison. */ + + +/* Tokens. */ +#ifndef YYTOKENTYPE +# define YYTOKENTYPE + /* Put the tokens into the symbol table, so that GDB and other debuggers + know about them. */ + enum yytokentype { + TOK_BOOLEAN = 258, + TOK_INTEGER = 259, + TOK_HEX = 260, + TOK_INTEGER64 = 261, + TOK_HEX64 = 262, + TOK_FLOAT = 263, + TOK_STRING = 264, + TOK_NAME = 265, + TOK_EQUALS = 266, + TOK_NEWLINE = 267, + TOK_ARRAY_START = 268, + TOK_ARRAY_END = 269, + TOK_LIST_START = 270, + TOK_LIST_END = 271, + TOK_COMMA = 272, + TOK_GROUP_START = 273, + TOK_GROUP_END = 274, + TOK_SEMICOLON = 275, + TOK_GARBAGE = 276, + TOK_ERROR = 277 + }; +#endif +/* Tokens. */ +#define TOK_BOOLEAN 258 +#define TOK_INTEGER 259 +#define TOK_HEX 260 +#define TOK_INTEGER64 261 +#define TOK_HEX64 262 +#define TOK_FLOAT 263 +#define TOK_STRING 264 +#define TOK_NAME 265 +#define TOK_EQUALS 266 +#define TOK_NEWLINE 267 +#define TOK_ARRAY_START 268 +#define TOK_ARRAY_END 269 +#define TOK_LIST_START 270 +#define TOK_LIST_END 271 +#define TOK_COMMA 272 +#define TOK_GROUP_START 273 +#define TOK_GROUP_END 274 +#define TOK_SEMICOLON 275 +#define TOK_GARBAGE 276 +#define TOK_ERROR 277 + + + + +#if ! defined YYSTYPE && ! defined YYSTYPE_IS_DECLARED +typedef union YYSTYPE +{ + +/* Line 1676 of yacc.c */ +#line 85 "grammar.y" + + int ival; + long long llval; + double fval; + char *sval; + + + +/* Line 1676 of yacc.c */ +#line 105 "grammar.h" +} YYSTYPE; +# define YYSTYPE_IS_TRIVIAL 1 +# define yystype YYSTYPE /* obsolescent; will be withdrawn */ +# define YYSTYPE_IS_DECLARED 1 +#endif + + + + diff --git a/libconfig-1.4.9/lib/grammar.y b/libconfig-1.4.9/lib/grammar.y new file mode 100644 index 0000000000000000000000000000000000000000..f578897cbf09bcc4c2c5524fa5f856d985a4b6e2 --- /dev/null +++ b/libconfig-1.4.9/lib/grammar.y @@ -0,0 +1,395 @@ +/* -*- mode: C -*- */ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +%defines +%output="y.tab.c" +%pure-parser +%lex-param{void *scanner} +%parse-param{void *scanner} +%parse-param{struct parse_context *ctx} +%parse-param{struct scan_context *scan_ctx} + +%{ +#include +#include +#include "libconfig.h" +#ifdef WIN32 +#include "wincompat.h" + +/* prevent warnings about redefined malloc/free in generated code: */ +#ifndef _STDLIB_H +#define _STDLIB_H +#endif + +#include +#endif +#include "parsectx.h" +#include "scanctx.h" + +/* these delcarations are provided to suppress compiler warnings */ +extern int libconfig_yylex(); +extern int libconfig_yyget_lineno(); + +static const char *err_array_elem_type = "mismatched element type in array"; +static const char *err_duplicate_setting = "duplicate setting name"; + +#define _delete(P) free((void *)(P)) + +#define IN_ARRAY() \ + (ctx->parent && (ctx->parent->type == CONFIG_TYPE_ARRAY)) + +#define IN_LIST() \ + (ctx->parent && (ctx->parent->type == CONFIG_TYPE_LIST)) + +static void capture_parse_pos(void *scanner, struct scan_context *scan_ctx, + config_setting_t *setting) +{ + setting->line = (unsigned int)libconfig_yyget_lineno(scanner); + setting->file = scanctx_current_filename(scan_ctx); +} + +#define CAPTURE_PARSE_POS(S) \ + capture_parse_pos(scanner, scan_ctx, (S)) + +void libconfig_yyerror(void *scanner, struct parse_context *ctx, + struct scan_context *scan_ctx, char const *s) +{ + if(ctx->config->error_text) return; + ctx->config->error_line = libconfig_yyget_lineno(scanner); + ctx->config->error_text = s; +} + +%} + +%union +{ + int ival; + long long llval; + double fval; + char *sval; +} + +%token TOK_BOOLEAN TOK_INTEGER TOK_HEX +%token TOK_INTEGER64 TOK_HEX64 +%token TOK_FLOAT +%token TOK_STRING TOK_NAME +%token TOK_EQUALS TOK_NEWLINE TOK_ARRAY_START TOK_ARRAY_END TOK_LIST_START TOK_LIST_END TOK_COMMA TOK_GROUP_START TOK_GROUP_END TOK_SEMICOLON TOK_GARBAGE TOK_ERROR + +%% + +configuration: + /* empty */ + | setting_list + ; + +setting_list: + setting + | setting_list setting + ; + +setting_list_optional: + /* empty */ + | setting_list + ; + +setting_terminator: + /* empty */ + | TOK_SEMICOLON + | TOK_COMMA + ; + +setting: + TOK_NAME + { + ctx->setting = config_setting_add(ctx->parent, $1, CONFIG_TYPE_NONE); + + if(ctx->setting == NULL) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_duplicate_setting); + YYABORT; + } + else + { + CAPTURE_PARSE_POS(ctx->setting); + } + } + + TOK_EQUALS value setting_terminator + ; + +array: + TOK_ARRAY_START + { + if(IN_LIST()) + { + ctx->parent = config_setting_add(ctx->parent, NULL, CONFIG_TYPE_ARRAY); + CAPTURE_PARSE_POS(ctx->parent); + } + else + { + ctx->setting->type = CONFIG_TYPE_ARRAY; + ctx->parent = ctx->setting; + ctx->setting = NULL; + } + } + simple_value_list_optional + TOK_ARRAY_END + { + if(ctx->parent) + ctx->parent = ctx->parent->parent; + } + ; + +list: + TOK_LIST_START + { + if(IN_LIST()) + { + ctx->parent = config_setting_add(ctx->parent, NULL, CONFIG_TYPE_LIST); + CAPTURE_PARSE_POS(ctx->parent); + } + else + { + ctx->setting->type = CONFIG_TYPE_LIST; + ctx->parent = ctx->setting; + ctx->setting = NULL; + } + } + value_list_optional + TOK_LIST_END + { + if(ctx->parent) + ctx->parent = ctx->parent->parent; + } + ; + +value: + simple_value + | array + | list + | group + ; + +string: + TOK_STRING { parsectx_append_string(ctx, $1); free($1); } + | string TOK_STRING { parsectx_append_string(ctx, $2); free($2); } + ; + +simple_value: + TOK_BOOLEAN + { + if(IN_ARRAY() || IN_LIST()) + { + config_setting_t *e = config_setting_set_bool_elem(ctx->parent, -1, + (int)$1); + + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + CAPTURE_PARSE_POS(e); + } + } + else + config_setting_set_bool(ctx->setting, (int)$1); + } + | TOK_INTEGER + { + if(IN_ARRAY() || IN_LIST()) + { + config_setting_t *e = config_setting_set_int_elem(ctx->parent, -1, $1); + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + config_setting_set_format(e, CONFIG_FORMAT_DEFAULT); + CAPTURE_PARSE_POS(e); + } + } + else + { + config_setting_set_int(ctx->setting, $1); + config_setting_set_format(ctx->setting, CONFIG_FORMAT_DEFAULT); + } + } + | TOK_INTEGER64 + { + if(IN_ARRAY() || IN_LIST()) + { + config_setting_t *e = config_setting_set_int64_elem(ctx->parent, -1, $1); + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + config_setting_set_format(e, CONFIG_FORMAT_DEFAULT); + CAPTURE_PARSE_POS(e); + } + } + else + { + config_setting_set_int64(ctx->setting, $1); + config_setting_set_format(ctx->setting, CONFIG_FORMAT_DEFAULT); + } + } + | TOK_HEX + { + if(IN_ARRAY() || IN_LIST()) + { + config_setting_t *e = config_setting_set_int_elem(ctx->parent, -1, $1); + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + config_setting_set_format(e, CONFIG_FORMAT_HEX); + CAPTURE_PARSE_POS(e); + } + } + else + { + config_setting_set_int(ctx->setting, $1); + config_setting_set_format(ctx->setting, CONFIG_FORMAT_HEX); + } + } + | TOK_HEX64 + { + if(IN_ARRAY() || IN_LIST()) + { + config_setting_t *e = config_setting_set_int64_elem(ctx->parent, -1, $1); + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + config_setting_set_format(e, CONFIG_FORMAT_HEX); + CAPTURE_PARSE_POS(e); + } + } + else + { + config_setting_set_int64(ctx->setting, $1); + config_setting_set_format(ctx->setting, CONFIG_FORMAT_HEX); + } + } + | TOK_FLOAT + { + if(IN_ARRAY() || IN_LIST()) + { + config_setting_t *e = config_setting_set_float_elem(ctx->parent, -1, $1); + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + CAPTURE_PARSE_POS(e); + } + } + else + config_setting_set_float(ctx->setting, $1); + } + | string + { + if(IN_ARRAY() || IN_LIST()) + { + const char *s = parsectx_take_string(ctx); + config_setting_t *e = config_setting_set_string_elem(ctx->parent, -1, s); + _delete(s); + + if(! e) + { + libconfig_yyerror(scanner, ctx, scan_ctx, err_array_elem_type); + YYABORT; + } + else + { + CAPTURE_PARSE_POS(e); + } + } + else + { + const char *s = parsectx_take_string(ctx); + config_setting_set_string(ctx->setting, s); + _delete(s); + } + } + ; + +value_list: + value + | value_list TOK_COMMA value + ; + +value_list_optional: + /* empty */ + | value_list + ; + +simple_value_list: + simple_value + | simple_value_list TOK_COMMA simple_value + ; + +simple_value_list_optional: + /* empty */ + | simple_value_list + ; + +group: + TOK_GROUP_START + { + if(IN_LIST()) + { + ctx->parent = config_setting_add(ctx->parent, NULL, CONFIG_TYPE_GROUP); + CAPTURE_PARSE_POS(ctx->parent); + } + else + { + ctx->setting->type = CONFIG_TYPE_GROUP; + ctx->parent = ctx->setting; + ctx->setting = NULL; + } + } + setting_list_optional + TOK_GROUP_END + { + if(ctx->parent) + ctx->parent = ctx->parent->parent; + } + ; + +%% diff --git a/libconfig-1.4.9/lib/libconfig++.pc b/libconfig-1.4.9/lib/libconfig++.pc new file mode 100644 index 0000000000000000000000000000000000000000..5a4aec73ffd36ba78f25d432020a7dfd5d59ffa0 --- /dev/null +++ b/libconfig-1.4.9/lib/libconfig++.pc @@ -0,0 +1,14 @@ +prefix=/usr/local +exec_prefix=${prefix} +libdir=${exec_prefix}/lib +includedir=${prefix}/include + +Name: libconfig++ +Description: C++ Configuration File Library +Version: 1.4.9 +URL: http://www.hyperrealm.com/main.php?s=libconfig +Requires: +Conflicts: +Libs: -L${libdir} -lconfig++ +Libs.private: +Cflags: -I${includedir} diff --git a/libconfig-1.4.9/lib/libconfig++.pc.in b/libconfig-1.4.9/lib/libconfig++.pc.in new file mode 100644 index 0000000000000000000000000000000000000000..2771cc97e73cd4ed6364e7da8170ac0ae496c5cd --- /dev/null +++ b/libconfig-1.4.9/lib/libconfig++.pc.in @@ -0,0 +1,14 @@ +prefix=@prefix@ +exec_prefix=@exec_prefix@ +libdir=@libdir@ +includedir=@includedir@ + +Name: libconfig++ +Description: C++ Configuration File Library +Version: @VERSION@ +URL: http://www.hyperrealm.com/main.php?s=libconfig +Requires: +Conflicts: +Libs: -L${libdir} -lconfig++ +Libs.private: @LIBS@ +Cflags: -I${includedir} diff --git a/libconfig-1.4.9/lib/libconfig++.vcproj b/libconfig-1.4.9/lib/libconfig++.vcproj new file mode 100644 index 0000000000000000000000000000000000000000..98464a75672913a91247899df5bacecbe9681776 --- /dev/null +++ b/libconfig-1.4.9/lib/libconfig++.vcproj @@ -0,0 +1,237 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/libconfig-1.4.9/lib/libconfig.c b/libconfig-1.4.9/lib/libconfig.c new file mode 100644 index 0000000000000000000000000000000000000000..edf7b8b9c4208eb2a9b4296324d2c0d79555cf8c --- /dev/null +++ b/libconfig-1.4.9/lib/libconfig.c @@ -0,0 +1,1616 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#ifdef HAVE_CONFIG_H +#include "ac_config.h" +#endif + +#include "libconfig.h" +#include "grammar.h" +#include "scanner.h" +#include "scanctx.h" +#include "parsectx.h" +#include "wincompat.h" + +#include + +#ifdef HAVE_XLOCALE_H +#include +#endif + +#include +#include +#include + +#define PATH_TOKENS ":./" +#define CHUNK_SIZE 16 +#define FLOAT_PRECISION 10 + +#define _new(T) (T *)calloc(sizeof(T), 1) /* zeroed */ +#define _delete(P) free((void *)(P)) + +/* ------------------------------------------------------------------------- */ + +#ifndef LIBCONFIG_STATIC +#if (defined(WIN32) || defined(_WIN32) || defined(__WIN32__)) + +BOOL WINAPI DllMain(HINSTANCE hinstDLL, DWORD fdwReason, LPVOID lpvReserved) +{ + return(TRUE); +} + +#endif /* WIN32 */ +#endif /* LIBCONFIG_STATIC */ + +/* ------------------------------------------------------------------------- */ + +static const char *__io_error = "file I/O error"; + +static void __config_list_destroy(config_list_t *list); +static void __config_write_setting(const config_setting_t *setting, + FILE *stream, int depth, + unsigned short tab_width); + +extern int libconfig_yyparse(void *scanner, struct parse_context *ctx, + struct scan_context *scan_ctx); +extern int libconfig_yylex_init_extra(struct scan_context *scan_ctx, + yyscan_t *scanner); + +/* ------------------------------------------------------------------------- */ + +static void __config_locale_override(void) +{ +#if (defined(WIN32) || defined(_WIN32) || defined(__WIN32__)) \ + && ! defined(__MINGW32__) + + _configthreadlocale(_ENABLE_PER_THREAD_LOCALE); + setlocale(LC_NUMERIC, "C"); + +#elif defined(__APPLE__) + + locale_t loc = newlocale(LC_NUMERIC_MASK, "C", NULL); + uselocale(loc); + +#elif ((defined HAVE_NEWLOCALE) && (defined HAVE_USELOCALE)) + + locale_t loc = newlocale(LC_NUMERIC, "C", NULL); + uselocale(loc); + +#else + +#warning "No way to modify calling thread's locale!" + +#endif +} + +/* ------------------------------------------------------------------------- */ + +static void __config_locale_restore(void) +{ +#if (defined(WIN32) || defined(_WIN32) || defined(__WIN32__)) \ + && ! defined(__MINGW32__) + + _configthreadlocale(_DISABLE_PER_THREAD_LOCALE); + +#elif ((defined HAVE_USELOCALE) && (defined HAVE_FREELOCALE)) + + locale_t loc = uselocale(LC_GLOBAL_LOCALE); + freelocale(loc); + +#else + +#warning "No way to modify calling thread's locale!" + +#endif +} + +/* ------------------------------------------------------------------------- */ + +static int __config_name_compare(const char *a, const char *b) +{ + const char *p, *q; + + for(p = a, q = b; ; p++, q++) + { + int pd = ((! *p) || strchr(PATH_TOKENS, *p)); + int qd = ((! *q) || strchr(PATH_TOKENS, *q)); + + if(pd && qd) + break; + else if(pd) + return(-1); + else if(qd) + return(1); + else if(*p < *q) + return(-1); + else if(*p > *q) + return(1); + } + + return(0); +} + +/* ------------------------------------------------------------------------- */ + +static void __config_indent(FILE *stream, int depth, unsigned short w) +{ + if(w) + fprintf(stream, "%*s", (depth - 1) * w, " "); + else + { + int i; + for(i = 0; i < (depth - 1); ++i) + fputc('\t', stream); + } +} + +/* ------------------------------------------------------------------------- */ + +static void __config_write_value(const config_value_t *value, int type, + int format, int depth, + unsigned short tab_width, FILE *stream) +{ + char fbuf[64]; + + switch(type) + { + /* boolean */ + case CONFIG_TYPE_BOOL: + fputs(value->ival ? "true" : "false", stream); + break; + + /* int */ + case CONFIG_TYPE_INT: + switch(format) + { + case CONFIG_FORMAT_HEX: + fprintf(stream, "0x%X", value->ival); + break; + + case CONFIG_FORMAT_DEFAULT: + default: + fprintf(stream, "%d", value->ival); + break; + } + break; + + /* 64-bit int */ + case CONFIG_TYPE_INT64: + switch(format) + { + case CONFIG_FORMAT_HEX: + fprintf(stream, "0x" INT64_HEX_FMT "L", value->llval); + break; + + case CONFIG_FORMAT_DEFAULT: + default: + fprintf(stream, INT64_FMT "L", value->llval); + break; + } + break; + + /* float */ + case CONFIG_TYPE_FLOAT: + { + char *q; + + snprintf(fbuf, sizeof(fbuf) - 3, "%.*g", FLOAT_PRECISION, value->fval); + + /* check for exponent */ + q = strchr(fbuf, 'e'); + if(! q) + { + /* no exponent */ + if(! strchr(fbuf, '.')) /* no decimal point */ + strcat(fbuf, ".0"); + else + { + /* has decimal point */ + char *p; + + for(p = fbuf + strlen(fbuf) - 1; p > fbuf; --p) + { + if(*p != '0') + { + *(++p) = '\0'; + break; + } + } + } + } + + fputs(fbuf, stream); + break; + } + + /* string */ + case CONFIG_TYPE_STRING: + { + char *p; + + fputc('\"', stream); + + if(value->sval) + { + for(p = value->sval; *p; p++) + { + int c = (int)*p & 0xFF; + switch(c) + { + case '\"': + case '\\': + fputc('\\', stream); + fputc(c, stream); + break; + + case '\n': + fputs("\\n", stream); + break; + + case '\r': + fputs("\\r", stream); + break; + + case '\f': + fputs("\\f", stream); + break; + + case '\t': + fputs("\\t", stream); + break; + + default: + if(c >= ' ') + fputc(c, stream); + else + fprintf(stream, "\\x%02X", c); + } + } + } + fputc('\"', stream); + break; + } + + /* list */ + case CONFIG_TYPE_LIST: + { + config_list_t *list = value->list; + + fprintf(stream, "( "); + + if(list) + { + int len = list->length; + config_setting_t **s; + + for(s = list->elements; len--; s++) + { + __config_write_value(&((*s)->value), (*s)->type, + config_setting_get_format(*s), + depth + 1, tab_width, stream); + + if(len) + fputc(',', stream); + + fputc(' ', stream); + } + } + + fputc(')', stream); + break; + } + + /* array */ + case CONFIG_TYPE_ARRAY: + { + config_list_t *list = value->list; + + fprintf(stream, "[ "); + + if(list) + { + int len = list->length; + config_setting_t **s; + + for(s = list->elements; len--; s++) + { + __config_write_value(&((*s)->value), (*s)->type, + config_setting_get_format(*s), + depth + 1, tab_width, stream); + + if(len) + fputc(',', stream); + + fputc(' ', stream); + } + } + + fputc(']', stream); + break; + } + + /* group */ + case CONFIG_TYPE_GROUP: + { + config_list_t *list = value->list; + + if(depth > 0) + { +#ifdef K_AND_R_STYLE /* Horrendous, but many people like it. */ + fputc(' ', stream); +#else + fputc('\n', stream); + + if(depth > 1) + __config_indent(stream, depth, tab_width); +#endif + fprintf(stream, "{\n"); + } + + if(list) + { + int len = list->length; + config_setting_t **s; + + for(s = list->elements; len--; s++) + __config_write_setting(*s, stream, depth + 1, tab_width); + } + + if(depth > 1) + __config_indent(stream, depth, tab_width); + + if(depth > 0) + fputc('}', stream); + + break; + } + + default: + /* this shouldn't happen, but handle it gracefully... */ + fputs("???", stream); + break; + } +} + +/* ------------------------------------------------------------------------- */ + +static void __config_list_add(config_list_t *list, config_setting_t *setting) +{ + if((list->length % CHUNK_SIZE) == 0) + { + list->elements = (config_setting_t **)realloc( + list->elements, + (list->length + CHUNK_SIZE) * sizeof(config_setting_t *)); + } + + list->elements[list->length] = setting; + list->length++; +} + +/* ------------------------------------------------------------------------- */ + +static config_setting_t *__config_list_search(config_list_t *list, + const char *name, + unsigned int *idx) +{ + config_setting_t **found = NULL; + unsigned int i; + + if(! list) + return(NULL); + + for(i = 0, found = list->elements; i < list->length; i++, found++) + { + if(! (*found)->name) + continue; + + if(! __config_name_compare(name, (*found)->name)) + { + if(idx) + *idx = i; + + return(*found); + } + } + + return(NULL); +} + +/* ------------------------------------------------------------------------- */ + +static config_setting_t *__config_list_remove(config_list_t *list, int idx) +{ + config_setting_t *removed = *(list->elements + idx); + int offset = (idx * sizeof(config_setting_t *)); + int len = list->length - 1 - idx; + char *base = (char *)list->elements + offset; + + memmove(base, base + sizeof(config_setting_t *), + len * sizeof(config_setting_t *)); + + list->length--; + + /* possibly realloc smaller? */ + + return(removed); +} + +/* ------------------------------------------------------------------------- */ + +static void __config_setting_destroy(config_setting_t *setting) +{ + if(setting) + { + if(setting->name) + _delete(setting->name); + + if(setting->type == CONFIG_TYPE_STRING) + _delete(setting->value.sval); + + else if((setting->type == CONFIG_TYPE_GROUP) + || (setting->type == CONFIG_TYPE_ARRAY) + || (setting->type == CONFIG_TYPE_LIST)) + { + if(setting->value.list) + __config_list_destroy(setting->value.list); + } + + if(setting->hook && setting->config->destructor) + setting->config->destructor(setting->hook); + + _delete(setting); + } +} + +/* ------------------------------------------------------------------------- */ + +static void __config_list_destroy(config_list_t *list) +{ + config_setting_t **p; + unsigned int i; + + if(! list) + return; + + if(list->elements) + { + for(p = list->elements, i = 0; i < list->length; p++, i++) + __config_setting_destroy(*p); + + _delete(list->elements); + } + + _delete(list); +} + +/* ------------------------------------------------------------------------- */ + +static int __config_vector_checktype(const config_setting_t *vector, int type) +{ + /* if the array is empty, then it has no type yet */ + + if(! vector->value.list) + return(CONFIG_TRUE); + + if(vector->value.list->length == 0) + return(CONFIG_TRUE); + + /* if it's a list, any type is allowed */ + + if(vector->type == CONFIG_TYPE_LIST) + return(CONFIG_TRUE); + + /* otherwise the first element added determines the type of the array */ + + return((vector->value.list->elements[0]->type == type) + ? CONFIG_TRUE : CONFIG_FALSE); +} + +/* ------------------------------------------------------------------------- */ + +static int __config_validate_name(const char *name) +{ + const char *p = name; + + if(*p == '\0') + return(CONFIG_FALSE); + + if(! isalpha((int)*p) && (*p != '*')) + return(CONFIG_FALSE); + + for(++p; *p; ++p) + { + if(! (isalpha((int)*p) || isdigit((int)*p) || strchr("*_-", (int)*p))) + return(CONFIG_FALSE); + } + + return(CONFIG_TRUE); +} + +/* ------------------------------------------------------------------------- */ + +static int __config_read(config_t *config, FILE *stream, const char *filename, + const char *str) +{ + yyscan_t scanner; + struct scan_context scan_ctx; + struct parse_context parse_ctx; + YY_BUFFER_STATE buffer = NULL; + int r; + + /* Reinitialize the config */ + void (*destructor)(void *) = config->destructor; + const char *include_dir = config->include_dir; + unsigned short tab_width = config->tab_width; + unsigned short flags = config->flags; + + config->include_dir = NULL; + config_destroy(config); + config_init(config); + + config->destructor = destructor; + config->include_dir = include_dir; + config->tab_width = tab_width; + config->flags = flags; + + parsectx_init(&parse_ctx); + parse_ctx.config = config; + parse_ctx.parent = config->root; + parse_ctx.setting = config->root; + + __config_locale_override(); + + scanctx_init(&scan_ctx, filename); + scan_ctx.config = config; + libconfig_yylex_init_extra(&scan_ctx, &scanner); + + if(stream) + libconfig_yyrestart(stream, scanner); + else /* read from string */ + buffer = libconfig_yy_scan_string(str, scanner); + + libconfig_yyset_lineno(1, scanner); + r = libconfig_yyparse(scanner, &parse_ctx, &scan_ctx); + + if(r != 0) + { + YY_BUFFER_STATE buf; + + config->error_file = scanctx_current_filename(&scan_ctx); + config->error_type = CONFIG_ERR_PARSE; + + /* Unwind the include stack, freeing the buffers and closing the files. */ + while((buf = (YY_BUFFER_STATE)scanctx_pop_include(&scan_ctx)) != NULL) + libconfig_yy_delete_buffer(buf, scanner); + } + + libconfig_yylex_destroy(scanner); + config->filenames = scanctx_cleanup(&scan_ctx, &(config->num_filenames)); + parsectx_cleanup(&parse_ctx); + + __config_locale_restore(); + + return(r == 0 ? CONFIG_TRUE : CONFIG_FALSE); +} + +/* ------------------------------------------------------------------------- */ + +int config_read(config_t *config, FILE *stream) +{ + return(__config_read(config, stream, NULL, NULL)); +} + +/* ------------------------------------------------------------------------- */ + +int config_read_string(config_t *config, const char *str) +{ + return(__config_read(config, NULL, NULL, str)); +} + +/* ------------------------------------------------------------------------- */ + +static void __config_write_setting(const config_setting_t *setting, + FILE *stream, int depth, + unsigned short tab_width) +{ + if(depth > 1) + __config_indent(stream, depth, tab_width); + + if(setting->name) + { + fputs(setting->name, stream); + fprintf(stream, " %c ", (setting->type == CONFIG_TYPE_GROUP ? ':' : '=')); + } + + __config_write_value(&(setting->value), setting->type, + config_setting_get_format(setting), + depth, tab_width, stream); + + if(depth > 0) + { + fputc(';', stream); + fputc('\n', stream); + } +} + +/* ------------------------------------------------------------------------- */ + +void config_write(const config_t *config, FILE *stream) +{ + __config_locale_override(); + + __config_write_setting(config->root, stream, 0, config->tab_width); + + __config_locale_restore(); +} + +/* ------------------------------------------------------------------------- */ + +int config_read_file(config_t *config, const char *filename) +{ + int ret; + FILE *stream = fopen(filename, "rt"); + if(! stream) + { + config->error_text = __io_error; + config->error_type = CONFIG_ERR_FILE_IO; + return(CONFIG_FALSE); + } + + ret = __config_read(config, stream, filename, NULL); + fclose(stream); + + return(ret); +} + +/* ------------------------------------------------------------------------- */ + +int config_write_file(config_t *config, const char *filename) +{ + FILE *f = fopen(filename, "wt"); + if(! f) + { + config->error_text = __io_error; + config->error_type = CONFIG_ERR_FILE_IO; + return(CONFIG_FALSE); + } + + config_write(config, f); + fclose(f); + config->error_type = CONFIG_ERR_NONE; + return(CONFIG_TRUE); +} + +/* ------------------------------------------------------------------------- */ + +void config_destroy(config_t *config) +{ + unsigned int count = config->num_filenames; + const char **f; + + __config_setting_destroy(config->root); + + for(f = config->filenames; count > 0; ++f, --count) + _delete(*f); + + _delete(config->filenames); + _delete(config->include_dir); + + memset((void *)config, 0, sizeof(config_t)); +} + +/* ------------------------------------------------------------------------- */ + +void config_init(config_t *config) +{ + memset((void *)config, 0, sizeof(config_t)); + + config->root = _new(config_setting_t); + config->root->type = CONFIG_TYPE_GROUP; + config->root->config = config; + config->tab_width = 2; +} + +/* ------------------------------------------------------------------------- */ + +void config_set_auto_convert(config_t *config, int flag) +{ + if(flag) + config->flags |= CONFIG_OPTION_AUTOCONVERT; + else + config->flags &= ~CONFIG_OPTION_AUTOCONVERT; +} + +/* ------------------------------------------------------------------------- */ + +int config_get_auto_convert(const config_t *config) +{ + return((config->flags & CONFIG_OPTION_AUTOCONVERT) != 0); +} + +/* ------------------------------------------------------------------------- */ + +static config_setting_t *config_setting_create(config_setting_t *parent, + const char *name, int type) +{ + config_setting_t *setting; + config_list_t *list; + + if((parent->type != CONFIG_TYPE_GROUP) + && (parent->type != CONFIG_TYPE_ARRAY) + && (parent->type != CONFIG_TYPE_LIST)) + return(NULL); + + setting = _new(config_setting_t); + setting->parent = parent; + setting->name = (name == NULL) ? NULL : strdup(name); + setting->type = type; + setting->config = parent->config; + setting->hook = NULL; + setting->line = 0; + + list = parent->value.list; + + if(! list) + list = parent->value.list = _new(config_list_t); + + __config_list_add(list, setting); + + return(setting); +} + +/* ------------------------------------------------------------------------- */ + +static int __config_setting_get_int(const config_setting_t *setting, + int *value) +{ + switch(setting->type) + { + case CONFIG_TYPE_INT: + *value = setting->value.ival; + return(CONFIG_TRUE); + + case CONFIG_TYPE_INT64: + if((setting->value.llval > INT32_MAX) + || (setting->value.llval < INT32_MIN)) + *value = 0; + else + *value = (int)(setting->value.llval); + return(CONFIG_TRUE); + + case CONFIG_TYPE_FLOAT: + if((setting->config->flags & CONFIG_OPTION_AUTOCONVERT) != 0) + { + *value = (int)(setting->value.fval); + return(CONFIG_TRUE); + } + else + { /* fall through */ } + + default: + return(CONFIG_FALSE); + } +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_get_int(const config_setting_t *setting) +{ + int value = 0; + __config_setting_get_int(setting, &value); + return(value); +} + +/* ------------------------------------------------------------------------- */ + +static int __config_setting_get_int64(const config_setting_t *setting, + long long *value) +{ + switch(setting->type) + { + case CONFIG_TYPE_INT64: + *value = setting->value.llval; + return(CONFIG_TRUE); + + case CONFIG_TYPE_INT: + *value = (long long)(setting->value.ival); + return(CONFIG_TRUE); + + case CONFIG_TYPE_FLOAT: + if((setting->config->flags & CONFIG_OPTION_AUTOCONVERT) != 0) + { + *value = (long long)(setting->value.fval); + return(CONFIG_TRUE); + } + else + { /* fall through */ } + + default: + return(CONFIG_FALSE); + } +} + +/* ------------------------------------------------------------------------- */ + +long long config_setting_get_int64(const config_setting_t *setting) +{ + long long value = 0; + __config_setting_get_int64(setting, &value); + return(value); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_lookup_int(const config_setting_t *setting, + const char *name, int *value) +{ + config_setting_t *member = config_setting_get_member(setting, name); + if(! member) + return(CONFIG_FALSE); + + return(__config_setting_get_int(member, value)); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_lookup_int64(const config_setting_t *setting, + const char *name, long long *value) +{ + config_setting_t *member = config_setting_get_member(setting, name); + if(! member) + return(CONFIG_FALSE); + + return(__config_setting_get_int64(member, value)); +} + +/* ------------------------------------------------------------------------- */ + +static int __config_setting_get_float(const config_setting_t *setting, + double *value) +{ + switch(setting->type) + { + case CONFIG_TYPE_FLOAT: + *value = setting->value.fval; + return(CONFIG_TRUE); + + case CONFIG_TYPE_INT: + if(config_get_auto_convert(setting->config)) + { + *value = (double)(setting->value.ival); + return(CONFIG_TRUE); + } + else + return(CONFIG_FALSE); + + case CONFIG_TYPE_INT64: + if(config_get_auto_convert(setting->config)) + { + *value = (double)(setting->value.llval); + return(CONFIG_TRUE); + } + else + { /* fall through */ } + + default: + return(CONFIG_FALSE); + } +} + +/* ------------------------------------------------------------------------- */ + +double config_setting_get_float(const config_setting_t *setting) +{ + double value = 0.0; + __config_setting_get_float(setting, &value); + return(value); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_lookup_float(const config_setting_t *setting, + const char *name, double *value) +{ + config_setting_t *member = config_setting_get_member(setting, name); + if(! member) + return(CONFIG_FALSE); + + return(__config_setting_get_float(member, value)); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_lookup_string(const config_setting_t *setting, + const char *name, const char **value) +{ + config_setting_t *member = config_setting_get_member(setting, name); + if(! member) + return(CONFIG_FALSE); + + if(config_setting_type(member) != CONFIG_TYPE_STRING) + return(CONFIG_FALSE); + + *value = config_setting_get_string(member); + return(CONFIG_TRUE); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_lookup_bool(const config_setting_t *setting, + const char *name, int *value) +{ + config_setting_t *member = config_setting_get_member(setting, name); + if(! member) + return(CONFIG_FALSE); + + if(config_setting_type(member) != CONFIG_TYPE_BOOL) + return(CONFIG_FALSE); + + *value = config_setting_get_bool(member); + return(CONFIG_TRUE); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_set_int(config_setting_t *setting, int value) +{ + switch(setting->type) + { + case CONFIG_TYPE_NONE: + setting->type = CONFIG_TYPE_INT; + /* fall through */ + + case CONFIG_TYPE_INT: + setting->value.ival = value; + return(CONFIG_TRUE); + + case CONFIG_TYPE_FLOAT: + if(config_get_auto_convert(setting->config)) + { + setting->value.fval = (float)value; + return(CONFIG_TRUE); + } + else + return(CONFIG_FALSE); + + default: + return(CONFIG_FALSE); + } +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_set_int64(config_setting_t *setting, long long value) +{ + switch(setting->type) + { + case CONFIG_TYPE_NONE: + setting->type = CONFIG_TYPE_INT64; + /* fall through */ + + case CONFIG_TYPE_INT64: + setting->value.llval = value; + return(CONFIG_TRUE); + + case CONFIG_TYPE_INT: + if((value > INT32_MAX) || (value < INT32_MIN)) + setting->value.ival = 0; + else + setting->value.ival = (int)value; + return(CONFIG_TRUE); + + case CONFIG_TYPE_FLOAT: + if(config_get_auto_convert(setting->config)) + { + setting->value.fval = (float)value; + return(CONFIG_TRUE); + } + else + return(CONFIG_FALSE); + + default: + return(CONFIG_FALSE); + } +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_set_float(config_setting_t *setting, double value) +{ + switch(setting->type) + { + case CONFIG_TYPE_NONE: + setting->type = CONFIG_TYPE_FLOAT; + /* fall through */ + + case CONFIG_TYPE_FLOAT: + setting->value.fval = value; + return(CONFIG_TRUE); + + case CONFIG_TYPE_INT: + if((setting->config->flags & CONFIG_OPTION_AUTOCONVERT) != 0) + { + setting->value.ival = (int)value; + return(CONFIG_TRUE); + } + else + return(CONFIG_FALSE); + + case CONFIG_TYPE_INT64: + if((setting->config->flags & CONFIG_OPTION_AUTOCONVERT) != 0) + { + setting->value.llval = (long long)value; + return(CONFIG_TRUE); + } + else + return(CONFIG_FALSE); + + default: + return(CONFIG_FALSE); + } +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_get_bool(const config_setting_t *setting) +{ + return((setting->type == CONFIG_TYPE_BOOL) ? setting->value.ival : 0); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_set_bool(config_setting_t *setting, int value) +{ + if(setting->type == CONFIG_TYPE_NONE) + setting->type = CONFIG_TYPE_BOOL; + else if(setting->type != CONFIG_TYPE_BOOL) + return(CONFIG_FALSE); + + setting->value.ival = value; + return(CONFIG_TRUE); +} + +/* ------------------------------------------------------------------------- */ + +const char *config_setting_get_string(const config_setting_t *setting) +{ + return((setting->type == CONFIG_TYPE_STRING) ? setting->value.sval : NULL); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_set_string(config_setting_t *setting, const char *value) +{ + if(setting->type == CONFIG_TYPE_NONE) + setting->type = CONFIG_TYPE_STRING; + else if(setting->type != CONFIG_TYPE_STRING) + return(CONFIG_FALSE); + + if(setting->value.sval) + _delete(setting->value.sval); + + setting->value.sval = (value == NULL) ? NULL : strdup(value); + return(CONFIG_TRUE); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_set_format(config_setting_t *setting, short format) +{ + if(((setting->type != CONFIG_TYPE_INT) + && (setting->type != CONFIG_TYPE_INT64)) + || ((format != CONFIG_FORMAT_DEFAULT) && (format != CONFIG_FORMAT_HEX))) + return(CONFIG_FALSE); + + setting->format = format; + + return(CONFIG_TRUE); +} + +/* ------------------------------------------------------------------------- */ + +short config_setting_get_format(const config_setting_t *setting) +{ + return(setting->format != 0 ? setting->format + : setting->config->default_format); +} + +/* ------------------------------------------------------------------------- */ + +config_setting_t *config_lookup_from(config_setting_t *setting, + const char *path) +{ + const char *p = path; + config_setting_t *found; + + for(;;) + { + while(*p && strchr(PATH_TOKENS, *p)) + p++; + + if(! *p) + break; + + if(*p == '[') + found = config_setting_get_elem(setting, atoi(++p)); + else + found = config_setting_get_member(setting, p); + + if(! found) + break; + + setting = found; + + while(! strchr(PATH_TOKENS, *p)) + p++; + } + + return(*p ? NULL : setting); +} + +/* ------------------------------------------------------------------------- */ + +config_setting_t *config_lookup(const config_t *config, const char *path) +{ + return(config_lookup_from(config->root, path)); +} + +/* ------------------------------------------------------------------------- */ + +int config_lookup_string(const config_t *config, const char *path, + const char **value) +{ + const config_setting_t *s = config_lookup(config, path); + if(! s) + return(CONFIG_FALSE); + + if(config_setting_type(s) != CONFIG_TYPE_STRING) + return(CONFIG_FALSE); + + *value = config_setting_get_string(s); + + return(CONFIG_TRUE); +} + +/* ------------------------------------------------------------------------- */ + +int config_lookup_int(const config_t *config, const char *path, + int *value) +{ + const config_setting_t *s = config_lookup(config, path); + if(! s) + return(CONFIG_FALSE); + + return(__config_setting_get_int(s, value)); +} + +/* ------------------------------------------------------------------------- */ + +int config_lookup_int64(const config_t *config, const char *path, + long long *value) +{ + const config_setting_t *s = config_lookup(config, path); + if(! s) + return(CONFIG_FALSE); + + return(__config_setting_get_int64(s, value)); +} + +/* ------------------------------------------------------------------------- */ + +int config_lookup_float(const config_t *config, const char *path, + double *value) +{ + const config_setting_t *s = config_lookup(config, path); + if(! s) + return(CONFIG_FALSE); + + return(__config_setting_get_float(s, value)); +} + +/* ------------------------------------------------------------------------- */ + +int config_lookup_bool(const config_t *config, const char *path, int *value) +{ + const config_setting_t *s = config_lookup(config, path); + if(! s) + return(CONFIG_FALSE); + + if(config_setting_type(s) != CONFIG_TYPE_BOOL) + return(CONFIG_FALSE); + + *value = config_setting_get_bool(s); + return(CONFIG_TRUE); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_get_int_elem(const config_setting_t *vector, int idx) +{ + const config_setting_t *element = config_setting_get_elem(vector, idx); + + return(element ? config_setting_get_int(element) : 0); +} + +/* ------------------------------------------------------------------------- */ + +config_setting_t *config_setting_set_int_elem(config_setting_t *vector, + int idx, int value) +{ + config_setting_t *element = NULL; + + if((vector->type != CONFIG_TYPE_ARRAY) && (vector->type != CONFIG_TYPE_LIST)) + return(NULL); + + if(idx < 0) + { + if(! __config_vector_checktype(vector, CONFIG_TYPE_INT)) + return(NULL); + + element = config_setting_create(vector, NULL, CONFIG_TYPE_INT); + } + else + { + element = config_setting_get_elem(vector, idx); + + if(! element) + return(NULL); + } + + if(! config_setting_set_int(element, value)) + return(NULL); + + return(element); +} + +/* ------------------------------------------------------------------------- */ + +long long config_setting_get_int64_elem(const config_setting_t *vector, + int idx) +{ + const config_setting_t *element = config_setting_get_elem(vector, idx); + + return(element ? config_setting_get_int64(element) : 0); +} + +/* ------------------------------------------------------------------------- */ + +config_setting_t *config_setting_set_int64_elem(config_setting_t *vector, + int idx, long long value) +{ + config_setting_t *element = NULL; + + if((vector->type != CONFIG_TYPE_ARRAY) && (vector->type != CONFIG_TYPE_LIST)) + return(NULL); + + if(idx < 0) + { + if(! __config_vector_checktype(vector, CONFIG_TYPE_INT64)) + return(NULL); + + element = config_setting_create(vector, NULL, CONFIG_TYPE_INT64); + } + else + { + element = config_setting_get_elem(vector, idx); + + if(! element) + return(NULL); + } + + if(! config_setting_set_int64(element, value)) + return(NULL); + + return(element); +} + +/* ------------------------------------------------------------------------- */ + +double config_setting_get_float_elem(const config_setting_t *vector, int idx) +{ + config_setting_t *element = config_setting_get_elem(vector, idx); + + return(element ? config_setting_get_float(element) : 0.0); +} + +/* ------------------------------------------------------------------------- */ + +config_setting_t *config_setting_set_float_elem(config_setting_t *vector, + int idx, double value) +{ + config_setting_t *element = NULL; + + if((vector->type != CONFIG_TYPE_ARRAY) && (vector->type != CONFIG_TYPE_LIST)) + return(NULL); + + if(idx < 0) + { + if(! __config_vector_checktype(vector, CONFIG_TYPE_FLOAT)) + return(NULL); + + element = config_setting_create(vector, NULL, CONFIG_TYPE_FLOAT); + } + else + element = config_setting_get_elem(vector, idx); + + if(! element) + return(NULL); + + if(! config_setting_set_float(element, value)) + return(NULL); + + return(element); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_get_bool_elem(const config_setting_t *vector, int idx) +{ + config_setting_t *element = config_setting_get_elem(vector, idx); + + if(! element) + return(CONFIG_FALSE); + + if(element->type != CONFIG_TYPE_BOOL) + return(CONFIG_FALSE); + + return(element->value.ival); +} + +/* ------------------------------------------------------------------------- */ + +config_setting_t *config_setting_set_bool_elem(config_setting_t *vector, + int idx, int value) +{ + config_setting_t *element = NULL; + + if((vector->type != CONFIG_TYPE_ARRAY) && (vector->type != CONFIG_TYPE_LIST)) + return(NULL); + + if(idx < 0) + { + if(! __config_vector_checktype(vector, CONFIG_TYPE_BOOL)) + return(NULL); + + element = config_setting_create(vector, NULL, CONFIG_TYPE_BOOL); + } + else + element = config_setting_get_elem(vector, idx); + + if(! element) + return(NULL); + + if(! config_setting_set_bool(element, value)) + return(NULL); + + return(element); +} + +/* ------------------------------------------------------------------------- */ + +const char *config_setting_get_string_elem(const config_setting_t *vector, + int idx) +{ + config_setting_t *element = config_setting_get_elem(vector, idx); + + if(! element) + return(NULL); + + if(element->type != CONFIG_TYPE_STRING) + return(NULL); + + return(element->value.sval); +} + +/* ------------------------------------------------------------------------- */ + +config_setting_t *config_setting_set_string_elem(config_setting_t *vector, + int idx, const char *value) +{ + config_setting_t *element = NULL; + + if((vector->type != CONFIG_TYPE_ARRAY) && (vector->type != CONFIG_TYPE_LIST)) + return(NULL); + + if(idx < 0) + { + if(! __config_vector_checktype(vector, CONFIG_TYPE_STRING)) + return(NULL); + + element = config_setting_create(vector, NULL, CONFIG_TYPE_STRING); + } + else + element = config_setting_get_elem(vector, idx); + + if(! element) + return(NULL); + + if(! config_setting_set_string(element, value)) + return(NULL); + + return(element); +} + +/* ------------------------------------------------------------------------- */ + +config_setting_t *config_setting_get_elem(const config_setting_t *vector, + unsigned int idx) +{ + config_list_t *list = vector->value.list; + + if(((vector->type != CONFIG_TYPE_ARRAY) + && (vector->type != CONFIG_TYPE_LIST) + && (vector->type != CONFIG_TYPE_GROUP)) || ! list) + return(NULL); + + if(idx >= list->length) + return(NULL); + + return(list->elements[idx]); +} + +/* ------------------------------------------------------------------------- */ + +config_setting_t *config_setting_get_member(const config_setting_t *setting, + const char *name) +{ + if(setting->type != CONFIG_TYPE_GROUP) + return(NULL); + + return(__config_list_search(setting->value.list, name, NULL)); +} + +/* ------------------------------------------------------------------------- */ + +void config_set_destructor(config_t *config, void (*destructor)(void *)) +{ + config->destructor = destructor; +} + +/* ------------------------------------------------------------------------- */ + +void config_set_include_dir(config_t *config, const char *include_dir) +{ + _delete(config->include_dir); + config->include_dir = strdup(include_dir); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_length(const config_setting_t *setting) +{ + if((setting->type != CONFIG_TYPE_GROUP) + && (setting->type != CONFIG_TYPE_ARRAY) + && (setting->type != CONFIG_TYPE_LIST)) + return(0); + + if(! setting->value.list) + return(0); + + return(setting->value.list->length); +} + +/* ------------------------------------------------------------------------- */ + +void config_setting_set_hook(config_setting_t *setting, void *hook) +{ + setting->hook = hook; +} + +/* ------------------------------------------------------------------------- */ + +config_setting_t *config_setting_add(config_setting_t *parent, + const char *name, int type) +{ + if((type < CONFIG_TYPE_NONE) || (type > CONFIG_TYPE_LIST)) + return(NULL); + + if(! parent) + return(NULL); + + if((parent->type == CONFIG_TYPE_ARRAY) || (parent->type == CONFIG_TYPE_LIST)) + name = NULL; + + if(name) + { + if(! __config_validate_name(name)) + return(NULL); + } + + if(config_setting_get_member(parent, name) != NULL) + return(NULL); /* already exists */ + + return(config_setting_create(parent, name, type)); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_remove(config_setting_t *parent, const char *name) +{ + unsigned int idx; + config_setting_t *setting; + + if(! parent) + return(CONFIG_FALSE); + + if(parent->type != CONFIG_TYPE_GROUP) + return(CONFIG_FALSE); + + if(! (setting = __config_list_search(parent->value.list, name, &idx))) + return(CONFIG_FALSE); + + __config_list_remove(parent->value.list, idx); + __config_setting_destroy(setting); + + return(CONFIG_TRUE); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_remove_elem(config_setting_t *parent, unsigned int idx) +{ + config_list_t *list; + config_setting_t *removed = NULL; + + if(! parent) + return(CONFIG_FALSE); + + list = parent->value.list; + + if(((parent->type != CONFIG_TYPE_ARRAY) + && (parent->type != CONFIG_TYPE_LIST) + && (parent->type != CONFIG_TYPE_GROUP)) || ! list) + return(CONFIG_FALSE); + + if(idx >= list->length) + return(CONFIG_FALSE); + + removed = __config_list_remove(list, idx); + __config_setting_destroy(removed); + + return(CONFIG_TRUE); +} + +/* ------------------------------------------------------------------------- */ + +int config_setting_index(const config_setting_t *setting) +{ + config_setting_t **found = NULL; + config_list_t *list; + int i; + + if(! setting->parent) + return(-1); + + list = setting->parent->value.list; + + for(i = 0, found = list->elements; i < (int)list->length; ++i, ++found) + { + if(*found == setting) + return(i); + } + + return(-1); +} + +/* ------------------------------------------------------------------------- */ +/* eof */ diff --git a/libconfig-1.4.9/lib/libconfig.h b/libconfig-1.4.9/lib/libconfig.h new file mode 100644 index 0000000000000000000000000000000000000000..1774a26d83809d6c24efb8e5304ce223a5ea2c79 --- /dev/null +++ b/libconfig-1.4.9/lib/libconfig.h @@ -0,0 +1,321 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#ifndef __libconfig_h +#define __libconfig_h + +#ifdef __cplusplus +extern "C" { +#endif /* __cplusplus */ + +#if defined(_WIN32) || defined(__WIN32__) || defined(WIN32) +#if defined(LIBCONFIG_STATIC) +#define LIBCONFIG_API +#elif defined(LIBCONFIG_EXPORTS) +#define LIBCONFIG_API __declspec(dllexport) +#else /* ! LIBCONFIG_EXPORTS */ +#define LIBCONFIG_API __declspec(dllimport) +#endif /* LIBCONFIG_STATIC */ +#else /* ! WIN32 */ +#define LIBCONFIG_API +#endif /* WIN32 */ + +#define LIBCONFIG_VER_MAJOR 1 +#define LIBCONFIG_VER_MINOR 4 +#define LIBCONFIG_VER_REVISION 9 + +#include + +#define CONFIG_TYPE_NONE 0 +#define CONFIG_TYPE_GROUP 1 +#define CONFIG_TYPE_INT 2 +#define CONFIG_TYPE_INT64 3 +#define CONFIG_TYPE_FLOAT 4 +#define CONFIG_TYPE_STRING 5 +#define CONFIG_TYPE_BOOL 6 +#define CONFIG_TYPE_ARRAY 7 +#define CONFIG_TYPE_LIST 8 + +#define CONFIG_FORMAT_DEFAULT 0 +#define CONFIG_FORMAT_HEX 1 + +#define CONFIG_OPTION_AUTOCONVERT 0x01 + +#define CONFIG_TRUE (1) +#define CONFIG_FALSE (0) + +typedef union config_value_t +{ + int ival; + long long llval; + double fval; + char *sval; + struct config_list_t *list; +} config_value_t; + +typedef struct config_setting_t +{ + char *name; + short type; + short format; + config_value_t value; + struct config_setting_t *parent; + struct config_t *config; + void *hook; + unsigned int line; + const char *file; +} config_setting_t; + +typedef enum +{ + CONFIG_ERR_NONE = 0, + CONFIG_ERR_FILE_IO = 1, + CONFIG_ERR_PARSE = 2 +} config_error_t; + +typedef struct config_list_t +{ + unsigned int length; + config_setting_t **elements; +} config_list_t; + +typedef struct config_t +{ + config_setting_t *root; + void (*destructor)(void *); + unsigned short flags; + unsigned short tab_width; + short default_format; + const char *include_dir; + const char *error_text; + const char *error_file; + int error_line; + config_error_t error_type; + const char **filenames; + unsigned int num_filenames; +} config_t; + +extern LIBCONFIG_API int config_read(config_t *config, FILE *stream); +extern LIBCONFIG_API void config_write(const config_t *config, FILE *stream); + +extern LIBCONFIG_API void config_set_default_format(config_t *config, + short format); + +extern LIBCONFIG_API void config_set_auto_convert(config_t *config, int flag); +extern LIBCONFIG_API int config_get_auto_convert(const config_t *config); + +extern LIBCONFIG_API int config_read_string(config_t *config, const char *str); + +extern LIBCONFIG_API int config_read_file(config_t *config, + const char *filename); +extern LIBCONFIG_API int config_write_file(config_t *config, + const char *filename); + +extern LIBCONFIG_API void config_set_destructor(config_t *config, + void (*destructor)(void *)); +extern LIBCONFIG_API void config_set_include_dir(config_t *config, + const char *include_dir); + +extern LIBCONFIG_API void config_init(config_t *config); +extern LIBCONFIG_API void config_destroy(config_t *config); + +extern LIBCONFIG_API int config_setting_get_int( + const config_setting_t *setting); +extern LIBCONFIG_API long long config_setting_get_int64( + const config_setting_t *setting); +extern LIBCONFIG_API double config_setting_get_float( + const config_setting_t *setting); +extern LIBCONFIG_API int config_setting_get_bool( + const config_setting_t *setting); +extern LIBCONFIG_API const char *config_setting_get_string( + const config_setting_t *setting); + +extern LIBCONFIG_API int config_setting_lookup_int( + const config_setting_t *setting, const char *name, int *value); +extern LIBCONFIG_API int config_setting_lookup_int64( + const config_setting_t *setting, const char *name, long long *value); +extern LIBCONFIG_API int config_setting_lookup_float( + const config_setting_t *setting, const char *name, double *value); +extern LIBCONFIG_API int config_setting_lookup_bool( + const config_setting_t *setting, const char *name, int *value); +extern LIBCONFIG_API int config_setting_lookup_string( + const config_setting_t *setting, const char *name, const char **value); + +extern LIBCONFIG_API int config_setting_set_int(config_setting_t *setting, + int value); +extern LIBCONFIG_API int config_setting_set_int64(config_setting_t *setting, + long long value); +extern LIBCONFIG_API int config_setting_set_float(config_setting_t *setting, + double value); +extern LIBCONFIG_API int config_setting_set_bool(config_setting_t *setting, + int value); +extern LIBCONFIG_API int config_setting_set_string(config_setting_t *setting, + const char *value); + +extern LIBCONFIG_API int config_setting_set_format(config_setting_t *setting, + short format); +extern LIBCONFIG_API short config_setting_get_format( + const config_setting_t *setting); + +extern LIBCONFIG_API int config_setting_get_int_elem( + const config_setting_t *setting, int idx); +extern LIBCONFIG_API long long config_setting_get_int64_elem( + const config_setting_t *setting, int idx); +extern LIBCONFIG_API double config_setting_get_float_elem( + const config_setting_t *setting, int idx); +extern LIBCONFIG_API int config_setting_get_bool_elem( + const config_setting_t *setting, int idx); +extern LIBCONFIG_API const char *config_setting_get_string_elem( + const config_setting_t *setting, int idx); + +extern LIBCONFIG_API config_setting_t *config_setting_set_int_elem( + config_setting_t *setting, int idx, int value); +extern LIBCONFIG_API config_setting_t *config_setting_set_int64_elem( + config_setting_t *setting, int idx, long long value); +extern LIBCONFIG_API config_setting_t *config_setting_set_float_elem( + config_setting_t *setting, int idx, double value); +extern LIBCONFIG_API config_setting_t *config_setting_set_bool_elem( + config_setting_t *setting, int idx, int value); +extern LIBCONFIG_API config_setting_t *config_setting_set_string_elem( + config_setting_t *setting, int idx, const char *value); + +#define /* const char * */ config_get_include_dir(/* const config_t * */ C) \ + ((C)->include_dir) + +#define /* int */ config_setting_type(/* const config_setting_t * */ S) \ + ((S)->type) + +#define /* int */ config_setting_is_group(/* const config_setting_t * */ S) \ + ((S)->type == CONFIG_TYPE_GROUP) +#define /* int */ config_setting_is_array(/* const config_setting_t * */ S) \ + ((S)->type == CONFIG_TYPE_ARRAY) +#define /* int */ config_setting_is_list(/* const config_setting_t * */ S) \ + ((S)->type == CONFIG_TYPE_LIST) + +#define /* int */ config_setting_is_aggregate( \ + /* const config_setting_t * */ S) \ + (((S)->type == CONFIG_TYPE_GROUP) || ((S)->type == CONFIG_TYPE_LIST) \ + || ((S)->type == CONFIG_TYPE_ARRAY)) + +#define /* int */ config_setting_is_number(/* const config_setting_t * */ S) \ + (((S)->type == CONFIG_TYPE_INT) \ + || ((S)->type == CONFIG_TYPE_INT64) \ + || ((S)->type == CONFIG_TYPE_FLOAT)) + +#define /* int */ config_setting_is_scalar(/* const config_setting_t * */ S) \ + (((S)->type == CONFIG_TYPE_BOOL) || ((S)->type == CONFIG_TYPE_STRING) \ + || config_setting_is_number(S)) + +#define /* const char * */ config_setting_name( \ + /* const config_setting_t * */ S) \ + ((S)->name) + +#define /* config_setting_t * */ config_setting_parent( \ + /* const config_setting_t * */ S) \ + ((S)->parent) + +#define /* int */ config_setting_is_root( \ + /* const config_setting_t * */ S) \ + ((S)->parent ? CONFIG_FALSE : CONFIG_TRUE) + +extern LIBCONFIG_API int config_setting_index(const config_setting_t *setting); + +extern LIBCONFIG_API int config_setting_length( + const config_setting_t *setting); +extern LIBCONFIG_API config_setting_t *config_setting_get_elem( + const config_setting_t *setting, unsigned int idx); + +extern LIBCONFIG_API config_setting_t *config_setting_get_member( + const config_setting_t *setting, const char *name); + +extern LIBCONFIG_API config_setting_t *config_setting_add( + config_setting_t *parent, const char *name, int type); +extern LIBCONFIG_API int config_setting_remove(config_setting_t *parent, + const char *name); +extern LIBCONFIG_API int config_setting_remove_elem(config_setting_t *parent, + unsigned int idx); +extern LIBCONFIG_API void config_setting_set_hook(config_setting_t *setting, + void *hook); + +#define config_setting_get_hook(S) ((S)->hook) + +extern LIBCONFIG_API config_setting_t *config_lookup(const config_t *config, + const char *path); +extern LIBCONFIG_API config_setting_t *config_lookup_from( + config_setting_t *setting, const char *path); + +extern LIBCONFIG_API int config_lookup_int(const config_t *config, + const char *path, int *value); +extern LIBCONFIG_API int config_lookup_int64(const config_t *config, + const char *path, + long long *value); +extern LIBCONFIG_API int config_lookup_float(const config_t *config, + const char *path, double *value); +extern LIBCONFIG_API int config_lookup_bool(const config_t *config, + const char *path, int *value); +extern LIBCONFIG_API int config_lookup_string(const config_t *config, + const char *path, + const char **value); + +#define /* config_setting_t * */ config_root_setting( \ + /* const config_t * */ C) \ + ((C)->root) + +#define /* void */ config_set_default_format(/* config_t * */ C, \ + /* short */ F) \ + (C)->default_format = (F) + +#define /* short */ config_get_default_format(/* config_t * */ C) \ + ((C)->default_format) + +#define /* void */ config_set_tab_width(/* config_t * */ C, \ + /* unsigned short */ W) \ + (C)->tab_width = ((W) & 0x0F) + +#define /* unsigned char */ config_get_tab_width(/* const config_t * */ C) \ + ((C)->tab_width) + +#define /* unsigned short */ config_setting_source_line( \ + /* const config_setting_t * */ S) \ + ((S)->line) + +#define /* const char */ config_setting_source_file( \ + /* const config_setting_t * */ S) \ + ((S)->file) + +#define /* const char * */ config_error_text(/* const config_t * */ C) \ + ((C)->error_text) + +#define /* const char * */ config_error_file(/* const config_t * */ C) \ + ((C)->error_file) + +#define /* int */ config_error_line(/* const config_t * */ C) \ + ((C)->error_line) + +#define /* config_error_t */ config_error_type(/* const config_t * */ C) \ + ((C)->error_type) + +#ifdef __cplusplus +} +#endif /* __cplusplus */ + +#endif /* __libconfig_h */ diff --git a/libconfig-1.4.9/lib/libconfig.h++ b/libconfig-1.4.9/lib/libconfig.h++ new file mode 100644 index 0000000000000000000000000000000000000000..04be7a9505a1c1d984a109eab14f180718f88105 --- /dev/null +++ b/libconfig-1.4.9/lib/libconfig.h++ @@ -0,0 +1,458 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#ifndef __libconfig_hpp +#define __libconfig_hpp + +#include +#include +#include + +#if defined(_WIN32) || defined(__WIN32__) || defined(WIN32) +#if defined(LIBCONFIGXX_STATIC) +#define LIBCONFIGXX_API +#elif defined(LIBCONFIGXX_EXPORTS) +#define LIBCONFIGXX_API __declspec(dllexport) +#else /* ! LIBCONFIGXX_EXPORTS */ +#define LIBCONFIGXX_API __declspec(dllimport) +#endif /* LIBCONFIGXX_STATIC */ +#else /* ! WIN32 */ +#define LIBCONFIGXX_API +#endif /* WIN32 */ + +#define LIBCONFIGXX_VER_MAJOR 1 +#define LIBCONFIGXX_VER_MINOR 4 +#define LIBCONFIGXX_VER_REVISION 9 + +struct config_t; // fwd decl +struct config_setting_t; // fwd decl + +namespace libconfig { + +class LIBCONFIGXX_API ConfigException : public std::exception { }; + +class Setting; // fwd decl + +class LIBCONFIGXX_API SettingException : public ConfigException +{ + friend class Config; + + public: + + SettingException(const SettingException &other); + SettingException& operator=(const SettingException &other); + + virtual ~SettingException() throw(); + + const char *getPath() const; + + virtual const char *what() const throw(); + + protected: + + SettingException(const Setting &setting); + SettingException(const Setting &setting, int idx); + SettingException(const Setting &setting, const char *name); + SettingException(const char *path); + + private: + + char *_path; +}; + +class LIBCONFIGXX_API SettingTypeException : public SettingException +{ + friend class Config; + friend class Setting; + + public: + + virtual const char *what() const throw(); + + private: + + SettingTypeException(const Setting &setting); + SettingTypeException(const Setting &setting, int idx); + SettingTypeException(const Setting &setting, const char *name); +}; + +class LIBCONFIGXX_API SettingNotFoundException : public SettingException +{ + friend class Config; + friend class Setting; + + public: + + virtual const char *what() const throw(); + + private: + + SettingNotFoundException(const Setting &setting, int idx); + SettingNotFoundException(const Setting &setting, const char *name); + SettingNotFoundException(const char *path); +}; + +class LIBCONFIGXX_API SettingNameException : public SettingException +{ + friend class Config; + friend class Setting; + + public: + + virtual const char *what() const throw(); + + private: + + SettingNameException(const Setting &setting, const char *name); +}; + +class LIBCONFIGXX_API FileIOException : public ConfigException +{ + public: + + virtual const char *what() const throw(); +}; + +class LIBCONFIGXX_API ParseException : public ConfigException +{ + friend class Config; + + public: + + ParseException(const ParseException &other); + + virtual ~ParseException() throw(); + + inline const char *getFile() const throw() + { return(_file); } + + inline int getLine() const throw() + { return(_line); } + + inline const char *getError() const throw() + { return(_error); } + + virtual const char *what() const throw(); + + private: + + ParseException(const char *file, int line, const char *error); + + const char *_file; + int _line; + const char *_error; +}; + +class LIBCONFIGXX_API Setting +{ + friend class Config; + + public: + + enum Type + { + TypeNone = 0, + // scalar types + TypeInt, + TypeInt64, + TypeFloat, + TypeString, + TypeBoolean, + // aggregate types + TypeGroup, + TypeArray, + TypeList + }; + + enum Format + { + FormatDefault = 0, + FormatHex = 1 + }; + + private: + + config_setting_t *_setting; + Type _type; + Format _format; + + Setting(config_setting_t *setting); + + void assertType(Type type) const throw(SettingTypeException); + static Setting & wrapSetting(config_setting_t *setting); + + Setting(const Setting& other); // not supported + Setting& operator=(const Setting& other); // not supported + + public: + + virtual ~Setting() throw(); + + inline Type getType() const throw() { return(_type); } + + inline Format getFormat() const throw() { return(_format); } + void setFormat(Format format) throw(); + + operator bool() const throw(SettingTypeException); + operator int() const throw(SettingTypeException); + operator unsigned int() const throw(SettingTypeException); + operator long() const throw(SettingTypeException); + operator unsigned long() const throw(SettingTypeException); + operator long long() const throw(SettingTypeException); + operator unsigned long long() const throw(SettingTypeException); + operator double() const throw(SettingTypeException); + operator float() const throw(SettingTypeException); + operator const char *() const throw(SettingTypeException); + operator std::string() const throw(SettingTypeException); + + inline const char *c_str() const throw(SettingTypeException) + { return operator const char*(); } + + Setting & operator=(bool value) throw(SettingTypeException); + Setting & operator=(int value) throw(SettingTypeException); + Setting & operator=(long value) throw(SettingTypeException); + Setting & operator=(const long long &value) throw(SettingTypeException); + Setting & operator=(const double &value) throw(SettingTypeException); + Setting & operator=(float value) throw(SettingTypeException); + Setting & operator=(const char *value) throw(SettingTypeException); + Setting & operator=(const std::string &value) throw(SettingTypeException); + + Setting & operator[](const char *key) const + throw(SettingTypeException, SettingNotFoundException); + + inline Setting & operator[](const std::string &key) const + throw(SettingTypeException, SettingNotFoundException) + { return(operator[](key.c_str())); } + + Setting & operator[](int index) const + throw(SettingTypeException, SettingNotFoundException); + + bool lookupValue(const char *name, bool &value) const throw(); + bool lookupValue(const char *name, int &value) const throw(); + bool lookupValue(const char *name, unsigned int &value) const throw(); + bool lookupValue(const char *name, long long &value) const throw(); + bool lookupValue(const char *name, unsigned long long &value) + const throw(); + bool lookupValue(const char *name, double &value) const throw(); + bool lookupValue(const char *name, float &value) const throw(); + bool lookupValue(const char *name, const char *&value) const throw(); + bool lookupValue(const char *name, std::string &value) const throw(); + + inline bool lookupValue(const std::string &name, bool &value) + const throw() + { return(lookupValue(name.c_str(), value)); } + + inline bool lookupValue(const std::string &name, int &value) + const throw() + { return(lookupValue(name.c_str(), value)); } + + inline bool lookupValue(const std::string &name, unsigned int &value) + const throw() + { return(lookupValue(name.c_str(), value)); } + + inline bool lookupValue(const std::string &name, long long &value) + const throw() + { return(lookupValue(name.c_str(), value)); } + + inline bool lookupValue(const std::string &name, + unsigned long long &value) const throw() + { return(lookupValue(name.c_str(), value)); } + + inline bool lookupValue(const std::string &name, double &value) const + throw() + { return(lookupValue(name.c_str(), value)); } + + inline bool lookupValue(const std::string &name, float &value) const + throw() + { return(lookupValue(name.c_str(), value)); } + + inline bool lookupValue(const std::string &name, const char *&value) const + throw() + { return(lookupValue(name.c_str(), value)); } + + inline bool lookupValue(const std::string &name, std::string &value) const + throw() + { return(lookupValue(name.c_str(), value)); } + + void remove(const char *name) + throw(SettingTypeException, SettingNotFoundException); + + inline void remove(const std::string & name) + throw(SettingTypeException, SettingNotFoundException) + { remove(name.c_str()); } + + void remove(unsigned int idx) + throw(SettingTypeException, SettingNotFoundException); + + inline Setting & add(const std::string & name, Type type) + throw(SettingNameException, SettingTypeException) + { return(add(name.c_str(), type)); } + + Setting & add(const char *name, Type type) + throw(SettingNameException, SettingTypeException); + + Setting & add(Type type) throw(SettingTypeException); + + inline bool exists(const std::string &name) const throw() + { return(exists(name.c_str())); } + + bool exists(const char *name) const throw(); + + int getLength() const throw(); + const char *getName() const throw(); + std::string getPath() const; + int getIndex() const throw(); + + const Setting & getParent() const throw(SettingNotFoundException); + Setting & getParent() throw(SettingNotFoundException); + + bool isRoot() const throw(); + + inline bool isGroup() const throw() + { return(_type == TypeGroup); } + + inline bool isArray() const throw() + { return(_type == TypeArray); } + + inline bool isList() const throw() + { return(_type == TypeList); } + + inline bool isAggregate() const throw() + { return(_type >= TypeGroup); } + + inline bool isScalar() const throw() + { return((_type > TypeNone) && (_type < TypeGroup)); } + + inline bool isNumber() const throw() + { return((_type == TypeInt) || (_type == TypeInt64) + || (_type == TypeFloat)); } + + unsigned int getSourceLine() const throw(); + const char *getSourceFile() const throw(); +}; + +class LIBCONFIGXX_API Config +{ + private: + + config_t *_config; + + static void ConfigDestructor(void *arg); + Config(const Config& other); // not supported + Config& operator=(const Config& other); // not supported + + public: + + Config(); + virtual ~Config(); + + void setAutoConvert(bool flag); + bool getAutoConvert() const; + + void setDefaultFormat(Setting::Format format); + inline Setting::Format getDefaultFormat() const + { return(_defaultFormat); } + + void setTabWidth(unsigned short width) throw(); + unsigned short getTabWidth() const throw(); + + void setIncludeDir(const char *includeDir) throw(); + const char *getIncludeDir() const throw(); + + void read(FILE *stream) throw(ParseException); + void write(FILE *stream) const; + + void readString(const char *str) throw(ParseException); + inline void readString(const std::string &str) throw(ParseException) + { return(readString(str.c_str())); } + + void readFile(const char *filename) throw(FileIOException, ParseException); + void writeFile(const char *filename) throw(FileIOException); + + inline Setting & lookup(const std::string &path) const + throw(SettingNotFoundException) + { return(lookup(path.c_str())); } + + Setting & lookup(const char *path) const throw(SettingNotFoundException); + + inline bool exists(const std::string & path) const throw() + { return(exists(path.c_str())); } + + bool exists(const char *path) const throw(); + + bool lookupValue(const char *path, bool &value) const throw(); + bool lookupValue(const char *path, int &value) const throw(); + bool lookupValue(const char *path, unsigned int &value) const throw(); + bool lookupValue(const char *path, long long &value) const throw(); + bool lookupValue(const char *path, unsigned long long &value) + const throw(); + bool lookupValue(const char *path, double &value) const throw(); + bool lookupValue(const char *path, float &value) const throw(); + bool lookupValue(const char *path, const char *&value) const throw(); + bool lookupValue(const char *path, std::string &value) const throw(); + + inline bool lookupValue(const std::string &path, bool &value) const throw() + { return(lookupValue(path.c_str(), value)); } + + inline bool lookupValue(const std::string &path, int &value) const throw() + { return(lookupValue(path.c_str(), value)); } + + inline bool lookupValue(const std::string &path, unsigned int &value) + const throw() + { return(lookupValue(path.c_str(), value)); } + + inline bool lookupValue(const std::string &path, long long &value) + const throw() + { return(lookupValue(path.c_str(), value)); } + + inline bool lookupValue(const std::string &path, + unsigned long long &value) const throw() + { return(lookupValue(path.c_str(), value)); } + + inline bool lookupValue(const std::string &path, double &value) + const throw() + { return(lookupValue(path.c_str(), value)); } + + inline bool lookupValue(const std::string &path, float &value) + const throw() + { return(lookupValue(path.c_str(), value)); } + + inline bool lookupValue(const std::string &path, const char *&value) + const throw() + { return(lookupValue(path.c_str(), value)); } + + inline bool lookupValue(const std::string &path, std::string &value) + const throw() + { return(lookupValue(path.c_str(), value)); } + + Setting & getRoot() const; + + private: + + Setting::Format _defaultFormat; + + void handleError() const; +}; + +} // namespace libconfig + +#endif // __libconfig_hpp diff --git a/libconfig-1.4.9/lib/libconfig.hh b/libconfig-1.4.9/lib/libconfig.hh new file mode 100644 index 0000000000000000000000000000000000000000..6883a31478b9b42bce8b7bbb97bcc2fe7bd98a3e --- /dev/null +++ b/libconfig-1.4.9/lib/libconfig.hh @@ -0,0 +1,23 @@ +/* ---------------------------------------------------------------------------- + libconfig - A structured configuration file parsing library + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Lesser General Public + License along with this library; if not, write to the Free Software + Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA + ---------------------------------------------------------------------------- +*/ + +#include diff --git a/libconfig-1.4.9/lib/libconfig.pc b/libconfig-1.4.9/lib/libconfig.pc new file mode 100644 index 0000000000000000000000000000000000000000..3ecd40ba443e33cf9862768890de8d872d1ed8f1 --- /dev/null +++ b/libconfig-1.4.9/lib/libconfig.pc @@ -0,0 +1,14 @@ +prefix=/usr/local +exec_prefix=${prefix} +libdir=${exec_prefix}/lib +includedir=${prefix}/include + +Name: libconfig +Description: C Configuration File Library +Version: 1.4.9 +URL: http://www.hyperrealm.com/main.php?s=libconfig +Requires: +Conflicts: +Libs: -L${libdir} -lconfig +Libs.private: +Cflags: -I${includedir} diff --git a/libconfig-1.4.9/lib/libconfig.pc.in b/libconfig-1.4.9/lib/libconfig.pc.in new file mode 100644 index 0000000000000000000000000000000000000000..4f7628b0559ee06e3310674b3a970d53009bfe99 --- /dev/null +++ b/libconfig-1.4.9/lib/libconfig.pc.in @@ -0,0 +1,14 @@ +prefix=@prefix@ +exec_prefix=@exec_prefix@ +libdir=@libdir@ +includedir=@includedir@ + +Name: libconfig +Description: C Configuration File Library +Version: @VERSION@ +URL: http://www.hyperrealm.com/main.php?s=libconfig +Requires: +Conflicts: +Libs: -L${libdir} -lconfig +Libs.private: @LIBS@ +Cflags: -I${includedir} diff --git a/libconfig-1.4.9/lib/libconfig.vcproj b/libconfig-1.4.9/lib/libconfig.vcproj new file mode 100644 index 0000000000000000000000000000000000000000..90a520ea57cb10ef83a0f6d55a0bc7d375567fc3 --- /dev/null +++ b/libconfig-1.4.9/lib/libconfig.vcproj @@ -0,0 +1,224 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/libconfig-1.4.9/lib/libconfigcpp.c++ b/libconfig-1.4.9/lib/libconfigcpp.c++ new file mode 100644 index 0000000000000000000000000000000000000000..6d196e7a1282e26f9a9ee0ca8224612d14880414 --- /dev/null +++ b/libconfig-1.4.9/lib/libconfigcpp.c++ @@ -0,0 +1,1169 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include "libconfig.h++" + +#ifdef _MSC_VER +#pragma warning (disable: 4996) +#endif + +#include "wincompat.h" +#include "libconfig.h" + +#include +#include +#include + +namespace libconfig { + +// --------------------------------------------------------------------------- + +ParseException::ParseException(const char *file, int line, const char *error) + : _file(file ? ::strdup(file) : NULL), _line(line), _error(error) +{ +} + +// --------------------------------------------------------------------------- + +ParseException::ParseException(const ParseException &other) + : ConfigException(other), + _file(other._file ? ::strdup(other._file) : NULL), + _line(other._line), + _error(other._error) +{ +} + +// --------------------------------------------------------------------------- + +ParseException::~ParseException() throw() +{ + ::free((void *)_file); +} + +// --------------------------------------------------------------------------- + +const char *ParseException::what() const throw() +{ + return("ParseException"); +} + +// --------------------------------------------------------------------------- + +static int __toTypeCode(Setting::Type type) +{ + int typecode; + + switch(type) + { + case Setting::TypeGroup: + typecode = CONFIG_TYPE_GROUP; + break; + + case Setting::TypeInt: + typecode = CONFIG_TYPE_INT; + break; + + case Setting::TypeInt64: + typecode = CONFIG_TYPE_INT64; + break; + + case Setting::TypeFloat: + typecode = CONFIG_TYPE_FLOAT; + break; + + case Setting::TypeString: + typecode = CONFIG_TYPE_STRING; + break; + + case Setting::TypeBoolean: + typecode = CONFIG_TYPE_BOOL; + break; + + case Setting::TypeArray: + typecode = CONFIG_TYPE_ARRAY; + break; + + case Setting::TypeList: + typecode = CONFIG_TYPE_LIST; + break; + + default: + typecode = CONFIG_TYPE_NONE; + } + + return(typecode); +} + +// --------------------------------------------------------------------------- + +static void __constructPath(const Setting &setting, + std::stringstream &path) +{ + // head recursion to print path from root to target + + if(! setting.isRoot()) + { + __constructPath(setting.getParent(), path); + if(path.tellp() > 0) + path << '.'; + + const char *name = setting.getName(); + if(name) + path << name; + else + path << '[' << setting.getIndex() << ']'; + } +} + +// --------------------------------------------------------------------------- + +SettingException::SettingException(const Setting &setting) +{ + std::stringstream sstr; + __constructPath(setting, sstr); + + _path = ::strdup(sstr.str().c_str()); +} + +// --------------------------------------------------------------------------- + +SettingException::SettingException(const Setting &setting, int idx) +{ + std::stringstream sstr; + __constructPath(setting, sstr); + sstr << ".[" << idx << "]"; + + _path = ::strdup(sstr.str().c_str()); +} + +// --------------------------------------------------------------------------- + +SettingException::SettingException(const Setting &setting, const char *name) +{ + std::stringstream sstr; + __constructPath(setting, sstr); + sstr << '.' << name; + + _path = ::strdup(sstr.str().c_str()); +} + +// --------------------------------------------------------------------------- + +SettingException::SettingException(const char *path) +{ + _path = ::strdup(path); +} + +// --------------------------------------------------------------------------- + +const char *SettingException::getPath() const +{ + return(_path); +} + +// --------------------------------------------------------------------------- + +SettingException::SettingException(const SettingException &other) + : ConfigException(other) +{ + _path = ::strdup(other._path); +} + +// --------------------------------------------------------------------------- + +SettingException &SettingException::operator=(const SettingException &other) +{ + ::free(_path); + _path = ::strdup(other._path); + + return(*this); +} + +// --------------------------------------------------------------------------- + +const char *SettingException::what() const throw() +{ + return("SettingException"); +} + +// --------------------------------------------------------------------------- + +SettingException::~SettingException() throw() +{ + ::free(_path); +} + +// --------------------------------------------------------------------------- + +SettingTypeException::SettingTypeException(const Setting &setting) + : SettingException(setting) +{ +} + +// --------------------------------------------------------------------------- + +SettingTypeException::SettingTypeException(const Setting &setting, int idx) + : SettingException(setting, idx) +{ +} + +// --------------------------------------------------------------------------- + +SettingTypeException::SettingTypeException(const Setting &setting, + const char *name) + : SettingException(setting, name) +{ +} + +// --------------------------------------------------------------------------- + +const char *SettingTypeException::what() const throw() +{ + return("SettingTypeException"); +} + +// --------------------------------------------------------------------------- + +SettingNotFoundException::SettingNotFoundException(const Setting &setting, + int idx) + : SettingException(setting, idx) +{ +} + +// --------------------------------------------------------------------------- + +SettingNotFoundException::SettingNotFoundException(const Setting &setting, + const char *name) + : SettingException(setting, name) +{ +} + +// --------------------------------------------------------------------------- + +SettingNotFoundException::SettingNotFoundException(const char *path) + : SettingException(path) +{ +} + +// --------------------------------------------------------------------------- + +const char *SettingNotFoundException::what() const throw() +{ + return("SettingNotFoundException"); +} + +// --------------------------------------------------------------------------- + +SettingNameException::SettingNameException(const Setting &setting, + const char *name) + : SettingException(setting, name) +{ +} + +// --------------------------------------------------------------------------- + +const char *SettingNameException::what() const throw() +{ + return("SettingNameException"); +} + +// --------------------------------------------------------------------------- + +const char *FileIOException::what() const throw() +{ + return("FileIOException"); +} + +// --------------------------------------------------------------------------- + +void Config::ConfigDestructor(void *arg) +{ + delete reinterpret_cast(arg); +} + +// --------------------------------------------------------------------------- + +Config::Config() + : _defaultFormat(Setting::FormatDefault) +{ + _config = new config_t; + config_init(_config); + config_set_destructor(_config, ConfigDestructor); +} + +// --------------------------------------------------------------------------- + +Config::~Config() +{ + config_destroy(_config); + delete _config; +} + +// --------------------------------------------------------------------------- + +void Config::setAutoConvert(bool flag) +{ + config_set_auto_convert(_config, (flag ? CONFIG_TRUE : CONFIG_FALSE)); +} + +// --------------------------------------------------------------------------- + +bool Config::getAutoConvert() const +{ + return(config_get_auto_convert(_config) != CONFIG_FALSE); +} + +// --------------------------------------------------------------------------- + +void Config::setDefaultFormat(Setting::Format format) +{ + if(format == Setting::FormatHex) + _defaultFormat = Setting::FormatHex; + else + _defaultFormat = Setting::FormatDefault; + + config_set_default_format(_config, static_cast(_defaultFormat)); +} + +// --------------------------------------------------------------------------- + +void Config::setTabWidth(unsigned short width) throw() +{ + config_set_tab_width(_config, width); +} + +// --------------------------------------------------------------------------- + +unsigned short Config::getTabWidth() const throw() +{ + return(config_get_tab_width(_config)); +} + +// --------------------------------------------------------------------------- + +void Config::setIncludeDir(const char *includeDir) throw() +{ + config_set_include_dir(_config, includeDir); +} + +// --------------------------------------------------------------------------- + +const char *Config::getIncludeDir() const throw() +{ + return(config_get_include_dir(_config)); +} + +// --------------------------------------------------------------------------- + +void Config::handleError() const +{ + switch(config_error_type(_config)) + { + case CONFIG_ERR_NONE: + break; + + case CONFIG_ERR_PARSE: + throw ParseException(config_error_file(_config), + config_error_line(_config), + config_error_text(_config)); + break; + + case CONFIG_ERR_FILE_IO: + default: + throw FileIOException(); + } +} + +// --------------------------------------------------------------------------- + +void Config::read(FILE *stream) throw(ParseException) +{ + if(! config_read(_config, stream)) + handleError(); +} + +// --------------------------------------------------------------------------- + +void Config::readString(const char *str) throw(ParseException) +{ + if(! config_read_string(_config, str)) + handleError(); +} + +// --------------------------------------------------------------------------- + +void Config::write(FILE *stream) const +{ + config_write(_config, stream); +} + +// --------------------------------------------------------------------------- + +void Config::readFile(const char *filename) throw(FileIOException, + ParseException) +{ + if(! config_read_file(_config, filename)) + handleError(); +} + +// --------------------------------------------------------------------------- + +void Config::writeFile(const char *filename) throw(FileIOException) +{ + if(! config_write_file(_config, filename)) + handleError(); +} + +// --------------------------------------------------------------------------- + +Setting & Config::lookup(const char *path) const + throw(SettingNotFoundException) +{ + config_setting_t *s = config_lookup(_config, path); + if(! s) + throw SettingNotFoundException(path); + + return(Setting::wrapSetting(s)); +} + +// --------------------------------------------------------------------------- + +bool Config::exists(const char *path) const throw() +{ + config_setting_t *s = config_lookup(_config, path); + + return(s != NULL); +} + +// --------------------------------------------------------------------------- + +#define CONFIG_LOOKUP_NO_EXCEPTIONS(P, T, V) \ + try \ + { \ + Setting &s = lookup(P); \ + V = (T)s; \ + return(true); \ + } \ + catch(const ConfigException &) \ + { \ + return(false); \ + } + +// --------------------------------------------------------------------------- + +bool Config::lookupValue(const char *path, bool &value) const throw() +{ + CONFIG_LOOKUP_NO_EXCEPTIONS(path, bool, value); +} + +// --------------------------------------------------------------------------- + +bool Config::lookupValue(const char *path, int &value) const throw() +{ + CONFIG_LOOKUP_NO_EXCEPTIONS(path, int, value); +} + +// --------------------------------------------------------------------------- + +bool Config::lookupValue(const char *path, unsigned int &value) const throw() +{ + CONFIG_LOOKUP_NO_EXCEPTIONS(path, unsigned int, value); +} + +// --------------------------------------------------------------------------- + +bool Config::lookupValue(const char *path, long long &value) const throw() +{ + CONFIG_LOOKUP_NO_EXCEPTIONS(path, long long, value); +} + +// --------------------------------------------------------------------------- + +bool Config::lookupValue(const char *path, unsigned long long &value) + const throw() +{ + CONFIG_LOOKUP_NO_EXCEPTIONS(path, unsigned long long, value); +} + +// --------------------------------------------------------------------------- + +bool Config::lookupValue(const char *path, double &value) const throw() +{ + CONFIG_LOOKUP_NO_EXCEPTIONS(path, double, value); +} + +// --------------------------------------------------------------------------- + +bool Config::lookupValue(const char *path, float &value) const throw() +{ + CONFIG_LOOKUP_NO_EXCEPTIONS(path, float, value); +} + +// --------------------------------------------------------------------------- + +bool Config::lookupValue(const char *path, const char *&value) const throw() +{ + CONFIG_LOOKUP_NO_EXCEPTIONS(path, const char *, value); +} + +// --------------------------------------------------------------------------- + +bool Config::lookupValue(const char *path, std::string &value) const throw() +{ + CONFIG_LOOKUP_NO_EXCEPTIONS(path, const char *, value); +} + +// --------------------------------------------------------------------------- + +Setting & Config::getRoot() const +{ + return(Setting::wrapSetting(config_root_setting(_config))); +} + +// --------------------------------------------------------------------------- + +Setting::Setting(config_setting_t *setting) + : _setting(setting) +{ + switch(config_setting_type(setting)) + { + case CONFIG_TYPE_GROUP: + _type = TypeGroup; + break; + + case CONFIG_TYPE_INT: + _type = TypeInt; + break; + + case CONFIG_TYPE_INT64: + _type = TypeInt64; + break; + + case CONFIG_TYPE_FLOAT: + _type = TypeFloat; + break; + + case CONFIG_TYPE_STRING: + _type = TypeString; + break; + + case CONFIG_TYPE_BOOL: + _type = TypeBoolean; + break; + + case CONFIG_TYPE_ARRAY: + _type = TypeArray; + break; + + case CONFIG_TYPE_LIST: + _type = TypeList; + break; + + case CONFIG_TYPE_NONE: + default: + _type = TypeNone; + break; + } + + switch(config_setting_get_format(setting)) + { + case CONFIG_FORMAT_HEX: + _format = FormatHex; + break; + + case CONFIG_FORMAT_DEFAULT: + default: + _format = FormatDefault; + break; + } +} + +// --------------------------------------------------------------------------- + +Setting::~Setting() throw() +{ + _setting = NULL; +} + +// --------------------------------------------------------------------------- + +void Setting::setFormat(Format format) throw() +{ + if((_type == TypeInt) || (_type == TypeInt64)) + { + if(format == FormatHex) + _format = FormatHex; + else + _format = FormatDefault; + } + else + _format = FormatDefault; + + config_setting_set_format(_setting, static_cast(_format)); +} + +// --------------------------------------------------------------------------- + +Setting::operator bool() const throw(SettingTypeException) +{ + assertType(TypeBoolean); + + return(config_setting_get_bool(_setting) ? true : false); +} + +// --------------------------------------------------------------------------- + +Setting::operator int() const throw(SettingTypeException) +{ + assertType(TypeInt); + + return(config_setting_get_int(_setting)); +} + +// --------------------------------------------------------------------------- + +Setting::operator unsigned int() const throw(SettingTypeException) +{ + assertType(TypeInt); + + int v = config_setting_get_int(_setting); + + if(v < 0) + v = 0; + + return(static_cast(v)); +} + +// --------------------------------------------------------------------------- + +Setting::operator long() const throw(SettingTypeException) +{ + if(sizeof(long) == sizeof(long long)) + return operator long long(); + else + return operator int(); +} + +// --------------------------------------------------------------------------- + +Setting::operator unsigned long() const throw(SettingTypeException) +{ + if(sizeof(long) == sizeof(long long)) + return operator unsigned long long(); + else + return operator unsigned int(); +} + +// --------------------------------------------------------------------------- + +Setting::operator long long() const throw(SettingTypeException) +{ + assertType(TypeInt64); + + return(config_setting_get_int64(_setting)); +} + +// --------------------------------------------------------------------------- + +Setting::operator unsigned long long() const throw(SettingTypeException) +{ + assertType(TypeInt64); + + long long v = config_setting_get_int64(_setting); + + if(v < INT64_CONST(0)) + v = INT64_CONST(0); + + return(static_cast(v)); +} + +// --------------------------------------------------------------------------- + +Setting::operator double() const throw(SettingTypeException) +{ + assertType(TypeFloat); + + return(config_setting_get_float(_setting)); +} + +// --------------------------------------------------------------------------- + +Setting::operator float() const throw(SettingTypeException) +{ + assertType(TypeFloat); + + // may cause loss of precision: + return(static_cast(config_setting_get_float(_setting))); +} + +// --------------------------------------------------------------------------- + +Setting::operator const char *() const throw(SettingTypeException) +{ + assertType(TypeString); + + return(config_setting_get_string(_setting)); +} + +// --------------------------------------------------------------------------- + +Setting::operator std::string() const throw(SettingTypeException) +{ + assertType(TypeString); + + const char *s = config_setting_get_string(_setting); + + std::string str; + if(s) + str = s; + + return(str); +} + +// --------------------------------------------------------------------------- + +Setting & Setting::operator=(bool value) throw(SettingTypeException) +{ + assertType(TypeBoolean); + + config_setting_set_bool(_setting, value); + + return(*this); +} + +// --------------------------------------------------------------------------- + +Setting & Setting::operator=(int value) throw(SettingTypeException) +{ + assertType(TypeInt); + + config_setting_set_int(_setting, value); + + return(*this); +} + +// --------------------------------------------------------------------------- + +Setting & Setting::operator=(long value) throw(SettingTypeException) +{ + if(sizeof(long) == sizeof(long long)) + return(operator=(static_cast(value))); + else + return(operator=(static_cast(value))); +} + +// --------------------------------------------------------------------------- + +Setting & Setting::operator=(const long long &value) + throw(SettingTypeException) +{ + assertType(TypeInt64); + + config_setting_set_int64(_setting, value); + + return(*this); +} + +// --------------------------------------------------------------------------- + +Setting & Setting::operator=(const double &value) throw(SettingTypeException) +{ + assertType(TypeFloat); + + config_setting_set_float(_setting, value); + + return(*this); +} + +// --------------------------------------------------------------------------- + +Setting & Setting::operator=(float value) throw(SettingTypeException) +{ + assertType(TypeFloat); + + double cvalue = static_cast(value); + + config_setting_set_float(_setting, cvalue); + + return(*this); +} + +// --------------------------------------------------------------------------- + +Setting & Setting::operator=(const char *value) throw(SettingTypeException) +{ + assertType(TypeString); + + config_setting_set_string(_setting, value); + + return(*this); +} + +// --------------------------------------------------------------------------- + +Setting & Setting::operator=(const std::string &value) + throw(SettingTypeException) +{ + assertType(TypeString); + + config_setting_set_string(_setting, value.c_str()); + + return(*this); +} + +// --------------------------------------------------------------------------- + +Setting & Setting::operator[](int i) const + throw(SettingTypeException, SettingNotFoundException) +{ + if((_type != TypeArray) && (_type != TypeGroup) && (_type != TypeList)) + throw SettingTypeException(*this, i); + + config_setting_t *setting = config_setting_get_elem(_setting, i); + + if(! setting) + throw SettingNotFoundException(*this, i); + + return(wrapSetting(setting)); +} + +// --------------------------------------------------------------------------- + +Setting & Setting::operator[](const char *key) const + throw(SettingTypeException, SettingNotFoundException) +{ + assertType(TypeGroup); + + config_setting_t *setting = config_setting_get_member(_setting, key); + + if(! setting) + throw SettingNotFoundException(*this, key); + + return(wrapSetting(setting)); +} + +// --------------------------------------------------------------------------- + +#define SETTING_LOOKUP_NO_EXCEPTIONS(K, T, V) \ + try \ + { \ + Setting &s = operator[](K); \ + V = (T)s; \ + return(true); \ + } \ + catch(const ConfigException &) \ + { \ + return(false); \ + } + +// --------------------------------------------------------------------------- + +bool Setting::lookupValue(const char *name, bool &value) const throw() +{ + SETTING_LOOKUP_NO_EXCEPTIONS(name, bool, value); +} + +// --------------------------------------------------------------------------- + +bool Setting::lookupValue(const char *name, int &value) const throw() +{ + SETTING_LOOKUP_NO_EXCEPTIONS(name, int, value); +} + +// --------------------------------------------------------------------------- + +bool Setting::lookupValue(const char *name, unsigned int &value) + const throw() +{ + SETTING_LOOKUP_NO_EXCEPTIONS(name, unsigned int, value); +} + +// --------------------------------------------------------------------------- + +bool Setting::lookupValue(const char *name, long long &value) const throw() +{ + SETTING_LOOKUP_NO_EXCEPTIONS(name, long long, value); +} + +// --------------------------------------------------------------------------- + +bool Setting::lookupValue(const char *name, unsigned long long &value) + const throw() +{ + SETTING_LOOKUP_NO_EXCEPTIONS(name, unsigned long long, value); +} + +// --------------------------------------------------------------------------- + +bool Setting::lookupValue(const char *name, double &value) const throw() +{ + SETTING_LOOKUP_NO_EXCEPTIONS(name, double, value); +} + +// --------------------------------------------------------------------------- + +bool Setting::lookupValue(const char *name, float &value) const throw() +{ + SETTING_LOOKUP_NO_EXCEPTIONS(name, float, value); +} + +// --------------------------------------------------------------------------- + +bool Setting::lookupValue(const char *name, const char *&value) const throw() +{ + SETTING_LOOKUP_NO_EXCEPTIONS(name, const char *, value); +} + +// --------------------------------------------------------------------------- + +bool Setting::lookupValue(const char *name, std::string &value) const throw() +{ + SETTING_LOOKUP_NO_EXCEPTIONS(name, const char *, value); +} + +// --------------------------------------------------------------------------- + +bool Setting::exists(const char *name) const throw() +{ + if(_type != TypeGroup) + return(false); + + config_setting_t *setting = config_setting_get_member(_setting, name); + + return(setting != NULL); +} + +// --------------------------------------------------------------------------- + +int Setting::getLength() const throw() +{ + return(config_setting_length(_setting)); +} + +// --------------------------------------------------------------------------- + +const char * Setting::getName() const throw() +{ + return(config_setting_name(_setting)); +} + +// --------------------------------------------------------------------------- + +std::string Setting::getPath() const +{ + std::stringstream path; + + __constructPath(*this, path); + + return(path.str()); +} + +// --------------------------------------------------------------------------- + +const Setting & Setting::getParent() const throw(SettingNotFoundException) +{ + config_setting_t *setting = config_setting_parent(_setting); + + if(! setting) + throw SettingNotFoundException(NULL); + + return(wrapSetting(setting)); +} + +// --------------------------------------------------------------------------- + +Setting & Setting::getParent() throw(SettingNotFoundException) +{ + config_setting_t *setting = config_setting_parent(_setting); + + if(! setting) + throw SettingNotFoundException(NULL); + + return(wrapSetting(setting)); +} + +// --------------------------------------------------------------------------- + +unsigned int Setting::getSourceLine() const throw() +{ + return(config_setting_source_line(_setting)); +} + +// --------------------------------------------------------------------------- + +const char *Setting::getSourceFile() const throw() +{ + return(config_setting_source_file(_setting)); +} + +// --------------------------------------------------------------------------- + +bool Setting::isRoot() const throw() +{ + return(config_setting_is_root(_setting)); +} + +// --------------------------------------------------------------------------- + +int Setting::getIndex() const throw() +{ + return(config_setting_index(_setting)); +} + +// --------------------------------------------------------------------------- + +void Setting::remove(const char *name) + throw(SettingTypeException, SettingNotFoundException) +{ + assertType(TypeGroup); + + if(! config_setting_remove(_setting, name)) + throw SettingNotFoundException(*this, name); +} + +// --------------------------------------------------------------------------- + +void Setting::remove(unsigned int idx) + throw(SettingTypeException, SettingNotFoundException) +{ + if((_type != TypeArray) && (_type != TypeGroup) && (_type != TypeList)) + throw SettingTypeException(*this, idx); + + if(! config_setting_remove_elem(_setting, idx)) + throw SettingNotFoundException(*this, idx); +} + +// --------------------------------------------------------------------------- + +Setting & Setting::add(const char *name, Setting::Type type) + throw(SettingNameException, SettingTypeException) +{ + assertType(TypeGroup); + + int typecode = __toTypeCode(type); + + if(typecode == CONFIG_TYPE_NONE) + throw SettingTypeException(*this, name); + + config_setting_t *setting = config_setting_add(_setting, name, typecode); + + if(! setting) + throw SettingNameException(*this, name); + + return(wrapSetting(setting)); +} + +// --------------------------------------------------------------------------- + +Setting & Setting::add(Setting::Type type) throw(SettingTypeException) +{ + if((_type != TypeArray) && (_type != TypeList)) + throw SettingTypeException(*this); + + if(_type == TypeArray) + { + int idx = getLength(); + + if(idx > 0) + { + Setting::Type atype = operator[](0).getType(); + if(type != atype) + throw SettingTypeException(*this, idx); + } + else + { + if((type != TypeInt) && (type != TypeInt64) && (type != TypeFloat) + && (type != TypeString) && (type != TypeBoolean)) + throw SettingTypeException(*this, idx); + } + } + + int typecode = __toTypeCode(type); + config_setting_t *s = config_setting_add(_setting, NULL, typecode); + + Setting &ns = wrapSetting(s); + + switch(type) + { + case TypeInt: + ns = 0; + break; + + case TypeInt64: + ns = INT64_CONST(0); + break; + + case TypeFloat: + ns = 0.0; + break; + + case TypeString: + ns = (char *)NULL; + break; + + case TypeBoolean: + ns = false; + break; + + default: + // won't happen + break; + } + + return(ns); +} + +// --------------------------------------------------------------------------- + +void Setting::assertType(Setting::Type type) const throw(SettingTypeException) +{ + if(type != _type) + { + if(!(isNumber() && config_get_auto_convert(_setting->config) + && ((type == TypeInt) || (type == TypeInt64) || (type == TypeFloat)))) + throw SettingTypeException(*this); + } +} + +// --------------------------------------------------------------------------- + +Setting & Setting::wrapSetting(config_setting_t *s) +{ + Setting *setting = NULL; + + void *hook = config_setting_get_hook(s); + if(! hook) + { + setting = new Setting(s); + config_setting_set_hook(s, reinterpret_cast(setting)); + } + else + setting = reinterpret_cast(hook); + + return(*setting); +} + +// --------------------------------------------------------------------------- + +} // namespace libconfig + +// eof diff --git a/libconfig-1.4.9/lib/libconfigcpp.cc b/libconfig-1.4.9/lib/libconfigcpp.cc new file mode 100644 index 0000000000000000000000000000000000000000..9431146c7a0a870c1a6e0a7cce4b25edd3586a5e --- /dev/null +++ b/libconfig-1.4.9/lib/libconfigcpp.cc @@ -0,0 +1,23 @@ +/* ---------------------------------------------------------------------------- + libconfig - A structured configuration file parsing library + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Lesser General Public + License along with this library; if not, write to the Free Software + Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA + ---------------------------------------------------------------------------- +*/ + +#include "libconfigcpp.c++" diff --git a/libconfig-1.4.9/lib/parsectx.h b/libconfig-1.4.9/lib/parsectx.h new file mode 100644 index 0000000000000000000000000000000000000000..af09b56dd56bbae6900410e077c406a954031f19 --- /dev/null +++ b/libconfig-1.4.9/lib/parsectx.h @@ -0,0 +1,48 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#ifndef __libconfig_parsectx_h +#define __libconfig_parsectx_h + +#include "libconfig.h" +#include "strbuf.h" + +struct parse_context +{ + config_t *config; + config_setting_t *parent; + config_setting_t *setting; + char *name; + strbuf_t string; +}; + +#define parsectx_init(C) \ + memset((C), 0, sizeof(struct parse_context)) +#define parsectx_cleanup(C) \ + free((void *)(strbuf_release(&((C)->string)))) + +#define parsectx_append_string(C, S) \ + strbuf_append(&((C)->string), (S)) +#define parsectx_take_string(C) \ + strbuf_release(&((C)->string)) + +#endif /* __libconfig_parsectx_h */ diff --git a/libconfig-1.4.9/lib/scanctx.c b/libconfig-1.4.9/lib/scanctx.c new file mode 100644 index 0000000000000000000000000000000000000000..f287fdfa65d97d83099f86b47bf34dd0e05ba594 --- /dev/null +++ b/libconfig-1.4.9/lib/scanctx.c @@ -0,0 +1,171 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include "scanctx.h" +#include "wincompat.h" + +#include +#include +#include + +#define STRING_BLOCK_SIZE 64 +#define CHUNK_SIZE 32 + +/* ------------------------------------------------------------------------- */ + +static const char *err_bad_include = "cannot open include file"; +static const char *err_include_too_deep = "include file nesting too deep"; + +/* ------------------------------------------------------------------------- */ + +static const char *__scanctx_add_filename(struct scan_context *ctx, + const char *filename) +{ + unsigned int count = ctx->num_filenames; + const char **f; + + for(f = ctx->filenames; count > 0; ++f, --count) + { + if(!strcmp(*f, filename)) + { + free((void *)filename); + return(*f); /* already in list */ + } + } + + if((ctx->num_filenames % CHUNK_SIZE) == 0) + { + ctx->filenames = (const char **)realloc( + (void *)ctx->filenames, + (ctx->num_filenames + CHUNK_SIZE) * sizeof(const char *)); + } + + ctx->filenames[ctx->num_filenames] = filename; + ++ctx->num_filenames; + return(filename); +} + +/* ------------------------------------------------------------------------- */ + +void scanctx_init(struct scan_context *ctx, const char *top_filename) +{ + memset(ctx, 0, sizeof(struct scan_context)); + if(top_filename) + ctx->top_filename = __scanctx_add_filename(ctx, strdup(top_filename)); +} + +/* ------------------------------------------------------------------------- */ + +const char **scanctx_cleanup(struct scan_context *ctx, + unsigned int *num_filenames) +{ + int i; + + for(i = 0; i < ctx->depth; ++i) + fclose(ctx->streams[i]); + + free((void *)(strbuf_release(&(ctx->string)))); + + *num_filenames = ctx->num_filenames; + return(ctx->filenames); +} + +/* ------------------------------------------------------------------------- */ + +FILE *scanctx_push_include(struct scan_context *ctx, void *buffer, + const char **error) +{ + FILE *fp = NULL; + const char *file; + char *full_file = NULL; + + *error = NULL; + + if(ctx->depth == MAX_INCLUDE_DEPTH) + { + *error = err_include_too_deep; + return(NULL); + } + + file = scanctx_take_string(ctx); + if(ctx->config->include_dir) + { + full_file = (char *)malloc(strlen(ctx->config->include_dir) + strlen(file) + + 2); + strcpy(full_file, ctx->config->include_dir); + strcat(full_file, FILE_SEPARATOR); + strcat(full_file, file); + } + + fp = fopen(full_file ? full_file : file, "rt"); + free((void *)full_file); + + if(fp) + { + ctx->streams[ctx->depth] = fp; + ctx->files[ctx->depth] = __scanctx_add_filename(ctx, file); + ctx->buffers[ctx->depth] = buffer; + ++(ctx->depth); + } + else + { + free((void *)file); + *error = err_bad_include; + } + + return(fp); +} + +/* ------------------------------------------------------------------------- */ + +void *scanctx_pop_include(struct scan_context *ctx) +{ + void *buffer; + + if(ctx->depth == 0) + return(NULL); /* stack underflow */ + + --(ctx->depth); + buffer = ctx->buffers[ctx->depth]; + fclose(ctx->streams[ctx->depth]); + + return(buffer); +} + +/* ------------------------------------------------------------------------- */ + +char *scanctx_take_string(struct scan_context *ctx) +{ + char *r = strbuf_release(&(ctx->string)); + + return(r ? r : strdup("")); +} + +/* ------------------------------------------------------------------------- */ + +const char *scanctx_current_filename(struct scan_context *ctx) +{ + return((ctx->depth == 0) ? ctx->top_filename : ctx->files[ctx->depth - 1]); +} + +/* ------------------------------------------------------------------------- */ +/* eof */ diff --git a/libconfig-1.4.9/lib/scanctx.h b/libconfig-1.4.9/lib/scanctx.h new file mode 100644 index 0000000000000000000000000000000000000000..8ff934e7e958f67c55cec4b22b4d0eb8dc37d1a3 --- /dev/null +++ b/libconfig-1.4.9/lib/scanctx.h @@ -0,0 +1,62 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#ifndef __libconfig_scanctx_h +#define __libconfig_scanctx_h + +#include "libconfig.h" +#include "strbuf.h" + +#include +#include + +#define MAX_INCLUDE_DEPTH 10 + +struct scan_context +{ + config_t *config; + const char *top_filename; + const char *files[MAX_INCLUDE_DEPTH]; + void *buffers[MAX_INCLUDE_DEPTH]; + FILE *streams[MAX_INCLUDE_DEPTH]; + int depth; + strbuf_t string; + const char **filenames; + unsigned int num_filenames; +}; + +extern void scanctx_init(struct scan_context *ctx, const char *top_filename); +extern const char **scanctx_cleanup(struct scan_context *ctx, + unsigned int *num_filenames); + +extern FILE *scanctx_push_include(struct scan_context *ctx, void *prev_buffer, + const char **error); +extern void *scanctx_pop_include(struct scan_context *ctx); + +#define scanctx_append_string(C, S) \ + strbuf_append(&((C)->string), (S)) + +extern char *scanctx_take_string(struct scan_context *ctx); + +extern const char *scanctx_current_filename(struct scan_context *ctx); + +#endif /* __libconfig_scanctx_h */ diff --git a/libconfig-1.4.9/lib/scanner.c b/libconfig-1.4.9/lib/scanner.c new file mode 100644 index 0000000000000000000000000000000000000000..a7a401af50976ebddd2800fe7b9d0420407af03e --- /dev/null +++ b/libconfig-1.4.9/lib/scanner.c @@ -0,0 +1,2367 @@ +#line 2 "scanner.c" + +#line 4 "scanner.c" + +#define YY_INT_ALIGNED short int + +/* A lexical scanner generated by flex */ + +#define FLEX_SCANNER +#define YY_FLEX_MAJOR_VERSION 2 +#define YY_FLEX_MINOR_VERSION 5 +#define YY_FLEX_SUBMINOR_VERSION 35 +#if YY_FLEX_SUBMINOR_VERSION > 0 +#define FLEX_BETA +#endif + +/* First, we deal with platform-specific or compiler-specific issues. */ + +/* begin standard C headers. */ +#include +#include +#include +#include + +/* end standard C headers. */ + +/* flex integer type definitions */ + +#ifndef FLEXINT_H +#define FLEXINT_H + +/* C99 systems have . Non-C99 systems may or may not. */ + +#if defined (__STDC_VERSION__) && __STDC_VERSION__ >= 199901L + +/* C99 says to define __STDC_LIMIT_MACROS before including stdint.h, + * if you want the limit (max/min) macros for int types. + */ +#ifndef __STDC_LIMIT_MACROS +#define __STDC_LIMIT_MACROS 1 +#endif + +#include +typedef int8_t flex_int8_t; +typedef uint8_t flex_uint8_t; +typedef int16_t flex_int16_t; +typedef uint16_t flex_uint16_t; +typedef int32_t flex_int32_t; +typedef uint32_t flex_uint32_t; +#else +typedef signed char flex_int8_t; +typedef short int flex_int16_t; +typedef int flex_int32_t; +typedef unsigned char flex_uint8_t; +typedef unsigned short int flex_uint16_t; +typedef unsigned int flex_uint32_t; + +/* Limits of integral types. */ +#ifndef INT8_MIN +#define INT8_MIN (-128) +#endif +#ifndef INT16_MIN +#define INT16_MIN (-32767-1) +#endif +#ifndef INT32_MIN +#define INT32_MIN (-2147483647-1) +#endif +#ifndef INT8_MAX +#define INT8_MAX (127) +#endif +#ifndef INT16_MAX +#define INT16_MAX (32767) +#endif +#ifndef INT32_MAX +#define INT32_MAX (2147483647) +#endif +#ifndef UINT8_MAX +#define UINT8_MAX (255U) +#endif +#ifndef UINT16_MAX +#define UINT16_MAX (65535U) +#endif +#ifndef UINT32_MAX +#define UINT32_MAX (4294967295U) +#endif + +#endif /* ! C99 */ + +#endif /* ! FLEXINT_H */ + +#ifdef __cplusplus + +/* The "const" storage-class-modifier is valid. */ +#define YY_USE_CONST + +#else /* ! __cplusplus */ + +/* C99 requires __STDC__ to be defined as 1. */ +#if defined (__STDC__) + +#define YY_USE_CONST + +#endif /* defined (__STDC__) */ +#endif /* ! __cplusplus */ + +#ifdef YY_USE_CONST +#define yyconst const +#else +#define yyconst +#endif + +/* Returned upon end-of-file. */ +#define YY_NULL 0 + +/* Promotes a possibly negative, possibly signed char to an unsigned + * integer for use as an array index. If the signed char is negative, + * we want to instead treat it as an 8-bit unsigned char, hence the + * double cast. + */ +#define YY_SC_TO_UI(c) ((unsigned int) (unsigned char) c) + +/* An opaque pointer. */ +#ifndef YY_TYPEDEF_YY_SCANNER_T +#define YY_TYPEDEF_YY_SCANNER_T +typedef void* yyscan_t; +#endif + +/* For convenience, these vars (plus the bison vars far below) + are macros in the reentrant scanner. */ +#define yyin yyg->yyin_r +#define yyout yyg->yyout_r +#define yyextra yyg->yyextra_r +#define yyleng yyg->yyleng_r +#define yytext yyg->yytext_r +#define yylineno (YY_CURRENT_BUFFER_LVALUE->yy_bs_lineno) +#define yycolumn (YY_CURRENT_BUFFER_LVALUE->yy_bs_column) +#define yy_flex_debug yyg->yy_flex_debug_r + +/* Enter a start condition. This macro really ought to take a parameter, + * but we do it the disgusting crufty way forced on us by the ()-less + * definition of BEGIN. + */ +#define BEGIN yyg->yy_start = 1 + 2 * + +/* Translate the current start state into a value that can be later handed + * to BEGIN to return to the state. The YYSTATE alias is for lex + * compatibility. + */ +#define YY_START ((yyg->yy_start - 1) / 2) +#define YYSTATE YY_START + +/* Action number for EOF rule of a given start state. */ +#define YY_STATE_EOF(state) (YY_END_OF_BUFFER + state + 1) + +/* Special action meaning "start processing a new file". */ +#define YY_NEW_FILE libconfig_yyrestart(yyin ,yyscanner ) + +#define YY_END_OF_BUFFER_CHAR 0 + +/* Size of default input buffer. */ +#ifndef YY_BUF_SIZE +#ifdef __ia64__ +/* On IA-64, the buffer size is 16k, not 8k. + * Moreover, YY_BUF_SIZE is 2*YY_READ_BUF_SIZE in the general case. + * Ditto for the __ia64__ case accordingly. + */ +#define YY_BUF_SIZE 32768 +#else +#define YY_BUF_SIZE 16384 +#endif /* __ia64__ */ +#endif + +/* The state buf must be large enough to hold one state per character in the main buffer. + */ +#define YY_STATE_BUF_SIZE ((YY_BUF_SIZE + 2) * sizeof(yy_state_type)) + +#ifndef YY_TYPEDEF_YY_BUFFER_STATE +#define YY_TYPEDEF_YY_BUFFER_STATE +typedef struct yy_buffer_state *YY_BUFFER_STATE; +#endif + +#define EOB_ACT_CONTINUE_SCAN 0 +#define EOB_ACT_END_OF_FILE 1 +#define EOB_ACT_LAST_MATCH 2 + + /* Note: We specifically omit the test for yy_rule_can_match_eol because it requires + * access to the local variable yy_act. Since yyless() is a macro, it would break + * existing scanners that call yyless() from OUTSIDE libconfig_yylex. + * One obvious solution it to make yy_act a global. I tried that, and saw + * a 5% performance hit in a non-yylineno scanner, because yy_act is + * normally declared as a register variable-- so it is not worth it. + */ + #define YY_LESS_LINENO(n) \ + do { \ + int yyl;\ + for ( yyl = n; yyl < yyleng; ++yyl )\ + if ( yytext[yyl] == '\n' )\ + --yylineno;\ + }while(0) + +/* Return all but the first "n" matched characters back to the input stream. */ +#define yyless(n) \ + do \ + { \ + /* Undo effects of setting up yytext. */ \ + int yyless_macro_arg = (n); \ + YY_LESS_LINENO(yyless_macro_arg);\ + *yy_cp = yyg->yy_hold_char; \ + YY_RESTORE_YY_MORE_OFFSET \ + yyg->yy_c_buf_p = yy_cp = yy_bp + yyless_macro_arg - YY_MORE_ADJ; \ + YY_DO_BEFORE_ACTION; /* set up yytext again */ \ + } \ + while ( 0 ) + +#define unput(c) yyunput( c, yyg->yytext_ptr , yyscanner ) + +#ifndef YY_TYPEDEF_YY_SIZE_T +#define YY_TYPEDEF_YY_SIZE_T +typedef size_t yy_size_t; +#endif + +#ifndef YY_STRUCT_YY_BUFFER_STATE +#define YY_STRUCT_YY_BUFFER_STATE +struct yy_buffer_state + { + FILE *yy_input_file; + + char *yy_ch_buf; /* input buffer */ + char *yy_buf_pos; /* current position in input buffer */ + + /* Size of input buffer in bytes, not including room for EOB + * characters. + */ + yy_size_t yy_buf_size; + + /* Number of characters read into yy_ch_buf, not including EOB + * characters. + */ + int yy_n_chars; + + /* Whether we "own" the buffer - i.e., we know we created it, + * and can realloc() it to grow it, and should free() it to + * delete it. + */ + int yy_is_our_buffer; + + /* Whether this is an "interactive" input source; if so, and + * if we're using stdio for input, then we want to use getc() + * instead of fread(), to make sure we stop fetching input after + * each newline. + */ + int yy_is_interactive; + + /* Whether we're considered to be at the beginning of a line. + * If so, '^' rules will be active on the next match, otherwise + * not. + */ + int yy_at_bol; + + int yy_bs_lineno; /**< The line count. */ + int yy_bs_column; /**< The column count. */ + + /* Whether to try to fill the input buffer when we reach the + * end of it. + */ + int yy_fill_buffer; + + int yy_buffer_status; + +#define YY_BUFFER_NEW 0 +#define YY_BUFFER_NORMAL 1 + /* When an EOF's been seen but there's still some text to process + * then we mark the buffer as YY_EOF_PENDING, to indicate that we + * shouldn't try reading from the input source any more. We might + * still have a bunch of tokens to match, though, because of + * possible backing-up. + * + * When we actually see the EOF, we change the status to "new" + * (via libconfig_yyrestart()), so that the user can continue scanning by + * just pointing yyin at a new input file. + */ +#define YY_BUFFER_EOF_PENDING 2 + + }; +#endif /* !YY_STRUCT_YY_BUFFER_STATE */ + +/* We provide macros for accessing buffer states in case in the + * future we want to put the buffer states in a more general + * "scanner state". + * + * Returns the top of the stack, or NULL. + */ +#define YY_CURRENT_BUFFER ( yyg->yy_buffer_stack \ + ? yyg->yy_buffer_stack[yyg->yy_buffer_stack_top] \ + : NULL) + +/* Same as previous macro, but useful when we know that the buffer stack is not + * NULL or when we need an lvalue. For internal use only. + */ +#define YY_CURRENT_BUFFER_LVALUE yyg->yy_buffer_stack[yyg->yy_buffer_stack_top] + +void libconfig_yyrestart (FILE *input_file ,yyscan_t yyscanner ); +void libconfig_yy_switch_to_buffer (YY_BUFFER_STATE new_buffer ,yyscan_t yyscanner ); +YY_BUFFER_STATE libconfig_yy_create_buffer (FILE *file,int size ,yyscan_t yyscanner ); +void libconfig_yy_delete_buffer (YY_BUFFER_STATE b ,yyscan_t yyscanner ); +void libconfig_yy_flush_buffer (YY_BUFFER_STATE b ,yyscan_t yyscanner ); +void libconfig_yypush_buffer_state (YY_BUFFER_STATE new_buffer ,yyscan_t yyscanner ); +void libconfig_yypop_buffer_state (yyscan_t yyscanner ); + +static void libconfig_yyensure_buffer_stack (yyscan_t yyscanner ); +static void libconfig_yy_load_buffer_state (yyscan_t yyscanner ); +static void libconfig_yy_init_buffer (YY_BUFFER_STATE b,FILE *file ,yyscan_t yyscanner ); + +#define YY_FLUSH_BUFFER libconfig_yy_flush_buffer(YY_CURRENT_BUFFER ,yyscanner) + +YY_BUFFER_STATE libconfig_yy_scan_buffer (char *base,yy_size_t size ,yyscan_t yyscanner ); +YY_BUFFER_STATE libconfig_yy_scan_string (yyconst char *yy_str ,yyscan_t yyscanner ); +YY_BUFFER_STATE libconfig_yy_scan_bytes (yyconst char *bytes,int len ,yyscan_t yyscanner ); + +void *libconfig_yyalloc (yy_size_t ,yyscan_t yyscanner ); +void *libconfig_yyrealloc (void *,yy_size_t ,yyscan_t yyscanner ); +void libconfig_yyfree (void * ,yyscan_t yyscanner ); + +#define yy_new_buffer libconfig_yy_create_buffer + +#define yy_set_interactive(is_interactive) \ + { \ + if ( ! YY_CURRENT_BUFFER ){ \ + libconfig_yyensure_buffer_stack (yyscanner); \ + YY_CURRENT_BUFFER_LVALUE = \ + libconfig_yy_create_buffer(yyin,YY_BUF_SIZE ,yyscanner); \ + } \ + YY_CURRENT_BUFFER_LVALUE->yy_is_interactive = is_interactive; \ + } + +#define yy_set_bol(at_bol) \ + { \ + if ( ! YY_CURRENT_BUFFER ){\ + libconfig_yyensure_buffer_stack (yyscanner); \ + YY_CURRENT_BUFFER_LVALUE = \ + libconfig_yy_create_buffer(yyin,YY_BUF_SIZE ,yyscanner); \ + } \ + YY_CURRENT_BUFFER_LVALUE->yy_at_bol = at_bol; \ + } + +#define YY_AT_BOL() (YY_CURRENT_BUFFER_LVALUE->yy_at_bol) + +#define libconfig_yywrap(n) 1 +#define YY_SKIP_YYWRAP + +typedef unsigned char YY_CHAR; + +typedef int yy_state_type; + +#define yytext_ptr yytext_r + +static yy_state_type yy_get_previous_state (yyscan_t yyscanner ); +static yy_state_type yy_try_NUL_trans (yy_state_type current_state ,yyscan_t yyscanner); +static int yy_get_next_buffer (yyscan_t yyscanner ); +static void yy_fatal_error (yyconst char msg[] ,yyscan_t yyscanner ); + +/* Done after the current pattern has been matched and before the + * corresponding action - sets up yytext. + */ +#define YY_DO_BEFORE_ACTION \ + yyg->yytext_ptr = yy_bp; \ + yyleng = (size_t) (yy_cp - yy_bp); \ + yyg->yy_hold_char = *yy_cp; \ + *yy_cp = '\0'; \ + yyg->yy_c_buf_p = yy_cp; + +#define YY_NUM_RULES 42 +#define YY_END_OF_BUFFER 43 +/* This struct is not used in this scanner, + but its presence is necessary. */ +struct yy_trans_info + { + flex_int32_t yy_verify; + flex_int32_t yy_nxt; + }; +static yyconst flex_int16_t yy_accept[103] = + { 0, + 0, 0, 0, 0, 0, 0, 0, 0, 43, 41, + 22, 21, 21, 5, 41, 37, 38, 29, 41, 24, + 30, 41, 31, 31, 23, 39, 29, 29, 35, 36, + 25, 26, 22, 41, 3, 4, 3, 6, 15, 14, + 17, 20, 42, 22, 0, 40, 29, 30, 31, 30, + 0, 1, 0, 30, 0, 32, 0, 29, 29, 22, + 0, 0, 2, 6, 12, 0, 11, 10, 7, 8, + 9, 17, 19, 18, 0, 30, 30, 0, 0, 30, + 32, 33, 29, 29, 0, 0, 0, 30, 34, 29, + 27, 0, 13, 34, 28, 0, 0, 0, 0, 0, + + 16, 0 + } ; + +static yyconst flex_int32_t yy_ec[256] = + { 0, + 1, 1, 1, 1, 1, 1, 1, 1, 2, 3, + 1, 4, 5, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 2, 1, 6, 7, 1, 1, 1, 1, 8, + 9, 10, 11, 12, 13, 14, 15, 16, 17, 17, + 17, 17, 17, 17, 17, 17, 17, 18, 19, 1, + 20, 1, 1, 21, 22, 23, 23, 23, 24, 25, + 26, 26, 26, 26, 26, 27, 26, 26, 26, 26, + 26, 28, 29, 30, 31, 26, 26, 32, 26, 26, + 33, 34, 35, 1, 36, 1, 22, 23, 37, 38, + + 39, 40, 26, 26, 41, 26, 26, 42, 26, 43, + 26, 26, 26, 44, 29, 45, 46, 26, 26, 32, + 26, 26, 47, 1, 48, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1 + } ; + +static yyconst flex_int32_t yy_meta[49] = + { 0, + 1, 1, 1, 1, 1, 2, 1, 1, 1, 3, + 1, 1, 3, 1, 1, 4, 4, 1, 1, 1, + 1, 4, 4, 4, 4, 3, 3, 3, 3, 3, + 3, 3, 1, 2, 1, 3, 4, 4, 4, 4, + 3, 3, 3, 3, 3, 3, 1, 1 + } ; + +static yyconst flex_int16_t yy_base[113] = + { 0, + 0, 47, 47, 48, 46, 47, 48, 49, 203, 204, + 200, 204, 204, 204, 198, 204, 204, 0, 45, 204, + 47, 50, 60, 74, 204, 204, 178, 28, 204, 204, + 204, 204, 64, 158, 204, 204, 183, 0, 204, 63, + 0, 204, 83, 195, 193, 204, 0, 88, 102, 98, + 62, 204, 190, 104, 119, 162, 0, 67, 65, 121, + 127, 124, 204, 0, 204, 0, 204, 204, 204, 204, + 204, 0, 204, 204, 108, 117, 122, 134, 132, 136, + 204, 139, 136, 116, 126, 0, 140, 142, 135, 130, + 0, 102, 204, 204, 0, 85, 72, 63, 98, 158, + + 204, 204, 169, 173, 177, 181, 183, 187, 191, 89, + 66, 63 + } ; + +static yyconst flex_int16_t yy_def[113] = + { 0, + 102, 1, 103, 103, 104, 104, 105, 105, 102, 102, + 102, 102, 102, 102, 106, 102, 102, 107, 102, 102, + 102, 102, 102, 102, 102, 102, 107, 107, 102, 102, + 102, 102, 102, 102, 102, 102, 102, 108, 102, 102, + 109, 102, 102, 102, 106, 102, 107, 102, 102, 102, + 102, 102, 106, 102, 102, 102, 110, 107, 107, 102, + 102, 102, 102, 108, 102, 111, 102, 102, 102, 102, + 102, 109, 102, 102, 102, 102, 102, 102, 102, 102, + 102, 110, 107, 107, 102, 112, 102, 102, 102, 107, + 107, 102, 102, 102, 107, 102, 102, 102, 102, 102, + + 102, 0, 102, 102, 102, 102, 102, 102, 102, 102, + 102, 102 + } ; + +static yyconst flex_int16_t yy_nxt[253] = + { 0, + 10, 11, 12, 13, 13, 14, 15, 16, 17, 18, + 19, 20, 19, 21, 22, 23, 24, 25, 26, 25, + 10, 18, 18, 18, 27, 18, 18, 18, 18, 28, + 18, 18, 29, 10, 30, 10, 18, 18, 18, 27, + 18, 18, 18, 18, 28, 18, 31, 32, 33, 36, + 36, 39, 39, 42, 42, 59, 37, 37, 48, 52, + 49, 49, 50, 50, 53, 60, 93, 34, 65, 86, + 51, 59, 75, 54, 75, 49, 49, 76, 76, 40, + 40, 43, 43, 55, 61, 51, 56, 54, 73, 49, + 49, 57, 82, 83, 66, 84, 67, 55, 55, 100, + + 56, 99, 68, 50, 50, 69, 70, 71, 83, 98, + 84, 51, 55, 50, 50, 54, 74, 49, 49, 77, + 77, 51, 60, 76, 76, 55, 51, 78, 56, 79, + 97, 79, 76, 76, 80, 80, 51, 77, 77, 91, + 55, 61, 78, 96, 87, 78, 87, 80, 80, 88, + 88, 80, 80, 95, 91, 88, 88, 88, 88, 100, + 78, 94, 92, 101, 90, 89, 85, 62, 95, 35, + 35, 35, 35, 38, 38, 38, 38, 41, 41, 41, + 41, 45, 45, 45, 45, 47, 47, 64, 81, 64, + 64, 72, 46, 72, 72, 46, 44, 63, 62, 58, + + 46, 44, 102, 9, 102, 102, 102, 102, 102, 102, + 102, 102, 102, 102, 102, 102, 102, 102, 102, 102, + 102, 102, 102, 102, 102, 102, 102, 102, 102, 102, + 102, 102, 102, 102, 102, 102, 102, 102, 102, 102, + 102, 102, 102, 102, 102, 102, 102, 102, 102, 102, + 102, 102 + } ; + +static yyconst flex_int16_t yy_chk[253] = + { 0, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 1, 1, + 1, 1, 1, 1, 1, 1, 1, 1, 2, 3, + 4, 5, 6, 7, 8, 28, 3, 4, 19, 22, + 19, 19, 21, 21, 22, 33, 112, 2, 40, 111, + 21, 28, 51, 23, 51, 23, 23, 51, 51, 5, + 6, 7, 8, 23, 33, 21, 23, 24, 43, 24, + 24, 23, 110, 58, 40, 59, 40, 24, 23, 99, + + 24, 98, 40, 48, 48, 40, 40, 40, 58, 97, + 59, 48, 24, 50, 50, 49, 43, 49, 49, 54, + 54, 50, 60, 75, 75, 49, 48, 54, 49, 55, + 96, 55, 76, 76, 55, 55, 50, 77, 77, 84, + 49, 60, 54, 92, 78, 77, 78, 79, 79, 78, + 78, 80, 80, 90, 84, 87, 87, 88, 88, 100, + 77, 89, 85, 100, 83, 82, 62, 61, 90, 103, + 103, 103, 103, 104, 104, 104, 104, 105, 105, 105, + 105, 106, 106, 106, 106, 107, 107, 108, 56, 108, + 108, 109, 53, 109, 109, 45, 44, 37, 34, 27, + + 15, 11, 9, 102, 102, 102, 102, 102, 102, 102, + 102, 102, 102, 102, 102, 102, 102, 102, 102, 102, + 102, 102, 102, 102, 102, 102, 102, 102, 102, 102, + 102, 102, 102, 102, 102, 102, 102, 102, 102, 102, + 102, 102, 102, 102, 102, 102, 102, 102, 102, 102, + 102, 102 + } ; + +/* Table of booleans, true if rule could match eol. */ +static yyconst flex_int32_t yy_rule_can_match_eol[43] = + { 0, +0, 0, 0, 1, 0, 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 1, 0, 0, + 0, 1, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, 0, + 0, 0, 0, }; + +/* The intent behind this definition is that it'll catch + * any uses of REJECT which flex missed. + */ +#define REJECT reject_used_but_not_detected +#define yymore() yymore_used_but_not_detected +#define YY_MORE_ADJ 0 +#define YY_RESTORE_YY_MORE_OFFSET +#line 1 "scanner.l" +/* -*- mode: C -*- */ +/* -------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ +#define YY_NO_UNISTD_H 1 +#line 35 "scanner.l" + +#ifdef _MSC_VER +#pragma warning (disable: 4996) +#endif + +#include +#include +#include +#include "grammar.h" +#include "wincompat.h" +#include "parsectx.h" +#include "scanctx.h" + +#define YY_NO_INPUT // Suppress generation of useless input() function + +static unsigned long long fromhex(const char *s) +{ +#ifdef __MINGW32__ + + /* MinGW's strtoull() seems to be broken; it only returns the lower + * 32 bits... + */ + + const char *p = s; + unsigned long long val = 0; + + if(*p != '0') + return(0); + + ++p; + + if(*p != 'x' && *p != 'X') + return(0); + + for(++p; isxdigit(*p); ++p) + { + val <<= 4; + val |= ((*p < 'A') ? (*p & 0xF) : (9 + (*p & 0x7))); + } + + return(val); + +#else /* ! __MINGW32__ */ + + return(strtoull(s, NULL, 16)); + +#endif /* __MINGW32__ */ +} + + +#line 626 "scanner.c" + +#define INITIAL 0 +#define COMMENT 1 +#define STRING 2 +#define INCLUDE 3 + +#ifndef YY_NO_UNISTD_H +/* Special case for "unistd.h", since it is non-ANSI. We include it way + * down here because we want the user's section 1 to have been scanned first. + * The user has a chance to override it with an option. + */ +#include +#endif + +#define YY_EXTRA_TYPE struct scan_context * + +/* Holds the entire state of the reentrant scanner. */ +struct yyguts_t + { + + /* User-defined. Not touched by flex. */ + YY_EXTRA_TYPE yyextra_r; + + /* The rest are the same as the globals declared in the non-reentrant scanner. */ + FILE *yyin_r, *yyout_r; + size_t yy_buffer_stack_top; /**< index of top of stack. */ + size_t yy_buffer_stack_max; /**< capacity of stack. */ + YY_BUFFER_STATE * yy_buffer_stack; /**< Stack as an array. */ + char yy_hold_char; + int yy_n_chars; + int yyleng_r; + char *yy_c_buf_p; + int yy_init; + int yy_start; + int yy_did_buffer_switch_on_eof; + int yy_start_stack_ptr; + int yy_start_stack_depth; + int *yy_start_stack; + yy_state_type yy_last_accepting_state; + char* yy_last_accepting_cpos; + + int yylineno_r; + int yy_flex_debug_r; + + char *yytext_r; + int yy_more_flag; + int yy_more_len; + + YYSTYPE * yylval_r; + + }; /* end struct yyguts_t */ + +static int yy_init_globals (yyscan_t yyscanner ); + + /* This must go here because YYSTYPE and YYLTYPE are included + * from bison output in section 1.*/ + # define yylval yyg->yylval_r + +int libconfig_yylex_init (yyscan_t* scanner); + +int libconfig_yylex_init_extra (YY_EXTRA_TYPE user_defined,yyscan_t* scanner); + +/* Accessor methods to globals. + These are made visible to non-reentrant scanners for convenience. */ + +int libconfig_yylex_destroy (yyscan_t yyscanner ); + +int libconfig_yyget_debug (yyscan_t yyscanner ); + +void libconfig_yyset_debug (int debug_flag ,yyscan_t yyscanner ); + +YY_EXTRA_TYPE libconfig_yyget_extra (yyscan_t yyscanner ); + +void libconfig_yyset_extra (YY_EXTRA_TYPE user_defined ,yyscan_t yyscanner ); + +FILE *libconfig_yyget_in (yyscan_t yyscanner ); + +void libconfig_yyset_in (FILE * in_str ,yyscan_t yyscanner ); + +FILE *libconfig_yyget_out (yyscan_t yyscanner ); + +void libconfig_yyset_out (FILE * out_str ,yyscan_t yyscanner ); + +int libconfig_yyget_leng (yyscan_t yyscanner ); + +char *libconfig_yyget_text (yyscan_t yyscanner ); + +int libconfig_yyget_lineno (yyscan_t yyscanner ); + +void libconfig_yyset_lineno (int line_number ,yyscan_t yyscanner ); + +YYSTYPE * libconfig_yyget_lval (yyscan_t yyscanner ); + +void libconfig_yyset_lval (YYSTYPE * yylval_param ,yyscan_t yyscanner ); + +/* Macros after this point can all be overridden by user definitions in + * section 1. + */ + +#ifndef YY_SKIP_YYWRAP +#ifdef __cplusplus +extern "C" int libconfig_yywrap (yyscan_t yyscanner ); +#else +extern int libconfig_yywrap (yyscan_t yyscanner ); +#endif +#endif + +#ifndef yytext_ptr +static void yy_flex_strncpy (char *,yyconst char *,int ,yyscan_t yyscanner); +#endif + +#ifdef YY_NEED_STRLEN +static int yy_flex_strlen (yyconst char * ,yyscan_t yyscanner); +#endif + +#ifndef YY_NO_INPUT + +#ifdef __cplusplus +static int yyinput (yyscan_t yyscanner ); +#else +static int input (yyscan_t yyscanner ); +#endif + +#endif + +/* Amount of stuff to slurp up with each read. */ +#ifndef YY_READ_BUF_SIZE +#ifdef __ia64__ +/* On IA-64, the buffer size is 16k, not 8k */ +#define YY_READ_BUF_SIZE 16384 +#else +#define YY_READ_BUF_SIZE 8192 +#endif /* __ia64__ */ +#endif + +/* Copy whatever the last rule matched to the standard output. */ +#ifndef ECHO +/* This used to be an fputs(), but since the string might contain NUL's, + * we now use fwrite(). + */ +#define ECHO do { if (fwrite( yytext, yyleng, 1, yyout )) {} } while (0) +#endif + +/* Gets input and stuffs it into "buf". number of characters read, or YY_NULL, + * is returned in "result". + */ +#ifndef YY_INPUT +#define YY_INPUT(buf,result,max_size) \ + if ( YY_CURRENT_BUFFER_LVALUE->yy_is_interactive ) \ + { \ + int c = '*'; \ + size_t n; \ + for ( n = 0; n < max_size && \ + (c = getc( yyin )) != EOF && c != '\n'; ++n ) \ + buf[n] = (char) c; \ + if ( c == '\n' ) \ + buf[n++] = (char) c; \ + if ( c == EOF && ferror( yyin ) ) \ + YY_FATAL_ERROR( "input in flex scanner failed" ); \ + result = n; \ + } \ + else \ + { \ + errno=0; \ + while ( (result = fread(buf, 1, max_size, yyin))==0 && ferror(yyin)) \ + { \ + if( errno != EINTR) \ + { \ + YY_FATAL_ERROR( "input in flex scanner failed" ); \ + break; \ + } \ + errno=0; \ + clearerr(yyin); \ + } \ + }\ +\ + +#endif + +/* No semi-colon after return; correct usage is to write "yyterminate();" - + * we don't want an extra ';' after the "return" because that will cause + * some compilers to complain about unreachable statements. + */ +#ifndef yyterminate +#define yyterminate() return YY_NULL +#endif + +/* Number of entries by which start-condition stack grows. */ +#ifndef YY_START_STACK_INCR +#define YY_START_STACK_INCR 25 +#endif + +/* Report a fatal error. */ +#ifndef YY_FATAL_ERROR +#define YY_FATAL_ERROR(msg) yy_fatal_error( msg , yyscanner) +#endif + +/* end tables serialization structures and prototypes */ + +/* Default declaration of generated scanner - a define so the user can + * easily add parameters. + */ +#ifndef YY_DECL +#define YY_DECL_IS_OURS 1 + +extern int libconfig_yylex \ + (YYSTYPE * yylval_param ,yyscan_t yyscanner); + +#define YY_DECL int libconfig_yylex \ + (YYSTYPE * yylval_param , yyscan_t yyscanner) +#endif /* !YY_DECL */ + +/* Code executed at the beginning of each rule, after yytext and yyleng + * have been set up. + */ +#ifndef YY_USER_ACTION +#define YY_USER_ACTION +#endif + +/* Code executed at the end of each rule. */ +#ifndef YY_BREAK +#define YY_BREAK break; +#endif + +#define YY_RULE_SETUP \ + if ( yyleng > 0 ) \ + YY_CURRENT_BUFFER_LVALUE->yy_at_bol = \ + (yytext[yyleng - 1] == '\n'); \ + YY_USER_ACTION + +/** The main scanner function which does all the work. + */ +YY_DECL +{ + register yy_state_type yy_current_state; + register char *yy_cp, *yy_bp; + register int yy_act; + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + +#line 100 "scanner.l" + + +#line 869 "scanner.c" + + yylval = yylval_param; + + if ( !yyg->yy_init ) + { + yyg->yy_init = 1; + +#ifdef YY_USER_INIT + YY_USER_INIT; +#endif + + if ( ! yyg->yy_start ) + yyg->yy_start = 1; /* first start state */ + + if ( ! yyin ) + yyin = stdin; + + if ( ! yyout ) + yyout = stdout; + + if ( ! YY_CURRENT_BUFFER ) { + libconfig_yyensure_buffer_stack (yyscanner); + YY_CURRENT_BUFFER_LVALUE = + libconfig_yy_create_buffer(yyin,YY_BUF_SIZE ,yyscanner); + } + + libconfig_yy_load_buffer_state(yyscanner ); + } + + while ( 1 ) /* loops until end-of-file is reached */ + { + yy_cp = yyg->yy_c_buf_p; + + /* Support of yytext. */ + *yy_cp = yyg->yy_hold_char; + + /* yy_bp points to the position in yy_ch_buf of the start of + * the current run. + */ + yy_bp = yy_cp; + + yy_current_state = yyg->yy_start; + yy_current_state += YY_AT_BOL(); +yy_match: + do + { + register YY_CHAR yy_c = yy_ec[YY_SC_TO_UI(*yy_cp)]; + if ( yy_accept[yy_current_state] ) + { + yyg->yy_last_accepting_state = yy_current_state; + yyg->yy_last_accepting_cpos = yy_cp; + } + while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) + { + yy_current_state = (int) yy_def[yy_current_state]; + if ( yy_current_state >= 103 ) + yy_c = yy_meta[(unsigned int) yy_c]; + } + yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; + ++yy_cp; + } + while ( yy_base[yy_current_state] != 204 ); + +yy_find_action: + yy_act = yy_accept[yy_current_state]; + if ( yy_act == 0 ) + { /* have to back up */ + yy_cp = yyg->yy_last_accepting_cpos; + yy_current_state = yyg->yy_last_accepting_state; + yy_act = yy_accept[yy_current_state]; + } + + YY_DO_BEFORE_ACTION; + + if ( yy_act != YY_END_OF_BUFFER && yy_rule_can_match_eol[yy_act] ) + { + int yyl; + for ( yyl = 0; yyl < yyleng; ++yyl ) + if ( yytext[yyl] == '\n' ) + + do{ yylineno++; + yycolumn=0; + }while(0) +; + } + +do_action: /* This label is used only to access EOF actions. */ + + switch ( yy_act ) + { /* beginning of action switch */ + case 0: /* must back up */ + /* undo the effects of YY_DO_BEFORE_ACTION */ + *yy_cp = yyg->yy_hold_char; + yy_cp = yyg->yy_last_accepting_cpos; + yy_current_state = yyg->yy_last_accepting_state; + goto yy_find_action; + +case 1: +YY_RULE_SETUP +#line 102 "scanner.l" +{ BEGIN COMMENT; } + YY_BREAK +case 2: +YY_RULE_SETUP +#line 103 "scanner.l" +{ BEGIN INITIAL; } + YY_BREAK +case 3: +YY_RULE_SETUP +#line 104 "scanner.l" +{ /* ignore */ } + YY_BREAK +case 4: +/* rule 4 can match eol */ +YY_RULE_SETUP +#line 105 "scanner.l" +{ /* ignore */ } + YY_BREAK +case 5: +YY_RULE_SETUP +#line 107 "scanner.l" +{ BEGIN STRING; } + YY_BREAK +case 6: +/* rule 6 can match eol */ +YY_RULE_SETUP +#line 108 "scanner.l" +{ scanctx_append_string(yyextra, yytext); } + YY_BREAK +case 7: +YY_RULE_SETUP +#line 109 "scanner.l" +{ scanctx_append_string(yyextra, "\n"); } + YY_BREAK +case 8: +YY_RULE_SETUP +#line 110 "scanner.l" +{ scanctx_append_string(yyextra, "\r"); } + YY_BREAK +case 9: +YY_RULE_SETUP +#line 111 "scanner.l" +{ scanctx_append_string(yyextra, "\t"); } + YY_BREAK +case 10: +YY_RULE_SETUP +#line 112 "scanner.l" +{ scanctx_append_string(yyextra, "\f"); } + YY_BREAK +case 11: +YY_RULE_SETUP +#line 113 "scanner.l" +{ scanctx_append_string(yyextra, "\\"); } + YY_BREAK +case 12: +YY_RULE_SETUP +#line 114 "scanner.l" +{ scanctx_append_string(yyextra, "\""); } + YY_BREAK +case 13: +YY_RULE_SETUP +#line 115 "scanner.l" +{ + char c[2] = { (char)(strtol(yytext + 2, NULL, 16) & 0xFF), + 0 }; + scanctx_append_string(yyextra, c); + } + YY_BREAK +case 14: +YY_RULE_SETUP +#line 120 "scanner.l" +{ scanctx_append_string(yyextra, "\\"); } + YY_BREAK +case 15: +YY_RULE_SETUP +#line 121 "scanner.l" +{ + yylval->sval = scanctx_take_string(yyextra); + BEGIN INITIAL; + return(TOK_STRING); + } + YY_BREAK +case 16: +YY_RULE_SETUP +#line 127 "scanner.l" +{ BEGIN INCLUDE; } + YY_BREAK +case 17: +/* rule 17 can match eol */ +YY_RULE_SETUP +#line 128 "scanner.l" +{ scanctx_append_string(yyextra, yytext); } + YY_BREAK +case 18: +YY_RULE_SETUP +#line 129 "scanner.l" +{ scanctx_append_string(yyextra, "\\"); } + YY_BREAK +case 19: +YY_RULE_SETUP +#line 130 "scanner.l" +{ scanctx_append_string(yyextra, "\""); } + YY_BREAK +case 20: +YY_RULE_SETUP +#line 131 "scanner.l" +{ + const char *error; + FILE *fp = scanctx_push_include(yyextra, + (void *)YY_CURRENT_BUFFER, + &error); + if(fp) + { + yyin = fp; + libconfig_yy_switch_to_buffer(libconfig_yy_create_buffer(yyin,YY_BUF_SIZE,yyscanner),yyscanner); + } + else + { + yyextra->config->error_text = error; + yyextra->config->error_file = scanctx_current_filename( + yyextra); + yyextra->config->error_line = libconfig_yyget_lineno( + yyscanner); + return TOK_ERROR; + } + BEGIN INITIAL; + } + YY_BREAK +case 21: +/* rule 21 can match eol */ +YY_RULE_SETUP +#line 155 "scanner.l" +{ /* ignore */ } + YY_BREAK +case 22: +YY_RULE_SETUP +#line 156 "scanner.l" +{ /* ignore */ } + YY_BREAK +case 23: +YY_RULE_SETUP +#line 158 "scanner.l" +{ return(TOK_EQUALS); } + YY_BREAK +case 24: +YY_RULE_SETUP +#line 159 "scanner.l" +{ return(TOK_COMMA); } + YY_BREAK +case 25: +YY_RULE_SETUP +#line 160 "scanner.l" +{ return(TOK_GROUP_START); } + YY_BREAK +case 26: +YY_RULE_SETUP +#line 161 "scanner.l" +{ return(TOK_GROUP_END); } + YY_BREAK +case 27: +YY_RULE_SETUP +#line 162 "scanner.l" +{ yylval->ival = 1; return(TOK_BOOLEAN); } + YY_BREAK +case 28: +YY_RULE_SETUP +#line 163 "scanner.l" +{ yylval->ival = 0; return(TOK_BOOLEAN); } + YY_BREAK +case 29: +YY_RULE_SETUP +#line 164 "scanner.l" +{ yylval->sval = yytext; return(TOK_NAME); } + YY_BREAK +case 30: +YY_RULE_SETUP +#line 165 "scanner.l" +{ yylval->fval = atof(yytext); return(TOK_FLOAT); } + YY_BREAK +case 31: +YY_RULE_SETUP +#line 166 "scanner.l" +{ yylval->ival = atoi(yytext); return(TOK_INTEGER); } + YY_BREAK +case 32: +YY_RULE_SETUP +#line 167 "scanner.l" +{ yylval->llval = atoll(yytext); return(TOK_INTEGER64); } + YY_BREAK +case 33: +YY_RULE_SETUP +#line 168 "scanner.l" +{ + yylval->ival = strtoul(yytext, NULL, 16); + return(TOK_HEX); + } + YY_BREAK +case 34: +YY_RULE_SETUP +#line 172 "scanner.l" +{ yylval->llval = fromhex(yytext); return(TOK_HEX64); } + YY_BREAK +case 35: +YY_RULE_SETUP +#line 173 "scanner.l" +{ return(TOK_ARRAY_START); } + YY_BREAK +case 36: +YY_RULE_SETUP +#line 174 "scanner.l" +{ return(TOK_ARRAY_END); } + YY_BREAK +case 37: +YY_RULE_SETUP +#line 175 "scanner.l" +{ return(TOK_LIST_START); } + YY_BREAK +case 38: +YY_RULE_SETUP +#line 176 "scanner.l" +{ return(TOK_LIST_END); } + YY_BREAK +case 39: +YY_RULE_SETUP +#line 177 "scanner.l" +{ return(TOK_SEMICOLON); } + YY_BREAK +case 40: +*yy_cp = yyg->yy_hold_char; /* undo effects of setting up yytext */ +yyg->yy_c_buf_p = yy_cp -= 1; +YY_DO_BEFORE_ACTION; /* set up yytext again */ +YY_RULE_SETUP +#line 178 "scanner.l" +{ /* ignore */ } + YY_BREAK +case 41: +YY_RULE_SETUP +#line 179 "scanner.l" +{ return(TOK_GARBAGE); } + YY_BREAK +case YY_STATE_EOF(INITIAL): +case YY_STATE_EOF(COMMENT): +case YY_STATE_EOF(STRING): +case YY_STATE_EOF(INCLUDE): +#line 181 "scanner.l" +{ + YY_BUFFER_STATE buf = (YY_BUFFER_STATE)scanctx_pop_include( + yyextra); + if(buf) + { + libconfig_yy_delete_buffer(YY_CURRENT_BUFFER,yyscanner); + libconfig_yy_switch_to_buffer(buf,yyscanner); + } + else + yyterminate(); + } + YY_BREAK +case 42: +YY_RULE_SETUP +#line 192 "scanner.l" +ECHO; + YY_BREAK +#line 1232 "scanner.c" + + case YY_END_OF_BUFFER: + { + /* Amount of text matched not including the EOB char. */ + int yy_amount_of_matched_text = (int) (yy_cp - yyg->yytext_ptr) - 1; + + /* Undo the effects of YY_DO_BEFORE_ACTION. */ + *yy_cp = yyg->yy_hold_char; + YY_RESTORE_YY_MORE_OFFSET + + if ( YY_CURRENT_BUFFER_LVALUE->yy_buffer_status == YY_BUFFER_NEW ) + { + /* We're scanning a new file or input source. It's + * possible that this happened because the user + * just pointed yyin at a new source and called + * libconfig_yylex(). If so, then we have to assure + * consistency between YY_CURRENT_BUFFER and our + * globals. Here is the right place to do so, because + * this is the first action (other than possibly a + * back-up) that will match for the new input source. + */ + yyg->yy_n_chars = YY_CURRENT_BUFFER_LVALUE->yy_n_chars; + YY_CURRENT_BUFFER_LVALUE->yy_input_file = yyin; + YY_CURRENT_BUFFER_LVALUE->yy_buffer_status = YY_BUFFER_NORMAL; + } + + /* Note that here we test for yy_c_buf_p "<=" to the position + * of the first EOB in the buffer, since yy_c_buf_p will + * already have been incremented past the NUL character + * (since all states make transitions on EOB to the + * end-of-buffer state). Contrast this with the test + * in input(). + */ + if ( yyg->yy_c_buf_p <= &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[yyg->yy_n_chars] ) + { /* This was really a NUL. */ + yy_state_type yy_next_state; + + yyg->yy_c_buf_p = yyg->yytext_ptr + yy_amount_of_matched_text; + + yy_current_state = yy_get_previous_state( yyscanner ); + + /* Okay, we're now positioned to make the NUL + * transition. We couldn't have + * yy_get_previous_state() go ahead and do it + * for us because it doesn't know how to deal + * with the possibility of jamming (and we don't + * want to build jamming into it because then it + * will run more slowly). + */ + + yy_next_state = yy_try_NUL_trans( yy_current_state , yyscanner); + + yy_bp = yyg->yytext_ptr + YY_MORE_ADJ; + + if ( yy_next_state ) + { + /* Consume the NUL. */ + yy_cp = ++yyg->yy_c_buf_p; + yy_current_state = yy_next_state; + goto yy_match; + } + + else + { + yy_cp = yyg->yy_c_buf_p; + goto yy_find_action; + } + } + + else switch ( yy_get_next_buffer( yyscanner ) ) + { + case EOB_ACT_END_OF_FILE: + { + yyg->yy_did_buffer_switch_on_eof = 0; + + if ( libconfig_yywrap(yyscanner ) ) + { + /* Note: because we've taken care in + * yy_get_next_buffer() to have set up + * yytext, we can now set up + * yy_c_buf_p so that if some total + * hoser (like flex itself) wants to + * call the scanner after we return the + * YY_NULL, it'll still work - another + * YY_NULL will get returned. + */ + yyg->yy_c_buf_p = yyg->yytext_ptr + YY_MORE_ADJ; + + yy_act = YY_STATE_EOF(YY_START); + goto do_action; + } + + else + { + if ( ! yyg->yy_did_buffer_switch_on_eof ) + YY_NEW_FILE; + } + break; + } + + case EOB_ACT_CONTINUE_SCAN: + yyg->yy_c_buf_p = + yyg->yytext_ptr + yy_amount_of_matched_text; + + yy_current_state = yy_get_previous_state( yyscanner ); + + yy_cp = yyg->yy_c_buf_p; + yy_bp = yyg->yytext_ptr + YY_MORE_ADJ; + goto yy_match; + + case EOB_ACT_LAST_MATCH: + yyg->yy_c_buf_p = + &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[yyg->yy_n_chars]; + + yy_current_state = yy_get_previous_state( yyscanner ); + + yy_cp = yyg->yy_c_buf_p; + yy_bp = yyg->yytext_ptr + YY_MORE_ADJ; + goto yy_find_action; + } + break; + } + + default: + YY_FATAL_ERROR( + "fatal flex scanner internal error--no action found" ); + } /* end of action switch */ + } /* end of scanning one token */ +} /* end of libconfig_yylex */ + +/* yy_get_next_buffer - try to read in a new buffer + * + * Returns a code representing an action: + * EOB_ACT_LAST_MATCH - + * EOB_ACT_CONTINUE_SCAN - continue scanning from current position + * EOB_ACT_END_OF_FILE - end of file + */ +static int yy_get_next_buffer (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + register char *dest = YY_CURRENT_BUFFER_LVALUE->yy_ch_buf; + register char *source = yyg->yytext_ptr; + register int number_to_move, i; + int ret_val; + + if ( yyg->yy_c_buf_p > &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[yyg->yy_n_chars + 1] ) + YY_FATAL_ERROR( + "fatal flex scanner internal error--end of buffer missed" ); + + if ( YY_CURRENT_BUFFER_LVALUE->yy_fill_buffer == 0 ) + { /* Don't try to fill the buffer, so this is an EOF. */ + if ( yyg->yy_c_buf_p - yyg->yytext_ptr - YY_MORE_ADJ == 1 ) + { + /* We matched a single character, the EOB, so + * treat this as a final EOF. + */ + return EOB_ACT_END_OF_FILE; + } + + else + { + /* We matched some text prior to the EOB, first + * process it. + */ + return EOB_ACT_LAST_MATCH; + } + } + + /* Try to read more data. */ + + /* First move last chars to start of buffer. */ + number_to_move = (int) (yyg->yy_c_buf_p - yyg->yytext_ptr) - 1; + + for ( i = 0; i < number_to_move; ++i ) + *(dest++) = *(source++); + + if ( YY_CURRENT_BUFFER_LVALUE->yy_buffer_status == YY_BUFFER_EOF_PENDING ) + /* don't do the read, it's not guaranteed to return an EOF, + * just force an EOF + */ + YY_CURRENT_BUFFER_LVALUE->yy_n_chars = yyg->yy_n_chars = 0; + + else + { + int num_to_read = + YY_CURRENT_BUFFER_LVALUE->yy_buf_size - number_to_move - 1; + + while ( num_to_read <= 0 ) + { /* Not enough room in the buffer - grow it. */ + + /* just a shorter name for the current buffer */ + YY_BUFFER_STATE b = YY_CURRENT_BUFFER; + + int yy_c_buf_p_offset = + (int) (yyg->yy_c_buf_p - b->yy_ch_buf); + + if ( b->yy_is_our_buffer ) + { + int new_size = b->yy_buf_size * 2; + + if ( new_size <= 0 ) + b->yy_buf_size += b->yy_buf_size / 8; + else + b->yy_buf_size *= 2; + + b->yy_ch_buf = (char *) + /* Include room in for 2 EOB chars. */ + libconfig_yyrealloc((void *) b->yy_ch_buf,b->yy_buf_size + 2 ,yyscanner ); + } + else + /* Can't grow it, we don't own it. */ + b->yy_ch_buf = 0; + + if ( ! b->yy_ch_buf ) + YY_FATAL_ERROR( + "fatal error - scanner input buffer overflow" ); + + yyg->yy_c_buf_p = &b->yy_ch_buf[yy_c_buf_p_offset]; + + num_to_read = YY_CURRENT_BUFFER_LVALUE->yy_buf_size - + number_to_move - 1; + + } + + if ( num_to_read > YY_READ_BUF_SIZE ) + num_to_read = YY_READ_BUF_SIZE; + + /* Read in more data. */ + YY_INPUT( (&YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[number_to_move]), + yyg->yy_n_chars, (size_t) num_to_read ); + + YY_CURRENT_BUFFER_LVALUE->yy_n_chars = yyg->yy_n_chars; + } + + if ( yyg->yy_n_chars == 0 ) + { + if ( number_to_move == YY_MORE_ADJ ) + { + ret_val = EOB_ACT_END_OF_FILE; + libconfig_yyrestart(yyin ,yyscanner); + } + + else + { + ret_val = EOB_ACT_LAST_MATCH; + YY_CURRENT_BUFFER_LVALUE->yy_buffer_status = + YY_BUFFER_EOF_PENDING; + } + } + + else + ret_val = EOB_ACT_CONTINUE_SCAN; + + if ((yy_size_t) (yyg->yy_n_chars + number_to_move) > YY_CURRENT_BUFFER_LVALUE->yy_buf_size) { + /* Extend the array by 50%, plus the number we really need. */ + yy_size_t new_size = yyg->yy_n_chars + number_to_move + (yyg->yy_n_chars >> 1); + YY_CURRENT_BUFFER_LVALUE->yy_ch_buf = (char *) libconfig_yyrealloc((void *) YY_CURRENT_BUFFER_LVALUE->yy_ch_buf,new_size ,yyscanner ); + if ( ! YY_CURRENT_BUFFER_LVALUE->yy_ch_buf ) + YY_FATAL_ERROR( "out of dynamic memory in yy_get_next_buffer()" ); + } + + yyg->yy_n_chars += number_to_move; + YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[yyg->yy_n_chars] = YY_END_OF_BUFFER_CHAR; + YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[yyg->yy_n_chars + 1] = YY_END_OF_BUFFER_CHAR; + + yyg->yytext_ptr = &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[0]; + + return ret_val; +} + +/* yy_get_previous_state - get the state just before the EOB char was reached */ + + static yy_state_type yy_get_previous_state (yyscan_t yyscanner) +{ + register yy_state_type yy_current_state; + register char *yy_cp; + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + + yy_current_state = yyg->yy_start; + yy_current_state += YY_AT_BOL(); + + for ( yy_cp = yyg->yytext_ptr + YY_MORE_ADJ; yy_cp < yyg->yy_c_buf_p; ++yy_cp ) + { + register YY_CHAR yy_c = (*yy_cp ? yy_ec[YY_SC_TO_UI(*yy_cp)] : 1); + if ( yy_accept[yy_current_state] ) + { + yyg->yy_last_accepting_state = yy_current_state; + yyg->yy_last_accepting_cpos = yy_cp; + } + while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) + { + yy_current_state = (int) yy_def[yy_current_state]; + if ( yy_current_state >= 103 ) + yy_c = yy_meta[(unsigned int) yy_c]; + } + yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; + } + + return yy_current_state; +} + +/* yy_try_NUL_trans - try to make a transition on the NUL character + * + * synopsis + * next_state = yy_try_NUL_trans( current_state ); + */ + static yy_state_type yy_try_NUL_trans (yy_state_type yy_current_state , yyscan_t yyscanner) +{ + register int yy_is_jam; + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; /* This var may be unused depending upon options. */ + register char *yy_cp = yyg->yy_c_buf_p; + + register YY_CHAR yy_c = 1; + if ( yy_accept[yy_current_state] ) + { + yyg->yy_last_accepting_state = yy_current_state; + yyg->yy_last_accepting_cpos = yy_cp; + } + while ( yy_chk[yy_base[yy_current_state] + yy_c] != yy_current_state ) + { + yy_current_state = (int) yy_def[yy_current_state]; + if ( yy_current_state >= 103 ) + yy_c = yy_meta[(unsigned int) yy_c]; + } + yy_current_state = yy_nxt[yy_base[yy_current_state] + (unsigned int) yy_c]; + yy_is_jam = (yy_current_state == 102); + + return yy_is_jam ? 0 : yy_current_state; +} + +#ifndef YY_NO_INPUT +#ifdef __cplusplus + static int yyinput (yyscan_t yyscanner) +#else + static int input (yyscan_t yyscanner) +#endif + +{ + int c; + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + + *yyg->yy_c_buf_p = yyg->yy_hold_char; + + if ( *yyg->yy_c_buf_p == YY_END_OF_BUFFER_CHAR ) + { + /* yy_c_buf_p now points to the character we want to return. + * If this occurs *before* the EOB characters, then it's a + * valid NUL; if not, then we've hit the end of the buffer. + */ + if ( yyg->yy_c_buf_p < &YY_CURRENT_BUFFER_LVALUE->yy_ch_buf[yyg->yy_n_chars] ) + /* This was really a NUL. */ + *yyg->yy_c_buf_p = '\0'; + + else + { /* need more input */ + int offset = yyg->yy_c_buf_p - yyg->yytext_ptr; + ++yyg->yy_c_buf_p; + + switch ( yy_get_next_buffer( yyscanner ) ) + { + case EOB_ACT_LAST_MATCH: + /* This happens because yy_g_n_b() + * sees that we've accumulated a + * token and flags that we need to + * try matching the token before + * proceeding. But for input(), + * there's no matching to consider. + * So convert the EOB_ACT_LAST_MATCH + * to EOB_ACT_END_OF_FILE. + */ + + /* Reset buffer status. */ + libconfig_yyrestart(yyin ,yyscanner); + + /*FALLTHROUGH*/ + + case EOB_ACT_END_OF_FILE: + { + if ( libconfig_yywrap(yyscanner ) ) + return EOF; + + if ( ! yyg->yy_did_buffer_switch_on_eof ) + YY_NEW_FILE; +#ifdef __cplusplus + return yyinput(yyscanner); +#else + return input(yyscanner); +#endif + } + + case EOB_ACT_CONTINUE_SCAN: + yyg->yy_c_buf_p = yyg->yytext_ptr + offset; + break; + } + } + } + + c = *(unsigned char *) yyg->yy_c_buf_p; /* cast for 8-bit char's */ + *yyg->yy_c_buf_p = '\0'; /* preserve yytext */ + yyg->yy_hold_char = *++yyg->yy_c_buf_p; + + YY_CURRENT_BUFFER_LVALUE->yy_at_bol = (c == '\n'); + if ( YY_CURRENT_BUFFER_LVALUE->yy_at_bol ) + + do{ yylineno++; + yycolumn=0; + }while(0) +; + + return c; +} +#endif /* ifndef YY_NO_INPUT */ + +/** Immediately switch to a different input stream. + * @param input_file A readable stream. + * @param yyscanner The scanner object. + * @note This function does not reset the start condition to @c INITIAL . + */ + void libconfig_yyrestart (FILE * input_file , yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + + if ( ! YY_CURRENT_BUFFER ){ + libconfig_yyensure_buffer_stack (yyscanner); + YY_CURRENT_BUFFER_LVALUE = + libconfig_yy_create_buffer(yyin,YY_BUF_SIZE ,yyscanner); + } + + libconfig_yy_init_buffer(YY_CURRENT_BUFFER,input_file ,yyscanner); + libconfig_yy_load_buffer_state(yyscanner ); +} + +/** Switch to a different input buffer. + * @param new_buffer The new input buffer. + * @param yyscanner The scanner object. + */ + void libconfig_yy_switch_to_buffer (YY_BUFFER_STATE new_buffer , yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + + /* TODO. We should be able to replace this entire function body + * with + * libconfig_yypop_buffer_state(); + * libconfig_yypush_buffer_state(new_buffer); + */ + libconfig_yyensure_buffer_stack (yyscanner); + if ( YY_CURRENT_BUFFER == new_buffer ) + return; + + if ( YY_CURRENT_BUFFER ) + { + /* Flush out information for old buffer. */ + *yyg->yy_c_buf_p = yyg->yy_hold_char; + YY_CURRENT_BUFFER_LVALUE->yy_buf_pos = yyg->yy_c_buf_p; + YY_CURRENT_BUFFER_LVALUE->yy_n_chars = yyg->yy_n_chars; + } + + YY_CURRENT_BUFFER_LVALUE = new_buffer; + libconfig_yy_load_buffer_state(yyscanner ); + + /* We don't actually know whether we did this switch during + * EOF (libconfig_yywrap()) processing, but the only time this flag + * is looked at is after libconfig_yywrap() is called, so it's safe + * to go ahead and always set it. + */ + yyg->yy_did_buffer_switch_on_eof = 1; +} + +static void libconfig_yy_load_buffer_state (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + yyg->yy_n_chars = YY_CURRENT_BUFFER_LVALUE->yy_n_chars; + yyg->yytext_ptr = yyg->yy_c_buf_p = YY_CURRENT_BUFFER_LVALUE->yy_buf_pos; + yyin = YY_CURRENT_BUFFER_LVALUE->yy_input_file; + yyg->yy_hold_char = *yyg->yy_c_buf_p; +} + +/** Allocate and initialize an input buffer state. + * @param file A readable stream. + * @param size The character buffer size in bytes. When in doubt, use @c YY_BUF_SIZE. + * @param yyscanner The scanner object. + * @return the allocated buffer state. + */ + YY_BUFFER_STATE libconfig_yy_create_buffer (FILE * file, int size , yyscan_t yyscanner) +{ + YY_BUFFER_STATE b; + + b = (YY_BUFFER_STATE) libconfig_yyalloc(sizeof( struct yy_buffer_state ) ,yyscanner ); + if ( ! b ) + YY_FATAL_ERROR( "out of dynamic memory in libconfig_yy_create_buffer()" ); + + b->yy_buf_size = size; + + /* yy_ch_buf has to be 2 characters longer than the size given because + * we need to put in 2 end-of-buffer characters. + */ + b->yy_ch_buf = (char *) libconfig_yyalloc(b->yy_buf_size + 2 ,yyscanner ); + if ( ! b->yy_ch_buf ) + YY_FATAL_ERROR( "out of dynamic memory in libconfig_yy_create_buffer()" ); + + b->yy_is_our_buffer = 1; + + libconfig_yy_init_buffer(b,file ,yyscanner); + + return b; +} + +/** Destroy the buffer. + * @param b a buffer created with libconfig_yy_create_buffer() + * @param yyscanner The scanner object. + */ + void libconfig_yy_delete_buffer (YY_BUFFER_STATE b , yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + + if ( ! b ) + return; + + if ( b == YY_CURRENT_BUFFER ) /* Not sure if we should pop here. */ + YY_CURRENT_BUFFER_LVALUE = (YY_BUFFER_STATE) 0; + + if ( b->yy_is_our_buffer ) + libconfig_yyfree((void *) b->yy_ch_buf ,yyscanner ); + + libconfig_yyfree((void *) b ,yyscanner ); +} + +#ifndef __cplusplus +extern int isatty (int ); +#endif /* __cplusplus */ + +/* Initializes or reinitializes a buffer. + * This function is sometimes called more than once on the same buffer, + * such as during a libconfig_yyrestart() or at EOF. + */ + static void libconfig_yy_init_buffer (YY_BUFFER_STATE b, FILE * file , yyscan_t yyscanner) + +{ + int oerrno = errno; + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + + libconfig_yy_flush_buffer(b ,yyscanner); + + b->yy_input_file = file; + b->yy_fill_buffer = 1; + + /* If b is the current buffer, then libconfig_yy_init_buffer was _probably_ + * called from libconfig_yyrestart() or through yy_get_next_buffer. + * In that case, we don't want to reset the lineno or column. + */ + if (b != YY_CURRENT_BUFFER){ + b->yy_bs_lineno = 1; + b->yy_bs_column = 0; + } + + b->yy_is_interactive = file ? (isatty( fileno(file) ) > 0) : 0; + + errno = oerrno; +} + +/** Discard all buffered characters. On the next scan, YY_INPUT will be called. + * @param b the buffer state to be flushed, usually @c YY_CURRENT_BUFFER. + * @param yyscanner The scanner object. + */ + void libconfig_yy_flush_buffer (YY_BUFFER_STATE b , yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + if ( ! b ) + return; + + b->yy_n_chars = 0; + + /* We always need two end-of-buffer characters. The first causes + * a transition to the end-of-buffer state. The second causes + * a jam in that state. + */ + b->yy_ch_buf[0] = YY_END_OF_BUFFER_CHAR; + b->yy_ch_buf[1] = YY_END_OF_BUFFER_CHAR; + + b->yy_buf_pos = &b->yy_ch_buf[0]; + + b->yy_at_bol = 1; + b->yy_buffer_status = YY_BUFFER_NEW; + + if ( b == YY_CURRENT_BUFFER ) + libconfig_yy_load_buffer_state(yyscanner ); +} + +/** Pushes the new state onto the stack. The new state becomes + * the current state. This function will allocate the stack + * if necessary. + * @param new_buffer The new state. + * @param yyscanner The scanner object. + */ +void libconfig_yypush_buffer_state (YY_BUFFER_STATE new_buffer , yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + if (new_buffer == NULL) + return; + + libconfig_yyensure_buffer_stack(yyscanner); + + /* This block is copied from libconfig_yy_switch_to_buffer. */ + if ( YY_CURRENT_BUFFER ) + { + /* Flush out information for old buffer. */ + *yyg->yy_c_buf_p = yyg->yy_hold_char; + YY_CURRENT_BUFFER_LVALUE->yy_buf_pos = yyg->yy_c_buf_p; + YY_CURRENT_BUFFER_LVALUE->yy_n_chars = yyg->yy_n_chars; + } + + /* Only push if top exists. Otherwise, replace top. */ + if (YY_CURRENT_BUFFER) + yyg->yy_buffer_stack_top++; + YY_CURRENT_BUFFER_LVALUE = new_buffer; + + /* copied from libconfig_yy_switch_to_buffer. */ + libconfig_yy_load_buffer_state(yyscanner ); + yyg->yy_did_buffer_switch_on_eof = 1; +} + +/** Removes and deletes the top of the stack, if present. + * The next element becomes the new top. + * @param yyscanner The scanner object. + */ +void libconfig_yypop_buffer_state (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + if (!YY_CURRENT_BUFFER) + return; + + libconfig_yy_delete_buffer(YY_CURRENT_BUFFER ,yyscanner); + YY_CURRENT_BUFFER_LVALUE = NULL; + if (yyg->yy_buffer_stack_top > 0) + --yyg->yy_buffer_stack_top; + + if (YY_CURRENT_BUFFER) { + libconfig_yy_load_buffer_state(yyscanner ); + yyg->yy_did_buffer_switch_on_eof = 1; + } +} + +/* Allocates the stack if it does not exist. + * Guarantees space for at least one push. + */ +static void libconfig_yyensure_buffer_stack (yyscan_t yyscanner) +{ + int num_to_alloc; + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + + if (!yyg->yy_buffer_stack) { + + /* First allocation is just for 2 elements, since we don't know if this + * scanner will even need a stack. We use 2 instead of 1 to avoid an + * immediate realloc on the next call. + */ + num_to_alloc = 1; + yyg->yy_buffer_stack = (struct yy_buffer_state**)libconfig_yyalloc + (num_to_alloc * sizeof(struct yy_buffer_state*) + , yyscanner); + if ( ! yyg->yy_buffer_stack ) + YY_FATAL_ERROR( "out of dynamic memory in libconfig_yyensure_buffer_stack()" ); + + memset(yyg->yy_buffer_stack, 0, num_to_alloc * sizeof(struct yy_buffer_state*)); + + yyg->yy_buffer_stack_max = num_to_alloc; + yyg->yy_buffer_stack_top = 0; + return; + } + + if (yyg->yy_buffer_stack_top >= (yyg->yy_buffer_stack_max) - 1){ + + /* Increase the buffer to prepare for a possible push. */ + int grow_size = 8 /* arbitrary grow size */; + + num_to_alloc = yyg->yy_buffer_stack_max + grow_size; + yyg->yy_buffer_stack = (struct yy_buffer_state**)libconfig_yyrealloc + (yyg->yy_buffer_stack, + num_to_alloc * sizeof(struct yy_buffer_state*) + , yyscanner); + if ( ! yyg->yy_buffer_stack ) + YY_FATAL_ERROR( "out of dynamic memory in libconfig_yyensure_buffer_stack()" ); + + /* zero only the new slots.*/ + memset(yyg->yy_buffer_stack + yyg->yy_buffer_stack_max, 0, grow_size * sizeof(struct yy_buffer_state*)); + yyg->yy_buffer_stack_max = num_to_alloc; + } +} + +/** Setup the input buffer state to scan directly from a user-specified character buffer. + * @param base the character buffer + * @param size the size in bytes of the character buffer + * @param yyscanner The scanner object. + * @return the newly allocated buffer state object. + */ +YY_BUFFER_STATE libconfig_yy_scan_buffer (char * base, yy_size_t size , yyscan_t yyscanner) +{ + YY_BUFFER_STATE b; + + if ( size < 2 || + base[size-2] != YY_END_OF_BUFFER_CHAR || + base[size-1] != YY_END_OF_BUFFER_CHAR ) + /* They forgot to leave room for the EOB's. */ + return 0; + + b = (YY_BUFFER_STATE) libconfig_yyalloc(sizeof( struct yy_buffer_state ) ,yyscanner ); + if ( ! b ) + YY_FATAL_ERROR( "out of dynamic memory in libconfig_yy_scan_buffer()" ); + + b->yy_buf_size = size - 2; /* "- 2" to take care of EOB's */ + b->yy_buf_pos = b->yy_ch_buf = base; + b->yy_is_our_buffer = 0; + b->yy_input_file = 0; + b->yy_n_chars = b->yy_buf_size; + b->yy_is_interactive = 0; + b->yy_at_bol = 1; + b->yy_fill_buffer = 0; + b->yy_buffer_status = YY_BUFFER_NEW; + + libconfig_yy_switch_to_buffer(b ,yyscanner ); + + return b; +} + +/** Setup the input buffer state to scan a string. The next call to libconfig_yylex() will + * scan from a @e copy of @a str. + * @param yystr a NUL-terminated string to scan + * @param yyscanner The scanner object. + * @return the newly allocated buffer state object. + * @note If you want to scan bytes that may contain NUL values, then use + * libconfig_yy_scan_bytes() instead. + */ +YY_BUFFER_STATE libconfig_yy_scan_string (yyconst char * yystr , yyscan_t yyscanner) +{ + + return libconfig_yy_scan_bytes(yystr,strlen(yystr) ,yyscanner); +} + +/** Setup the input buffer state to scan the given bytes. The next call to libconfig_yylex() will + * scan from a @e copy of @a bytes. + * @param yybytes the byte buffer to scan + * @param _yybytes_len the number of bytes in the buffer pointed to by @a bytes. + * @param yyscanner The scanner object. + * @return the newly allocated buffer state object. + */ +YY_BUFFER_STATE libconfig_yy_scan_bytes (yyconst char * yybytes, int _yybytes_len , yyscan_t yyscanner) +{ + YY_BUFFER_STATE b; + char *buf; + yy_size_t n; + int i; + + /* Get memory for full buffer, including space for trailing EOB's. */ + n = _yybytes_len + 2; + buf = (char *) libconfig_yyalloc(n ,yyscanner ); + if ( ! buf ) + YY_FATAL_ERROR( "out of dynamic memory in libconfig_yy_scan_bytes()" ); + + for ( i = 0; i < _yybytes_len; ++i ) + buf[i] = yybytes[i]; + + buf[_yybytes_len] = buf[_yybytes_len+1] = YY_END_OF_BUFFER_CHAR; + + b = libconfig_yy_scan_buffer(buf,n ,yyscanner); + if ( ! b ) + YY_FATAL_ERROR( "bad buffer in libconfig_yy_scan_bytes()" ); + + /* It's okay to grow etc. this buffer, and we should throw it + * away when we're done. + */ + b->yy_is_our_buffer = 1; + + return b; +} + +#ifndef YY_EXIT_FAILURE +#define YY_EXIT_FAILURE 2 +#endif + +static void yy_fatal_error (yyconst char* msg , yyscan_t yyscanner) +{ + (void) fprintf( stderr, "%s\n", msg ); + exit( YY_EXIT_FAILURE ); +} + +/* Redefine yyless() so it works in section 3 code. */ + +#undef yyless +#define yyless(n) \ + do \ + { \ + /* Undo effects of setting up yytext. */ \ + int yyless_macro_arg = (n); \ + YY_LESS_LINENO(yyless_macro_arg);\ + yytext[yyleng] = yyg->yy_hold_char; \ + yyg->yy_c_buf_p = yytext + yyless_macro_arg; \ + yyg->yy_hold_char = *yyg->yy_c_buf_p; \ + *yyg->yy_c_buf_p = '\0'; \ + yyleng = yyless_macro_arg; \ + } \ + while ( 0 ) + +/* Accessor methods (get/set functions) to struct members. */ + +/** Get the user-defined data for this scanner. + * @param yyscanner The scanner object. + */ +YY_EXTRA_TYPE libconfig_yyget_extra (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + return yyextra; +} + +/** Get the current line number. + * @param yyscanner The scanner object. + */ +int libconfig_yyget_lineno (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + + if (! YY_CURRENT_BUFFER) + return 0; + + return yylineno; +} + +/** Get the current column number. + * @param yyscanner The scanner object. + */ +int libconfig_yyget_column (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + + if (! YY_CURRENT_BUFFER) + return 0; + + return yycolumn; +} + +/** Get the input stream. + * @param yyscanner The scanner object. + */ +FILE *libconfig_yyget_in (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + return yyin; +} + +/** Get the output stream. + * @param yyscanner The scanner object. + */ +FILE *libconfig_yyget_out (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + return yyout; +} + +/** Get the length of the current token. + * @param yyscanner The scanner object. + */ +int libconfig_yyget_leng (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + return yyleng; +} + +/** Get the current token. + * @param yyscanner The scanner object. + */ + +char *libconfig_yyget_text (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + return yytext; +} + +/** Set the user-defined data. This data is never touched by the scanner. + * @param user_defined The data to be associated with this scanner. + * @param yyscanner The scanner object. + */ +void libconfig_yyset_extra (YY_EXTRA_TYPE user_defined , yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + yyextra = user_defined ; +} + +/** Set the current line number. + * @param line_number + * @param yyscanner The scanner object. + */ +void libconfig_yyset_lineno (int line_number , yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + + /* lineno is only valid if an input buffer exists. */ + if (! YY_CURRENT_BUFFER ) + yy_fatal_error( "libconfig_yyset_lineno called with no buffer" , yyscanner); + + yylineno = line_number; +} + +/** Set the current column. + * @param line_number + * @param yyscanner The scanner object. + */ +void libconfig_yyset_column (int column_no , yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + + /* column is only valid if an input buffer exists. */ + if (! YY_CURRENT_BUFFER ) + yy_fatal_error( "libconfig_yyset_column called with no buffer" , yyscanner); + + yycolumn = column_no; +} + +/** Set the input stream. This does not discard the current + * input buffer. + * @param in_str A readable stream. + * @param yyscanner The scanner object. + * @see libconfig_yy_switch_to_buffer + */ +void libconfig_yyset_in (FILE * in_str , yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + yyin = in_str ; +} + +void libconfig_yyset_out (FILE * out_str , yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + yyout = out_str ; +} + +int libconfig_yyget_debug (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + return yy_flex_debug; +} + +void libconfig_yyset_debug (int bdebug , yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + yy_flex_debug = bdebug ; +} + +/* Accessor methods for yylval and yylloc */ + +YYSTYPE * libconfig_yyget_lval (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + return yylval; +} + +void libconfig_yyset_lval (YYSTYPE * yylval_param , yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + yylval = yylval_param; +} + +/* User-visible API */ + +/* libconfig_yylex_init is special because it creates the scanner itself, so it is + * the ONLY reentrant function that doesn't take the scanner as the last argument. + * That's why we explicitly handle the declaration, instead of using our macros. + */ + +int libconfig_yylex_init(yyscan_t* ptr_yy_globals) + +{ + if (ptr_yy_globals == NULL){ + errno = EINVAL; + return 1; + } + + *ptr_yy_globals = (yyscan_t) libconfig_yyalloc ( sizeof( struct yyguts_t ), NULL ); + + if (*ptr_yy_globals == NULL){ + errno = ENOMEM; + return 1; + } + + /* By setting to 0xAA, we expose bugs in yy_init_globals. Leave at 0x00 for releases. */ + memset(*ptr_yy_globals,0x00,sizeof(struct yyguts_t)); + + return yy_init_globals ( *ptr_yy_globals ); +} + +/* libconfig_yylex_init_extra has the same functionality as libconfig_yylex_init, but follows the + * convention of taking the scanner as the last argument. Note however, that + * this is a *pointer* to a scanner, as it will be allocated by this call (and + * is the reason, too, why this function also must handle its own declaration). + * The user defined value in the first argument will be available to libconfig_yyalloc in + * the yyextra field. + */ + +int libconfig_yylex_init_extra(YY_EXTRA_TYPE yy_user_defined,yyscan_t* ptr_yy_globals ) + +{ + struct yyguts_t dummy_yyguts; + + libconfig_yyset_extra (yy_user_defined, &dummy_yyguts); + + if (ptr_yy_globals == NULL){ + errno = EINVAL; + return 1; + } + + *ptr_yy_globals = (yyscan_t) libconfig_yyalloc ( sizeof( struct yyguts_t ), &dummy_yyguts ); + + if (*ptr_yy_globals == NULL){ + errno = ENOMEM; + return 1; + } + + /* By setting to 0xAA, we expose bugs in + yy_init_globals. Leave at 0x00 for releases. */ + memset(*ptr_yy_globals,0x00,sizeof(struct yyguts_t)); + + libconfig_yyset_extra (yy_user_defined, *ptr_yy_globals); + + return yy_init_globals ( *ptr_yy_globals ); +} + +static int yy_init_globals (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + /* Initialization is the same as for the non-reentrant scanner. + * This function is called from libconfig_yylex_destroy(), so don't allocate here. + */ + + yyg->yy_buffer_stack = 0; + yyg->yy_buffer_stack_top = 0; + yyg->yy_buffer_stack_max = 0; + yyg->yy_c_buf_p = (char *) 0; + yyg->yy_init = 0; + yyg->yy_start = 0; + + yyg->yy_start_stack_ptr = 0; + yyg->yy_start_stack_depth = 0; + yyg->yy_start_stack = NULL; + +/* Defined in main.c */ +#ifdef YY_STDINIT + yyin = stdin; + yyout = stdout; +#else + yyin = (FILE *) 0; + yyout = (FILE *) 0; +#endif + + /* For future reference: Set errno on error, since we are called by + * libconfig_yylex_init() + */ + return 0; +} + +/* libconfig_yylex_destroy is for both reentrant and non-reentrant scanners. */ +int libconfig_yylex_destroy (yyscan_t yyscanner) +{ + struct yyguts_t * yyg = (struct yyguts_t*)yyscanner; + + /* Pop the buffer stack, destroying each element. */ + while(YY_CURRENT_BUFFER){ + libconfig_yy_delete_buffer(YY_CURRENT_BUFFER ,yyscanner ); + YY_CURRENT_BUFFER_LVALUE = NULL; + libconfig_yypop_buffer_state(yyscanner); + } + + /* Destroy the stack itself. */ + libconfig_yyfree(yyg->yy_buffer_stack ,yyscanner); + yyg->yy_buffer_stack = NULL; + + /* Destroy the start condition stack. */ + libconfig_yyfree(yyg->yy_start_stack ,yyscanner ); + yyg->yy_start_stack = NULL; + + /* Reset the globals. This is important in a non-reentrant scanner so the next time + * libconfig_yylex() is called, initialization will occur. */ + yy_init_globals( yyscanner); + + /* Destroy the main struct (reentrant only). */ + libconfig_yyfree ( yyscanner , yyscanner ); + yyscanner = NULL; + return 0; +} + +/* + * Internal utility routines. + */ + +#ifndef yytext_ptr +static void yy_flex_strncpy (char* s1, yyconst char * s2, int n , yyscan_t yyscanner) +{ + register int i; + for ( i = 0; i < n; ++i ) + s1[i] = s2[i]; +} +#endif + +#ifdef YY_NEED_STRLEN +static int yy_flex_strlen (yyconst char * s , yyscan_t yyscanner) +{ + register int n; + for ( n = 0; s[n]; ++n ) + ; + + return n; +} +#endif + +void *libconfig_yyalloc (yy_size_t size , yyscan_t yyscanner) +{ + return (void *) malloc( size ); +} + +void *libconfig_yyrealloc (void * ptr, yy_size_t size , yyscan_t yyscanner) +{ + /* The cast to (char *) in the following accommodates both + * implementations that use char* generic pointers, and those + * that use void* generic pointers. It works with the latter + * because both ANSI C and C++ allow castless assignment from + * any pointer type to void*, and deal with argument conversions + * as though doing an assignment. + */ + return (void *) realloc( (char *) ptr, size ); +} + +void libconfig_yyfree (void * ptr , yyscan_t yyscanner) +{ + free( (char *) ptr ); /* see libconfig_yyrealloc() for (char *) cast */ +} + +#define YYTABLES_NAME "yytables" + +#line 192 "scanner.l" diff --git a/libconfig-1.4.9/lib/scanner.h b/libconfig-1.4.9/lib/scanner.h new file mode 100644 index 0000000000000000000000000000000000000000..baa6f771fb9ae4a127d6fd688c08c8f8b3b5f47c --- /dev/null +++ b/libconfig-1.4.9/lib/scanner.h @@ -0,0 +1,326 @@ +#ifndef libconfig_yyHEADER_H +#define libconfig_yyHEADER_H 1 +#define libconfig_yyIN_HEADER 1 + +#line 6 "scanner.h" + +#line 8 "scanner.h" + +#define YY_INT_ALIGNED short int + +/* A lexical scanner generated by flex */ + +#define FLEX_SCANNER +#define YY_FLEX_MAJOR_VERSION 2 +#define YY_FLEX_MINOR_VERSION 5 +#define YY_FLEX_SUBMINOR_VERSION 33 +#if YY_FLEX_SUBMINOR_VERSION > 0 +#define FLEX_BETA +#endif + +/* First, we deal with platform-specific or compiler-specific issues. */ + +/* begin standard C headers. */ +#include +#include +#include +#include + +/* end standard C headers. */ + +/* flex integer type definitions */ + +#ifndef FLEXINT_H +#define FLEXINT_H + +/* C99 systems have . Non-C99 systems may or may not. */ + +#if __STDC_VERSION__ >= 199901L + +/* C99 says to define __STDC_LIMIT_MACROS before including stdint.h, + * if you want the limit (max/min) macros for int types. + */ +#ifndef __STDC_LIMIT_MACROS +#define __STDC_LIMIT_MACROS 1 +#endif + +#include +typedef int8_t flex_int8_t; +typedef uint8_t flex_uint8_t; +typedef int16_t flex_int16_t; +typedef uint16_t flex_uint16_t; +typedef int32_t flex_int32_t; +typedef uint32_t flex_uint32_t; +#else +typedef signed char flex_int8_t; +typedef short int flex_int16_t; +typedef int flex_int32_t; +typedef unsigned char flex_uint8_t; +typedef unsigned short int flex_uint16_t; +typedef unsigned int flex_uint32_t; +#endif /* ! C99 */ + +/* Limits of integral types. */ +#ifndef INT8_MIN +#define INT8_MIN (-128) +#endif +#ifndef INT16_MIN +#define INT16_MIN (-32767-1) +#endif +#ifndef INT32_MIN +#define INT32_MIN (-2147483647-1) +#endif +#ifndef INT8_MAX +#define INT8_MAX (127) +#endif +#ifndef INT16_MAX +#define INT16_MAX (32767) +#endif +#ifndef INT32_MAX +#define INT32_MAX (2147483647) +#endif +#ifndef UINT8_MAX +#define UINT8_MAX (255U) +#endif +#ifndef UINT16_MAX +#define UINT16_MAX (65535U) +#endif +#ifndef UINT32_MAX +#define UINT32_MAX (4294967295U) +#endif + +#endif /* ! FLEXINT_H */ + +#ifdef __cplusplus + +/* The "const" storage-class-modifier is valid. */ +#define YY_USE_CONST + +#else /* ! __cplusplus */ + +#if __STDC__ + +#define YY_USE_CONST + +#endif /* __STDC__ */ +#endif /* ! __cplusplus */ + +#ifdef YY_USE_CONST +#define yyconst const +#else +#define yyconst +#endif + +/* An opaque pointer. */ +#ifndef YY_TYPEDEF_YY_SCANNER_T +#define YY_TYPEDEF_YY_SCANNER_T +typedef void* yyscan_t; +#endif + +/* For convenience, these vars (plus the bison vars far below) + are macros in the reentrant scanner. */ +#define yyin yyg->yyin_r +#define yyout yyg->yyout_r +#define yyextra yyg->yyextra_r +#define yyleng yyg->yyleng_r +#define yytext yyg->yytext_r +#define yylineno (YY_CURRENT_BUFFER_LVALUE->yy_bs_lineno) +#define yycolumn (YY_CURRENT_BUFFER_LVALUE->yy_bs_column) +#define yy_flex_debug yyg->yy_flex_debug_r + +int libconfig_yylex_init (yyscan_t* scanner); + +#ifndef YY_TYPEDEF_YY_BUFFER_STATE +#define YY_TYPEDEF_YY_BUFFER_STATE +typedef struct yy_buffer_state *YY_BUFFER_STATE; +#endif + +/* The following is because we cannot portably get our hands on size_t + * (without autoconf's help, which isn't available because we want + * flex-generated scanners to compile on their own). + */ + +#ifndef YY_TYPEDEF_YY_SIZE_T +#define YY_TYPEDEF_YY_SIZE_T +typedef unsigned int yy_size_t; +#endif + +#ifndef YY_STRUCT_YY_BUFFER_STATE +#define YY_STRUCT_YY_BUFFER_STATE +struct yy_buffer_state + { + FILE *yy_input_file; + + char *yy_ch_buf; /* input buffer */ + char *yy_buf_pos; /* current position in input buffer */ + + /* Size of input buffer in bytes, not including room for EOB + * characters. + */ + yy_size_t yy_buf_size; + + /* Number of characters read into yy_ch_buf, not including EOB + * characters. + */ + int yy_n_chars; + + /* Whether we "own" the buffer - i.e., we know we created it, + * and can realloc() it to grow it, and should free() it to + * delete it. + */ + int yy_is_our_buffer; + + /* Whether this is an "interactive" input source; if so, and + * if we're using stdio for input, then we want to use getc() + * instead of fread(), to make sure we stop fetching input after + * each newline. + */ + int yy_is_interactive; + + /* Whether we're considered to be at the beginning of a line. + * If so, '^' rules will be active on the next match, otherwise + * not. + */ + int yy_at_bol; + + int yy_bs_lineno; /**< The line count. */ + int yy_bs_column; /**< The column count. */ + + /* Whether to try to fill the input buffer when we reach the + * end of it. + */ + int yy_fill_buffer; + + int yy_buffer_status; + + }; +#endif /* !YY_STRUCT_YY_BUFFER_STATE */ + +void libconfig_yyrestart (FILE *input_file ,yyscan_t yyscanner ); +void libconfig_yy_switch_to_buffer (YY_BUFFER_STATE new_buffer ,yyscan_t yyscanner ); +YY_BUFFER_STATE libconfig_yy_create_buffer (FILE *file,int size ,yyscan_t yyscanner ); +void libconfig_yy_delete_buffer (YY_BUFFER_STATE b ,yyscan_t yyscanner ); +void libconfig_yy_flush_buffer (YY_BUFFER_STATE b ,yyscan_t yyscanner ); +void libconfig_yypush_buffer_state (YY_BUFFER_STATE new_buffer ,yyscan_t yyscanner ); +void libconfig_yypop_buffer_state (yyscan_t yyscanner ); + +YY_BUFFER_STATE libconfig_yy_scan_buffer (char *base,yy_size_t size ,yyscan_t yyscanner ); +YY_BUFFER_STATE libconfig_yy_scan_string (yyconst char *yy_str ,yyscan_t yyscanner ); +YY_BUFFER_STATE libconfig_yy_scan_bytes (yyconst char *bytes,int len ,yyscan_t yyscanner ); + +void *libconfig_yyalloc (yy_size_t ,yyscan_t yyscanner ); +void *libconfig_yyrealloc (void *,yy_size_t ,yyscan_t yyscanner ); +void libconfig_yyfree (void * ,yyscan_t yyscanner ); + +#define libconfig_yywrap(n) 1 +#define YY_SKIP_YYWRAP + +#define yytext_ptr yytext_r + +#ifdef YY_HEADER_EXPORT_START_CONDITIONS +#define INITIAL 0 +#define COMMENT 1 + +#endif + +#ifndef YY_EXTRA_TYPE +#define YY_EXTRA_TYPE void * +#endif + +/* Accessor methods to globals. + These are made visible to non-reentrant scanners for convenience. */ + +int libconfig_yylex_destroy (yyscan_t yyscanner ); + +int libconfig_yyget_debug (yyscan_t yyscanner ); + +void libconfig_yyset_debug (int debug_flag ,yyscan_t yyscanner ); + +YY_EXTRA_TYPE libconfig_yyget_extra (yyscan_t yyscanner ); + +void libconfig_yyset_extra (YY_EXTRA_TYPE user_defined ,yyscan_t yyscanner ); + +FILE *libconfig_yyget_in (yyscan_t yyscanner ); + +void libconfig_yyset_in (FILE * in_str ,yyscan_t yyscanner ); + +FILE *libconfig_yyget_out (yyscan_t yyscanner ); + +void libconfig_yyset_out (FILE * out_str ,yyscan_t yyscanner ); + +int libconfig_yyget_leng (yyscan_t yyscanner ); + +char *libconfig_yyget_text (yyscan_t yyscanner ); + +int libconfig_yyget_lineno (yyscan_t yyscanner ); + +void libconfig_yyset_lineno (int line_number ,yyscan_t yyscanner ); + +YYSTYPE * libconfig_yyget_lval (yyscan_t yyscanner ); + +void libconfig_yyset_lval (YYSTYPE * yylval_param ,yyscan_t yyscanner ); + +/* Macros after this point can all be overridden by user definitions in + * section 1. + */ + +#ifndef YY_SKIP_YYWRAP +#ifdef __cplusplus +extern "C" int libconfig_yywrap (yyscan_t yyscanner ); +#else +extern int libconfig_yywrap (yyscan_t yyscanner ); +#endif +#endif + +#ifndef yytext_ptr +static void yy_flex_strncpy (char *,yyconst char *,int ,yyscan_t yyscanner); +#endif + +#ifdef YY_NEED_STRLEN +static int yy_flex_strlen (yyconst char * ,yyscan_t yyscanner); +#endif + +#ifndef YY_NO_INPUT + +#endif + +/* Amount of stuff to slurp up with each read. */ +#ifndef YY_READ_BUF_SIZE +#define YY_READ_BUF_SIZE 8192 +#endif + +/* Number of entries by which start-condition stack grows. */ +#ifndef YY_START_STACK_INCR +#define YY_START_STACK_INCR 25 +#endif + +/* Default declaration of generated scanner - a define so the user can + * easily add parameters. + */ +#ifndef YY_DECL +#define YY_DECL_IS_OURS 1 + +extern int libconfig_yylex (YYSTYPE * yylval_param ,yyscan_t yyscanner); + +#define YY_DECL int libconfig_yylex (YYSTYPE * yylval_param , yyscan_t yyscanner) +#endif /* !YY_DECL */ + +/* yy_get_previous_state - get the state just before the EOB char was reached */ + +#undef YY_NEW_FILE +#undef YY_FLUSH_BUFFER +#undef yy_set_bol +#undef yy_new_buffer +#undef yy_set_interactive +#undef YY_DO_BEFORE_ACTION + +#ifdef YY_DECL_IS_OURS +#undef YY_DECL_IS_OURS +#undef YY_DECL +#endif + +#line 130 "scanner.l" + +#line 325 "scanner.h" +#undef libconfig_yyIN_HEADER +#endif /* libconfig_yyHEADER_H */ diff --git a/libconfig-1.4.9/lib/scanner.l b/libconfig-1.4.9/lib/scanner.l new file mode 100644 index 0000000000000000000000000000000000000000..fb467cfb11758348519e45acbcddf26338df671d --- /dev/null +++ b/libconfig-1.4.9/lib/scanner.l @@ -0,0 +1,191 @@ +/* -*- mode: C -*- */ +/* -------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +%option nounistd +%option reentrant +%option noyywrap +%option yylineno +%option nounput +%option bison-bridge +%option header-file="scanner.h" +%option outfile="lex.yy.c" +%option extra-type="struct scan_context *" + +%{ + +#ifdef _MSC_VER +#pragma warning (disable: 4996) +#endif + +#include +#include +#include +#include "grammar.h" +#include "wincompat.h" +#include "parsectx.h" +#include "scanctx.h" + +#define YY_NO_INPUT // Suppress generation of useless input() function + +static unsigned long long fromhex(const char *s) +{ +#ifdef __MINGW32__ + + /* MinGW's strtoull() seems to be broken; it only returns the lower + * 32 bits... + */ + + const char *p = s; + unsigned long long val = 0; + + if(*p != '0') + return(0); + + ++p; + + if(*p != 'x' && *p != 'X') + return(0); + + for(++p; isxdigit(*p); ++p) + { + val <<= 4; + val |= ((*p < 'A') ? (*p & 0xF) : (9 + (*p & 0x7))); + } + + return(val); + +#else /* ! __MINGW32__ */ + + return(strtoull(s, NULL, 16)); + +#endif /* __MINGW32__ */ +} + +%} + +true [Tt][Rr][Uu][Ee] +false [Ff][Aa][Ll][Ss][Ee] +name [A-Za-z\*][-A-Za-z0-9_\*]* +integer [-+]?[0-9]+ +integer64 [-+]?[0-9]+L(L)? +hex 0[Xx][0-9A-Fa-f]+ +hex64 0[Xx][0-9A-Fa-f]+L(L)? +hexchar \\[Xx][0-9A-Fa-f]{2} +float ([-+]?([0-9]*)?\.[0-9]*([eE][-+]?[0-9]+)?)|([-+]?([0-9]+)(\.[0-9]*)?[eE][-+]?[0-9]+) +comment (#|\/\/).*$ +include_open ^[ \t]*@include[ \t]+\" + +%x COMMENT STRING INCLUDE + +%% + +\/\* { BEGIN COMMENT; } +\*\/ { BEGIN INITIAL; } +. { /* ignore */ } +\n { /* ignore */ } + +\" { BEGIN STRING; } +[^\"\\]+ { scanctx_append_string(yyextra, yytext); } +\\n { scanctx_append_string(yyextra, "\n"); } +\\r { scanctx_append_string(yyextra, "\r"); } +\\t { scanctx_append_string(yyextra, "\t"); } +\\f { scanctx_append_string(yyextra, "\f"); } +\\\\ { scanctx_append_string(yyextra, "\\"); } +\\\" { scanctx_append_string(yyextra, "\""); } +{hexchar} { + char c[2] = { (char)(strtol(yytext + 2, NULL, 16) & 0xFF), + 0 }; + scanctx_append_string(yyextra, c); + } +\\ { scanctx_append_string(yyextra, "\\"); } +\" { + yylval->sval = scanctx_take_string(yyextra); + BEGIN INITIAL; + return(TOK_STRING); + } + +{include_open} { BEGIN INCLUDE; } +[^\"\\]+ { scanctx_append_string(yyextra, yytext); } +\\\\ { scanctx_append_string(yyextra, "\\"); } +\\\" { scanctx_append_string(yyextra, "\""); } +\" { + const char *error; + FILE *fp = scanctx_push_include(yyextra, + (void *)YY_CURRENT_BUFFER, + &error); + if(fp) + { + yyin = fp; + yy_switch_to_buffer( + yy_create_buffer(yyin, YY_BUF_SIZE, yyscanner), + yyscanner); + } + else + { + yyextra->config->error_text = error; + yyextra->config->error_file = scanctx_current_filename( + yyextra); + yyextra->config->error_line = libconfig_yyget_lineno( + yyscanner); + return TOK_ERROR; + } + BEGIN INITIAL; + } + +\n|\r|\f { /* ignore */ } +[ \t]+ { /* ignore */ } + +\=|\: { return(TOK_EQUALS); } +, { return(TOK_COMMA); } +\{ { return(TOK_GROUP_START); } +\} { return(TOK_GROUP_END); } +{true} { yylval->ival = 1; return(TOK_BOOLEAN); } +{false} { yylval->ival = 0; return(TOK_BOOLEAN); } +{name} { yylval->sval = yytext; return(TOK_NAME); } +{float} { yylval->fval = atof(yytext); return(TOK_FLOAT); } +{integer} { yylval->ival = atoi(yytext); return(TOK_INTEGER); } +{integer64} { yylval->llval = atoll(yytext); return(TOK_INTEGER64); } +{hex} { + yylval->ival = strtoul(yytext, NULL, 16); + return(TOK_HEX); + } +{hex64} { yylval->llval = fromhex(yytext); return(TOK_HEX64); } +\[ { return(TOK_ARRAY_START); } +\] { return(TOK_ARRAY_END); } +\( { return(TOK_LIST_START); } +\) { return(TOK_LIST_END); } +; { return(TOK_SEMICOLON); } +{comment} { /* ignore */ } +. { return(TOK_GARBAGE); } + +<> { + YY_BUFFER_STATE buf = (YY_BUFFER_STATE)scanctx_pop_include( + yyextra); + if(buf) + { + yy_delete_buffer(YY_CURRENT_BUFFER, yyscanner); + yy_switch_to_buffer(buf, yyscanner); + } + else + yyterminate(); + } diff --git a/libconfig-1.4.9/lib/strbuf.c b/libconfig-1.4.9/lib/strbuf.c new file mode 100644 index 0000000000000000000000000000000000000000..f7f48d3ebde157f33acad2cfb8e27ec93569ca1e --- /dev/null +++ b/libconfig-1.4.9/lib/strbuf.c @@ -0,0 +1,58 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include "strbuf.h" + +#include +#include + +#define STRING_BLOCK_SIZE 64 + +/* ------------------------------------------------------------------------- */ + +char *strbuf_release(strbuf_t *buf) +{ + char *r = buf->string; + memset(buf, 0, sizeof(strbuf_t)); + return(r); +} + +/* ------------------------------------------------------------------------- */ + +void strbuf_append(strbuf_t *buf, const char *text) +{ + static const size_t mask = ~(STRING_BLOCK_SIZE - 1); + size_t len = strlen(text); + size_t newlen = buf->length + len + 1; /* add 1 for NUL */ + + if(newlen > buf->capacity) + { + buf->capacity = (newlen + (STRING_BLOCK_SIZE - 1)) & mask; + buf->string = (char *)realloc(buf->string, buf->capacity); + } + + strcpy(buf->string + buf->length, text); + buf->length += len; +} + +/* ------------------------------------------------------------------------- */ +/* eof */ diff --git a/libconfig-1.4.9/lib/strbuf.h b/libconfig-1.4.9/lib/strbuf.h new file mode 100644 index 0000000000000000000000000000000000000000..62cd782eaadabd3a7e51793025fa303d9b1ae2dd --- /dev/null +++ b/libconfig-1.4.9/lib/strbuf.h @@ -0,0 +1,40 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#ifndef __libconfig_strbuf_h +#define __libconfig_strbuf_h + +#include +#include + +typedef struct +{ + char *string; + size_t length; + size_t capacity; +} strbuf_t; + +char *strbuf_release(strbuf_t *buf); + +void strbuf_append(strbuf_t *buf, const char *text); + +#endif /* __libconfig_strbuf_h */ diff --git a/libconfig-1.4.9/lib/wincompat.h b/libconfig-1.4.9/lib/wincompat.h new file mode 100644 index 0000000000000000000000000000000000000000..23d7379e29df3d138dcb4c4331e0ea58458e50cf --- /dev/null +++ b/libconfig-1.4.9/lib/wincompat.h @@ -0,0 +1,90 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#ifndef __wincompat_h +#define __wincompat_h + +#if defined(WIN32) || defined(_WIN32) || defined(__WIN32__) + +#ifdef _MSC_VER +#pragma warning (disable: 4996) +#endif + +#define WIN32_LEAN_AND_MEAN +#include + +#define snprintf _snprintf + +#ifndef __MINGW32__ +#define atoll _atoi64 +#define strtoull _strtoui64 +#endif /* __MINGW32__ */ + +#endif + +#if (defined(WIN32) || defined(_WIN32) || defined(__WIN32__) \ + || defined(__MINGW32__)) + +/* Why does gcc on MinGW use the Visual C++ style format directives + * for 64-bit integers? Inquiring minds want to know.... + */ + +#define INT64_FMT "%I64d" +#define UINT64_FMT "%I64u" + +#define INT64_HEX_FMT "%I64X" + +#define FILE_SEPARATOR "\\" + +#else /* defined(WIN32) || defined(__MINGW32__) */ + +#define INT64_FMT "%lld" +#define UINT64_FMT "%llu" + +#define INT64_HEX_FMT "%llX" + +#define FILE_SEPARATOR "/" + +#endif /* defined(WIN32) || defined(__MINGW32__) */ + +#if (defined(WIN32) || defined(_WIN32) || defined(__WIN32__)) \ + && ! defined(__MINGW32__) + +#define INT64_CONST(I) (I ## i64) +#define UINT64_CONST(I) (I ## Ui64) + +#ifndef INT32_MAX +#define INT32_MAX (2147483647) +#endif + +#ifndef INT32_MIN +#define INT32_MIN (-2147483647-1) +#endif + +#else /* defined(WIN32) && ! defined(__MINGW32__) */ + +#define INT64_CONST(I) (I ## LL) +#define UINT64_CONST(I) (I ## ULL) + +#endif /* defined(WIN32) && ! defined(__MINGW32__) */ + +#endif /* __wincompat_h */ diff --git a/libconfig-1.4.9/libconfig.sln b/libconfig-1.4.9/libconfig.sln new file mode 100644 index 0000000000000000000000000000000000000000..3b855a8690d2af9612b9eee6f13fd79537e52ee9 --- /dev/null +++ b/libconfig-1.4.9/libconfig.sln @@ -0,0 +1,105 @@ + +Microsoft Visual Studio Solution File, Format Version 10.00 +# Visual Studio 2008 +Project("{8BC9CEB8-8B4A-11D0-8D11-00A0C91BC942}") = "c_example1", "examples\c\example1.vcproj", "{454984C5-C302-4CE2-9B17-15B96E05E120}" + ProjectSection(ProjectDependencies) = postProject + {1A234565-926D-49B2-83E4-D56E0C38C9F2} = {1A234565-926D-49B2-83E4-D56E0C38C9F2} + EndProjectSection +EndProject +Project("{8BC9CEB8-8B4A-11D0-8D11-00A0C91BC942}") = "libconfig", "lib\libconfig.vcproj", "{1A234565-926D-49B2-83E4-D56E0C38C9F2}" +EndProject +Project("{8BC9CEB8-8B4A-11D0-8D11-00A0C91BC942}") = "libconfig++", "lib\libconfig++.vcproj", "{A0C36CE7-D908-4573-8B69-249EEEB7D2BE}" +EndProject +Project("{8BC9CEB8-8B4A-11D0-8D11-00A0C91BC942}") = "c_example2", "examples\c\example2.vcproj", "{E4B1E9C1-E319-4A23-A6EB-85D74AB59BBE}" + ProjectSection(ProjectDependencies) = postProject + {1A234565-926D-49B2-83E4-D56E0C38C9F2} = {1A234565-926D-49B2-83E4-D56E0C38C9F2} + EndProjectSection +EndProject +Project("{8BC9CEB8-8B4A-11D0-8D11-00A0C91BC942}") = "c_example3", "examples\c\example3.vcproj", "{93568409-C7AD-4A32-88E2-8883E10A8F7E}" + ProjectSection(ProjectDependencies) = postProject + {1A234565-926D-49B2-83E4-D56E0C38C9F2} = {1A234565-926D-49B2-83E4-D56E0C38C9F2} + EndProjectSection +EndProject +Project("{8BC9CEB8-8B4A-11D0-8D11-00A0C91BC942}") = "c++_example1", "examples\c++\cxx_example1.vcproj", "{A1DF518C-A515-45A3-9B67-7D49F616DECC}" + ProjectSection(ProjectDependencies) = postProject + {A0C36CE7-D908-4573-8B69-249EEEB7D2BE} = {A0C36CE7-D908-4573-8B69-249EEEB7D2BE} + EndProjectSection +EndProject +Project("{8BC9CEB8-8B4A-11D0-8D11-00A0C91BC942}") = "c++_example2", "examples\c++\cxx_example2.vcproj", "{DEBD09F1-33A1-41A9-9506-BC3E6FD053FD}" + ProjectSection(ProjectDependencies) = postProject + {A0C36CE7-D908-4573-8B69-249EEEB7D2BE} = {A0C36CE7-D908-4573-8B69-249EEEB7D2BE} + EndProjectSection +EndProject +Project("{8BC9CEB8-8B4A-11D0-8D11-00A0C91BC942}") = "c++_example3", "examples\c++\cxx_example3.vcproj", "{8F2C54DE-BCC8-4CC7-81F3-FD0C04E8D5AE}" + ProjectSection(ProjectDependencies) = postProject + {A0C36CE7-D908-4573-8B69-249EEEB7D2BE} = {A0C36CE7-D908-4573-8B69-249EEEB7D2BE} + EndProjectSection +EndProject +Project("{8BC9CEB8-8B4A-11D0-8D11-00A0C91BC942}") = "c++_example4", "examples\c++\cxx_example4.vcproj", "{F631BE25-B384-4061-B7D1-E0C0E77D3A0C}" + ProjectSection(ProjectDependencies) = postProject + {A0C36CE7-D908-4573-8B69-249EEEB7D2BE} = {A0C36CE7-D908-4573-8B69-249EEEB7D2BE} + EndProjectSection +EndProject +Project("{8BC9CEB8-8B4A-11D0-8D11-00A0C91BC942}") = "libtinytest", "tinytest\tinytest.vcproj", "{58F43D41-FE56-40E1-BB83-9CB8CDE0B7AA}" +EndProject +Project("{8BC9CEB8-8B4A-11D0-8D11-00A0C91BC942}") = "libconfig_tests", "tests\tests.vcproj", "{E4FF1E84-9D5A-4A45-A5E5-8B99CA895172}" + ProjectSection(ProjectDependencies) = postProject + {58F43D41-FE56-40E1-BB83-9CB8CDE0B7AA} = {58F43D41-FE56-40E1-BB83-9CB8CDE0B7AA} + {1A234565-926D-49B2-83E4-D56E0C38C9F2} = {1A234565-926D-49B2-83E4-D56E0C38C9F2} + EndProjectSection +EndProject +Global + GlobalSection(SolutionConfigurationPlatforms) = preSolution + Debug|Win32 = Debug|Win32 + Release|Win32 = Release|Win32 + EndGlobalSection + GlobalSection(ProjectConfigurationPlatforms) = postSolution + {454984C5-C302-4CE2-9B17-15B96E05E120}.Debug|Win32.ActiveCfg = Debug|Win32 + {454984C5-C302-4CE2-9B17-15B96E05E120}.Debug|Win32.Build.0 = Debug|Win32 + {454984C5-C302-4CE2-9B17-15B96E05E120}.Release|Win32.ActiveCfg = Release|Win32 + {454984C5-C302-4CE2-9B17-15B96E05E120}.Release|Win32.Build.0 = Release|Win32 + {1A234565-926D-49B2-83E4-D56E0C38C9F2}.Debug|Win32.ActiveCfg = Debug|Win32 + {1A234565-926D-49B2-83E4-D56E0C38C9F2}.Debug|Win32.Build.0 = Debug|Win32 + {1A234565-926D-49B2-83E4-D56E0C38C9F2}.Release|Win32.ActiveCfg = Release|Win32 + {1A234565-926D-49B2-83E4-D56E0C38C9F2}.Release|Win32.Build.0 = Release|Win32 + {A0C36CE7-D908-4573-8B69-249EEEB7D2BE}.Debug|Win32.ActiveCfg = Debug|Win32 + {A0C36CE7-D908-4573-8B69-249EEEB7D2BE}.Debug|Win32.Build.0 = Debug|Win32 + {A0C36CE7-D908-4573-8B69-249EEEB7D2BE}.Release|Win32.ActiveCfg = Release|Win32 + {A0C36CE7-D908-4573-8B69-249EEEB7D2BE}.Release|Win32.Build.0 = Release|Win32 + {E4B1E9C1-E319-4A23-A6EB-85D74AB59BBE}.Debug|Win32.ActiveCfg = Debug|Win32 + {E4B1E9C1-E319-4A23-A6EB-85D74AB59BBE}.Debug|Win32.Build.0 = Debug|Win32 + {E4B1E9C1-E319-4A23-A6EB-85D74AB59BBE}.Release|Win32.ActiveCfg = Release|Win32 + {E4B1E9C1-E319-4A23-A6EB-85D74AB59BBE}.Release|Win32.Build.0 = Release|Win32 + {93568409-C7AD-4A32-88E2-8883E10A8F7E}.Debug|Win32.ActiveCfg = Debug|Win32 + {93568409-C7AD-4A32-88E2-8883E10A8F7E}.Debug|Win32.Build.0 = Debug|Win32 + {93568409-C7AD-4A32-88E2-8883E10A8F7E}.Release|Win32.ActiveCfg = Release|Win32 + {93568409-C7AD-4A32-88E2-8883E10A8F7E}.Release|Win32.Build.0 = Release|Win32 + {A1DF518C-A515-45A3-9B67-7D49F616DECC}.Debug|Win32.ActiveCfg = Debug|Win32 + {A1DF518C-A515-45A3-9B67-7D49F616DECC}.Debug|Win32.Build.0 = Debug|Win32 + {A1DF518C-A515-45A3-9B67-7D49F616DECC}.Release|Win32.ActiveCfg = Release|Win32 + {A1DF518C-A515-45A3-9B67-7D49F616DECC}.Release|Win32.Build.0 = Release|Win32 + {DEBD09F1-33A1-41A9-9506-BC3E6FD053FD}.Debug|Win32.ActiveCfg = Debug|Win32 + {DEBD09F1-33A1-41A9-9506-BC3E6FD053FD}.Debug|Win32.Build.0 = Debug|Win32 + {DEBD09F1-33A1-41A9-9506-BC3E6FD053FD}.Release|Win32.ActiveCfg = Release|Win32 + {DEBD09F1-33A1-41A9-9506-BC3E6FD053FD}.Release|Win32.Build.0 = Release|Win32 + {8F2C54DE-BCC8-4CC7-81F3-FD0C04E8D5AE}.Debug|Win32.ActiveCfg = Debug|Win32 + {8F2C54DE-BCC8-4CC7-81F3-FD0C04E8D5AE}.Debug|Win32.Build.0 = Debug|Win32 + {8F2C54DE-BCC8-4CC7-81F3-FD0C04E8D5AE}.Release|Win32.ActiveCfg = Release|Win32 + {8F2C54DE-BCC8-4CC7-81F3-FD0C04E8D5AE}.Release|Win32.Build.0 = Release|Win32 + {F631BE25-B384-4061-B7D1-E0C0E77D3A0C}.Debug|Win32.ActiveCfg = Debug|Win32 + {F631BE25-B384-4061-B7D1-E0C0E77D3A0C}.Debug|Win32.Build.0 = Debug|Win32 + {F631BE25-B384-4061-B7D1-E0C0E77D3A0C}.Release|Win32.ActiveCfg = Release|Win32 + {F631BE25-B384-4061-B7D1-E0C0E77D3A0C}.Release|Win32.Build.0 = Release|Win32 + {58F43D41-FE56-40E1-BB83-9CB8CDE0B7AA}.Debug|Win32.ActiveCfg = Debug|Win32 + {58F43D41-FE56-40E1-BB83-9CB8CDE0B7AA}.Debug|Win32.Build.0 = Debug|Win32 + {58F43D41-FE56-40E1-BB83-9CB8CDE0B7AA}.Release|Win32.ActiveCfg = Release|Win32 + {58F43D41-FE56-40E1-BB83-9CB8CDE0B7AA}.Release|Win32.Build.0 = Release|Win32 + {E4FF1E84-9D5A-4A45-A5E5-8B99CA895172}.Debug|Win32.ActiveCfg = Debug|Win32 + {E4FF1E84-9D5A-4A45-A5E5-8B99CA895172}.Debug|Win32.Build.0 = Debug|Win32 + {E4FF1E84-9D5A-4A45-A5E5-8B99CA895172}.Release|Win32.ActiveCfg = Release|Win32 + {E4FF1E84-9D5A-4A45-A5E5-8B99CA895172}.Release|Win32.Build.0 = Release|Win32 + EndGlobalSection + GlobalSection(SolutionProperties) = preSolution + HideSolutionNode = FALSE + EndGlobalSection +EndGlobal diff --git a/libconfig-1.4.9/libconfig.spec b/libconfig-1.4.9/libconfig.spec new file mode 100644 index 0000000000000000000000000000000000000000..b1b03d813634ea457c2559398c82f2e52f251834 --- /dev/null +++ b/libconfig-1.4.9/libconfig.spec @@ -0,0 +1,77 @@ +Name: libconfig +Version: 1.4.9 +Release: 1 +Summary: C/C++ Configuration File Library + +Group: System Environment/Libraries +License: LGPL +URL: http://hyperrealm.com/main.php?s=libconfig +Source0: %{name}-%{version}.tar.gz +BuildRoot: %{_tmppath}/%{name}-%{version}-%{release}-root-%(%{__id} -u -n) + +Packager: Deneys S. Maartens + +BuildRequires: texinfo + +%description +%{name} is a simple library for processing structured configuration +files. The file format is more compact and more readable than XML. And +unlike XML, it is type-aware, so it is not necessary to do string +parsing in application code. The library includes bindings for both +the C and C++ languages. It works on POSIX-compliant UNIX systems. + +%package devel +Summary: %{name} development package +Group: Development/Libraries +Requires: %{name} = %{version} + +%description devel +Development files for %{name}. + +%prep +%setup -q + +%build +%configure +make %{?_smp_mflags} +make html + +%install +rm -rf $RPM_BUILD_ROOT +make install DESTDIR=$RPM_BUILD_ROOT + +%clean +rm -rf $RPM_BUILD_ROOT + +%post +ldconfig + +%postun +ldconfig + +%files +%defattr(-,root,root,-) +%doc AUTHORS COPYING.LIB ChangeLog INSTALL NEWS README +%{_libdir}/%{name}.so* +%{_libdir}/%{name}++.so* + +%files devel +%defattr(-,root,root,-) +%doc AUTHORS COPYING.LIB ChangeLog INSTALL NEWS README +%doc doc/%{name}.html +%doc test.cfg +%doc examples/c/*.c +%doc examples/c++/*.cpp +%{_infodir} +%{_includedir} +%{_libdir}/pkgconfig +%{_libdir}/%{name}.a +%{_libdir}/%{name}.la +%{_libdir}/%{name}++.a +%{_libdir}/%{name}++.la + +%changelog +* Wed Aug 19 2007 Deneys S. Maartens 1.1.3-1 +- create spec file + +# -fin- diff --git a/libconfig-1.4.9/libconfig.spec.in b/libconfig-1.4.9/libconfig.spec.in new file mode 100644 index 0000000000000000000000000000000000000000..22edef27b004c870f057b284cfb4791c26d0abe0 --- /dev/null +++ b/libconfig-1.4.9/libconfig.spec.in @@ -0,0 +1,77 @@ +Name: @PACKAGE@ +Version: @VERSION@ +Release: 1 +Summary: C/C++ Configuration File Library + +Group: System Environment/Libraries +License: LGPL +URL: http://hyperrealm.com/main.php?s=libconfig +Source0: %{name}-%{version}.tar.gz +BuildRoot: %{_tmppath}/%{name}-%{version}-%{release}-root-%(%{__id} -u -n) + +Packager: Deneys S. Maartens + +BuildRequires: texinfo + +%description +%{name} is a simple library for processing structured configuration +files. The file format is more compact and more readable than XML. And +unlike XML, it is type-aware, so it is not necessary to do string +parsing in application code. The library includes bindings for both +the C and C++ languages. It works on POSIX-compliant UNIX systems. + +%package devel +Summary: %{name} development package +Group: Development/Libraries +Requires: %{name} = %{version} + +%description devel +Development files for %{name}. + +%prep +%setup -q + +%build +%configure +make %{?_smp_mflags} +make html + +%install +rm -rf $RPM_BUILD_ROOT +make install DESTDIR=$RPM_BUILD_ROOT + +%clean +rm -rf $RPM_BUILD_ROOT + +%post +ldconfig + +%postun +ldconfig + +%files +%defattr(-,root,root,-) +%doc AUTHORS COPYING.LIB ChangeLog INSTALL NEWS README +%{_libdir}/%{name}.so* +%{_libdir}/%{name}++.so* + +%files devel +%defattr(-,root,root,-) +%doc AUTHORS COPYING.LIB ChangeLog INSTALL NEWS README +%doc doc/%{name}.html +%doc test.cfg +%doc examples/c/*.c +%doc examples/c++/*.cpp +%{_infodir} +%{_includedir} +%{_libdir}/pkgconfig +%{_libdir}/%{name}.a +%{_libdir}/%{name}.la +%{_libdir}/%{name}++.a +%{_libdir}/%{name}++.la + +%changelog +* Wed Aug 19 2007 Deneys S. Maartens 1.1.3-1 +- create spec file + +# -fin- diff --git a/libconfig-1.4.9/libtool b/libconfig-1.4.9/libtool new file mode 100755 index 0000000000000000000000000000000000000000..d2b199465974c008d592b6b6695d20a8a82f674a --- /dev/null +++ b/libconfig-1.4.9/libtool @@ -0,0 +1,10243 @@ +#! /bin/sh + +# libtool - Provide generalized library-building support services. +# Generated automatically by config.status (libconfig) 1.4.9 +# Libtool was configured on host timor.sen.cwi.nl: +# NOTE: Changes made to this file will be lost: look at ltmain.sh. +# +# Copyright (C) 1996, 1997, 1998, 1999, 2000, 2001, 2003, 2004, 2005, +# 2006, 2007, 2008, 2009, 2010, 2011 Free Software +# Foundation, Inc. +# Written by Gordon Matzigkeit, 1996 +# +# This file is part of GNU Libtool. +# +# GNU Libtool is free software; you can redistribute it and/or +# modify it under the terms of the GNU General Public License as +# published by the Free Software Foundation; either version 2 of +# the License, or (at your option) any later version. +# +# As a special exception to the GNU General Public License, +# if you distribute this file as part of a program or library that +# is built using GNU Libtool, you may include this file under the +# same distribution terms that you use for the rest of that program. +# +# GNU Libtool is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY; without even the implied warranty of +# MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +# GNU General Public License for more details. +# +# You should have received a copy of the GNU General Public License +# along with GNU Libtool; see the file COPYING. If not, a copy +# can be downloaded from http://www.gnu.org/licenses/gpl.html, or +# obtained by writing to the Free Software Foundation, Inc., +# 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301, USA. + + +# The names of the tagged configurations supported by this script. +available_tags="CXX " + +# ### BEGIN LIBTOOL CONFIG + +# Which release of libtool.m4 was used? +macro_version=2.4.2 +macro_revision=1.3337 + +# Whether or not to build shared libraries. +build_libtool_libs=yes + +# Whether or not to build static libraries. +build_old_libs=yes + +# What type of objects to build. +pic_mode=default + +# Whether or not to optimize for fast installation. +fast_install=yes + +# Shell to use when invoking shell scripts. +SHELL="/bin/sh" + +# An echo program that protects backslashes. +ECHO="printf %s\\n" + +# The PATH separator for the build system. +PATH_SEPARATOR=":" + +# The host system. +host_alias= +host=x86_64-unknown-linux-gnu +host_os=linux-gnu + +# The build system. +build_alias= +build=x86_64-unknown-linux-gnu +build_os=linux-gnu + +# A sed program that does not truncate output. +SED="/usr/bin/sed" + +# Sed that helps us avoid accidentally triggering echo(1) options like -n. +Xsed="$SED -e 1s/^X//" + +# A grep program that handles long lines. +GREP="/usr/bin/grep" + +# An ERE matcher. +EGREP="/usr/bin/grep -E" + +# A literal string matcher. +FGREP="/usr/bin/grep -F" + +# A BSD- or MS-compatible name lister. +NM="/usr/bin/nm -B" + +# Whether we need soft or hard links. +LN_S="ln -s" + +# What is the maximum length of a command? +max_cmd_len=1572864 + +# Object file suffix (normally "o"). +objext=o + +# Executable file suffix (normally ""). +exeext= + +# whether the shell understands "unset". +lt_unset=unset + +# turn spaces into newlines. +SP2NL="tr \\040 \\012" + +# turn newlines into spaces. +NL2SP="tr \\015\\012 \\040\\040" + +# convert $build file names to $host format. +to_host_file_cmd=func_convert_file_noop + +# convert $build files to toolchain format. +to_tool_file_cmd=func_convert_file_noop + +# An object symbol dumper. +OBJDUMP="objdump" + +# Method to check whether dependent libraries are shared objects. +deplibs_check_method="pass_all" + +# Command to use when deplibs_check_method = "file_magic". +file_magic_cmd="\$MAGIC_CMD" + +# How to find potential files when deplibs_check_method = "file_magic". +file_magic_glob="" + +# Find potential files using nocaseglob when deplibs_check_method = "file_magic". +want_nocaseglob="no" + +# DLL creation program. +DLLTOOL="false" + +# Command to associate shared and link libraries. +sharedlib_from_linklib_cmd="printf %s\\n" + +# The archiver. +AR="ar" + +# Flags to create an archive. +AR_FLAGS="cru" + +# How to feed a file listing to the archiver. +archiver_list_spec="@" + +# A symbol stripping program. +STRIP="strip" + +# Commands used to install an old-style archive. +RANLIB="ranlib" +old_postinstall_cmds="chmod 644 \$oldlib~\$RANLIB \$tool_oldlib" +old_postuninstall_cmds="" + +# Whether to use a lock for old archive extraction. +lock_old_archive_extraction=no + +# A C compiler. +LTCC="gcc" + +# LTCC compiler flags. +LTCFLAGS="-g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter" + +# Take the output of nm and produce a listing of raw symbols and C names. +global_symbol_pipe="sed -n -e 's/^.*[ ]\\([ABCDGIRSTW][ABCDGIRSTW]*\\)[ ][ ]*\\([_A-Za-z][_A-Za-z0-9]*\\)\$/\\1 \\2 \\2/p' | sed '/ __gnu_lto/d'" + +# Transform the output of nm in a proper C declaration. +global_symbol_to_cdecl="sed -n -e 's/^T .* \\(.*\\)\$/extern int \\1();/p' -e 's/^[ABCDGIRSTW]* .* \\(.*\\)\$/extern char \\1;/p'" + +# Transform the output of nm in a C name address pair. +global_symbol_to_c_name_address="sed -n -e 's/^: \\([^ ]*\\)[ ]*\$/ {\\\"\\1\\\", (void *) 0},/p' -e 's/^[ABCDGIRSTW]* \\([^ ]*\\) \\([^ ]*\\)\$/ {\"\\2\", (void *) \\&\\2},/p'" + +# Transform the output of nm in a C name address pair when lib prefix is needed. +global_symbol_to_c_name_address_lib_prefix="sed -n -e 's/^: \\([^ ]*\\)[ ]*\$/ {\\\"\\1\\\", (void *) 0},/p' -e 's/^[ABCDGIRSTW]* \\([^ ]*\\) \\(lib[^ ]*\\)\$/ {\"\\2\", (void *) \\&\\2},/p' -e 's/^[ABCDGIRSTW]* \\([^ ]*\\) \\([^ ]*\\)\$/ {\"lib\\2\", (void *) \\&\\2},/p'" + +# Specify filename containing input files for $NM. +nm_file_list_spec="@" + +# The root where to search for dependent libraries,and in which our libraries should be installed. +lt_sysroot= + +# The name of the directory that contains temporary libtool files. +objdir=.libs + +# Used to examine libraries when file_magic_cmd begins with "file". +MAGIC_CMD=file + +# Must we lock files when doing compilation? +need_locks="no" + +# Manifest tool. +MANIFEST_TOOL=":" + +# Tool to manipulate archived DWARF debug symbol files on Mac OS X. +DSYMUTIL="" + +# Tool to change global to local symbols on Mac OS X. +NMEDIT="" + +# Tool to manipulate fat objects and archives on Mac OS X. +LIPO="" + +# ldd/readelf like tool for Mach-O binaries on Mac OS X. +OTOOL="" + +# ldd/readelf like tool for 64 bit Mach-O binaries on Mac OS X 10.4. +OTOOL64="" + +# Old archive suffix (normally "a"). +libext=a + +# Shared library suffix (normally ".so"). +shrext_cmds=".so" + +# The commands to extract the exported symbol list from a shared archive. +extract_expsyms_cmds="" + +# Variables whose values should be saved in libtool wrapper scripts and +# restored at link time. +variables_saved_for_relink="PATH LD_LIBRARY_PATH LD_RUN_PATH GCC_EXEC_PREFIX COMPILER_PATH LIBRARY_PATH" + +# Do we need the "lib" prefix for modules? +need_lib_prefix=no + +# Do we need a version for libraries? +need_version=no + +# Library versioning type. +version_type=linux + +# Shared library runtime path variable. +runpath_var=LD_RUN_PATH + +# Shared library path variable. +shlibpath_var=LD_LIBRARY_PATH + +# Is shlibpath searched before the hard-coded library search path? +shlibpath_overrides_runpath=no + +# Format of library name prefix. +libname_spec="lib\$name" + +# List of archive names. First name is the real one, the rest are links. +# The last name is the one that the linker finds with -lNAME +library_names_spec="\${libname}\${release}\${shared_ext}\$versuffix \${libname}\${release}\${shared_ext}\$major \$libname\${shared_ext}" + +# The coded name of the library, if different from the real name. +soname_spec="\${libname}\${release}\${shared_ext}\$major" + +# Permission mode override for installation of shared libraries. +install_override_mode="" + +# Command to use after installation of a shared archive. +postinstall_cmds="" + +# Command to use after uninstallation of a shared archive. +postuninstall_cmds="" + +# Commands used to finish a libtool library installation in a directory. +finish_cmds="PATH=\\\"\\\$PATH:/sbin\\\" ldconfig -n \$libdir" + +# As "finish_cmds", except a single script fragment to be evaled but +# not shown. +finish_eval="" + +# Whether we should hardcode library paths into libraries. +hardcode_into_libs=yes + +# Compile-time system search path for libraries. +sys_lib_search_path_spec="/usr/lib/gcc/x86_64-redhat-linux/4.8.3 /usr/lib64 /lib64 " + +# Run-time system search path for libraries. +sys_lib_dlsearch_path_spec="/lib /usr/lib /usr/lib64/R/lib /usr/lib64/atlas /usr/lib64/dyninst /usr/lib64/iscsi /usr/lib64/llvm /usr/lib64/mysql /usr/lib64/octave/3.6.4 /usr/lib/qt-3.3/lib /usr/lib64/qt-3.3/lib /usr/lib64/root /usr/lib64/tcl8.5/tclx8.4 /usr/lib64/tcl8.5 /usr/lib64/tracker-0.16 " + +# Whether dlopen is supported. +dlopen_support=unknown + +# Whether dlopen of programs is supported. +dlopen_self=unknown + +# Whether dlopen of statically linked programs is supported. +dlopen_self_static=unknown + +# Commands to strip libraries. +old_striplib="strip --strip-debug" +striplib="strip --strip-unneeded" + +# Assembler program. +AS="as" + + +# The linker used to build libraries. +LD="/usr/bin/ld -m elf_x86_64" + +# How to create reloadable object files. +reload_flag=" -r" +reload_cmds="\$LD\$reload_flag -o \$output\$reload_objs" + +# Commands used to build an old-style archive. +old_archive_cmds="\$AR \$AR_FLAGS \$oldlib\$oldobjs~\$RANLIB \$tool_oldlib" + +# A language specific compiler. +CC="gcc" + +# Is the compiler the GNU compiler? +with_gcc=yes + +# Compiler flag to turn off builtin functions. +no_builtin_flag=" -fno-builtin" + +# Additional compiler flags for building library objects. +pic_flag=" -fPIC -DPIC" + +# How to pass a linker flag through the compiler. +wl="-Wl," + +# Compiler flag to prevent dynamic linking. +link_static_flag="-static" + +# Does compiler simultaneously support -c and -o options? +compiler_c_o="yes" + +# Whether or not to add -lc for building shared libraries. +build_libtool_need_lc=no + +# Whether or not to disallow shared libs when runtime libs are static. +allow_libtool_libs_with_static_runtimes=no + +# Compiler flag to allow reflexive dlopens. +export_dynamic_flag_spec="\${wl}--export-dynamic" + +# Compiler flag to generate shared objects directly from archives. +whole_archive_flag_spec="\${wl}--whole-archive\$convenience \${wl}--no-whole-archive" + +# Whether the compiler copes with passing no objects directly. +compiler_needs_object="no" + +# Create an old-style archive from a shared archive. +old_archive_from_new_cmds="" + +# Create a temporary old-style archive to link instead of a shared archive. +old_archive_from_expsyms_cmds="" + +# Commands used to build a shared archive. +archive_cmds="\$CC -shared \$pic_flag \$libobjs \$deplibs \$compiler_flags \${wl}-soname \$wl\$soname -o \$lib" +archive_expsym_cmds="echo \\\"{ global:\\\" > \$output_objdir/\$libname.ver~ + cat \$export_symbols | sed -e \\\"s/\\\\(.*\\\\)/\\\\1;/\\\" >> \$output_objdir/\$libname.ver~ + echo \\\"local: *; };\\\" >> \$output_objdir/\$libname.ver~ + \$CC -shared \$pic_flag \$libobjs \$deplibs \$compiler_flags \${wl}-soname \$wl\$soname \${wl}-version-script \${wl}\$output_objdir/\$libname.ver -o \$lib" + +# Commands used to build a loadable module if different from building +# a shared archive. +module_cmds="" +module_expsym_cmds="" + +# Whether we are building with GNU ld or not. +with_gnu_ld="yes" + +# Flag that allows shared libraries with undefined symbols to be built. +allow_undefined_flag="" + +# Flag that enforces no undefined symbols. +no_undefined_flag="" + +# Flag to hardcode $libdir into a binary during linking. +# This must work even if $libdir does not exist +hardcode_libdir_flag_spec="\${wl}-rpath \${wl}\$libdir" + +# Whether we need a single "-rpath" flag with a separated argument. +hardcode_libdir_separator="" + +# Set to "yes" if using DIR/libNAME${shared_ext} during linking hardcodes +# DIR into the resulting binary. +hardcode_direct=no + +# Set to "yes" if using DIR/libNAME${shared_ext} during linking hardcodes +# DIR into the resulting binary and the resulting library dependency is +# "absolute",i.e impossible to change by setting ${shlibpath_var} if the +# library is relocated. +hardcode_direct_absolute=no + +# Set to "yes" if using the -LDIR flag during linking hardcodes DIR +# into the resulting binary. +hardcode_minus_L=no + +# Set to "yes" if using SHLIBPATH_VAR=DIR during linking hardcodes DIR +# into the resulting binary. +hardcode_shlibpath_var=unsupported + +# Set to "yes" if building a shared library automatically hardcodes DIR +# into the library and all subsequent libraries and executables linked +# against it. +hardcode_automatic=no + +# Set to yes if linker adds runtime paths of dependent libraries +# to runtime path list. +inherit_rpath=no + +# Whether libtool must link a program against all its dependency libraries. +link_all_deplibs=unknown + +# Set to "yes" if exported symbols are required. +always_export_symbols=no + +# The commands to list exported symbols. +export_symbols_cmds="\$NM \$libobjs \$convenience | \$global_symbol_pipe | \$SED 's/.* //' | sort | uniq > \$export_symbols" + +# Symbols that should not be listed in the preloaded symbols. +exclude_expsyms="_GLOBAL_OFFSET_TABLE_|_GLOBAL__F[ID]_.*" + +# Symbols that must always be exported. +include_expsyms="" + +# Commands necessary for linking programs (against libraries) with templates. +prelink_cmds="" + +# Commands necessary for finishing linking programs. +postlink_cmds="" + +# Specify filename containing input files. +file_list_spec="" + +# How to hardcode a shared library path into an executable. +hardcode_action=immediate + +# The directories searched by this compiler when creating a shared library. +compiler_lib_search_dirs="" + +# Dependencies to place before and after the objects being linked to +# create a shared library. +predep_objects="" +postdep_objects="" +predeps="" +postdeps="" + +# The library search path used internally by the compiler when linking +# a shared library. +compiler_lib_search_path="" + +# ### END LIBTOOL CONFIG + + +# libtool (GNU libtool) 2.4.2 +# Written by Gordon Matzigkeit , 1996 + +# Copyright (C) 1996, 1997, 1998, 1999, 2000, 2001, 2003, 2004, 2005, 2006, +# 2007, 2008, 2009, 2010, 2011 Free Software Foundation, Inc. +# This is free software; see the source for copying conditions. There is NO +# warranty; not even for MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. + +# GNU Libtool is free software; you can redistribute it and/or modify +# it under the terms of the GNU General Public License as published by +# the Free Software Foundation; either version 2 of the License, or +# (at your option) any later version. +# +# As a special exception to the GNU General Public License, +# if you distribute this file as part of a program or library that +# is built using GNU Libtool, you may include this file under the +# same distribution terms that you use for the rest of that program. +# +# GNU Libtool is distributed in the hope that it will be useful, but +# WITHOUT ANY WARRANTY; without even the implied warranty of +# MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU +# General Public License for more details. +# +# You should have received a copy of the GNU General Public License +# along with GNU Libtool; see the file COPYING. If not, a copy +# can be downloaded from http://www.gnu.org/licenses/gpl.html, +# or obtained by writing to the Free Software Foundation, Inc., +# 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301, USA. + +# Usage: $progname [OPTION]... [MODE-ARG]... +# +# Provide generalized library-building support services. +# +# --config show all configuration variables +# --debug enable verbose shell tracing +# -n, --dry-run display commands without modifying any files +# --features display basic configuration information and exit +# --mode=MODE use operation mode MODE +# --preserve-dup-deps don't remove duplicate dependency libraries +# --quiet, --silent don't print informational messages +# --no-quiet, --no-silent +# print informational messages (default) +# --no-warn don't display warning messages +# --tag=TAG use configuration variables from tag TAG +# -v, --verbose print more informational messages than default +# --no-verbose don't print the extra informational messages +# --version print version information +# -h, --help, --help-all print short, long, or detailed help message +# +# MODE must be one of the following: +# +# clean remove files from the build directory +# compile compile a source file into a libtool object +# execute automatically set library path, then run a program +# finish complete the installation of libtool libraries +# install install libraries or executables +# link create a library or an executable +# uninstall remove libraries from an installed directory +# +# MODE-ARGS vary depending on the MODE. When passed as first option, +# `--mode=MODE' may be abbreviated as `MODE' or a unique abbreviation of that. +# Try `$progname --help --mode=MODE' for a more detailed description of MODE. +# +# When reporting a bug, please describe a test case to reproduce it and +# include the following information: +# +# host-triplet: $host +# shell: $SHELL +# compiler: $LTCC +# compiler flags: $LTCFLAGS +# linker: $LD (gnu? $with_gnu_ld) +# $progname: (GNU libtool) 2.4.2 +# automake: $automake_version +# autoconf: $autoconf_version +# +# Report bugs to . +# GNU libtool home page: . +# General help using GNU software: . + +PROGRAM=libtool +PACKAGE=libtool +VERSION=2.4.2 +TIMESTAMP="" +package_revision=1.3337 + +# Be Bourne compatible +if test -n "${ZSH_VERSION+set}" && (emulate sh) >/dev/null 2>&1; then + emulate sh + NULLCMD=: + # Zsh 3.x and 4.x performs word splitting on ${1+"$@"}, which + # is contrary to our usage. Disable this feature. + alias -g '${1+"$@"}'='"$@"' + setopt NO_GLOB_SUBST +else + case `(set -o) 2>/dev/null` in *posix*) set -o posix;; esac +fi +BIN_SH=xpg4; export BIN_SH # for Tru64 +DUALCASE=1; export DUALCASE # for MKS sh + +# A function that is used when there is no print builtin or printf. +func_fallback_echo () +{ + eval 'cat <<_LTECHO_EOF +$1 +_LTECHO_EOF' +} + +# NLS nuisances: We save the old values to restore during execute mode. +lt_user_locale= +lt_safe_locale= +for lt_var in LANG LANGUAGE LC_ALL LC_CTYPE LC_COLLATE LC_MESSAGES +do + eval "if test \"\${$lt_var+set}\" = set; then + save_$lt_var=\$$lt_var + $lt_var=C + export $lt_var + lt_user_locale=\"$lt_var=\\\$save_\$lt_var; \$lt_user_locale\" + lt_safe_locale=\"$lt_var=C; \$lt_safe_locale\" + fi" +done +LC_ALL=C +LANGUAGE=C +export LANGUAGE LC_ALL + +$lt_unset CDPATH + + +# Work around backward compatibility issue on IRIX 6.5. On IRIX 6.4+, sh +# is ksh but when the shell is invoked as "sh" and the current value of +# the _XPG environment variable is not equal to 1 (one), the special +# positional parameter $0, within a function call, is the name of the +# function. +progpath="$0" + + + +: ${CP="cp -f"} +test "${ECHO+set}" = set || ECHO=${as_echo-'printf %s\n'} +: ${MAKE="make"} +: ${MKDIR="mkdir"} +: ${MV="mv -f"} +: ${RM="rm -f"} +: ${SHELL="${CONFIG_SHELL-/bin/sh}"} +: ${Xsed="$SED -e 1s/^X//"} + +# Global variables: +EXIT_SUCCESS=0 +EXIT_FAILURE=1 +EXIT_MISMATCH=63 # $? = 63 is used to indicate version mismatch to missing. +EXIT_SKIP=77 # $? = 77 is used to indicate a skipped test to automake. + +exit_status=$EXIT_SUCCESS + +# Make sure IFS has a sensible default +lt_nl=' +' +IFS=" $lt_nl" + +dirname="s,/[^/]*$,," +basename="s,^.*/,," + +# func_dirname file append nondir_replacement +# Compute the dirname of FILE. If nonempty, add APPEND to the result, +# otherwise set result to NONDIR_REPLACEMENT. +func_dirname () +{ + case ${1} in + */*) func_dirname_result="${1%/*}${2}" ;; + * ) func_dirname_result="${3}" ;; + esac +} # Extended-shell func_dirname implementation + + +# func_basename file +func_basename () +{ + func_basename_result="${1##*/}" +} # Extended-shell func_basename implementation + + +# func_dirname_and_basename file append nondir_replacement +# perform func_basename and func_dirname in a single function +# call: +# dirname: Compute the dirname of FILE. If nonempty, +# add APPEND to the result, otherwise set result +# to NONDIR_REPLACEMENT. +# value returned in "$func_dirname_result" +# basename: Compute filename of FILE. +# value retuned in "$func_basename_result" +# Implementation must be kept synchronized with func_dirname +# and func_basename. For efficiency, we do not delegate to +# those functions but instead duplicate the functionality here. +func_dirname_and_basename () +{ + case ${1} in + */*) func_dirname_result="${1%/*}${2}" ;; + * ) func_dirname_result="${3}" ;; + esac + func_basename_result="${1##*/}" +} # Extended-shell func_dirname_and_basename implementation + + +# func_stripname prefix suffix name +# strip PREFIX and SUFFIX off of NAME. +# PREFIX and SUFFIX must not contain globbing or regex special +# characters, hashes, percent signs, but SUFFIX may contain a leading +# dot (in which case that matches only a dot). +# func_strip_suffix prefix name +func_stripname () +{ + # pdksh 5.2.14 does not do ${X%$Y} correctly if both X and Y are + # positional parameters, so assign one to ordinary parameter first. + func_stripname_result=${3} + func_stripname_result=${func_stripname_result#"${1}"} + func_stripname_result=${func_stripname_result%"${2}"} +} # Extended-shell func_stripname implementation + + +# These SED scripts presuppose an absolute path with a trailing slash. +pathcar='s,^/\([^/]*\).*$,\1,' +pathcdr='s,^/[^/]*,,' +removedotparts=':dotsl + s@/\./@/@g + t dotsl + s,/\.$,/,' +collapseslashes='s@/\{1,\}@/@g' +finalslash='s,/*$,/,' + +# func_normal_abspath PATH +# Remove doubled-up and trailing slashes, "." path components, +# and cancel out any ".." path components in PATH after making +# it an absolute path. +# value returned in "$func_normal_abspath_result" +func_normal_abspath () +{ + # Start from root dir and reassemble the path. + func_normal_abspath_result= + func_normal_abspath_tpath=$1 + func_normal_abspath_altnamespace= + case $func_normal_abspath_tpath in + "") + # Empty path, that just means $cwd. + func_stripname '' '/' "`pwd`" + func_normal_abspath_result=$func_stripname_result + return + ;; + # The next three entries are used to spot a run of precisely + # two leading slashes without using negated character classes; + # we take advantage of case's first-match behaviour. + ///*) + # Unusual form of absolute path, do nothing. + ;; + //*) + # Not necessarily an ordinary path; POSIX reserves leading '//' + # and for example Cygwin uses it to access remote file shares + # over CIFS/SMB, so we conserve a leading double slash if found. + func_normal_abspath_altnamespace=/ + ;; + /*) + # Absolute path, do nothing. + ;; + *) + # Relative path, prepend $cwd. + func_normal_abspath_tpath=`pwd`/$func_normal_abspath_tpath + ;; + esac + # Cancel out all the simple stuff to save iterations. We also want + # the path to end with a slash for ease of parsing, so make sure + # there is one (and only one) here. + func_normal_abspath_tpath=`$ECHO "$func_normal_abspath_tpath" | $SED \ + -e "$removedotparts" -e "$collapseslashes" -e "$finalslash"` + while :; do + # Processed it all yet? + if test "$func_normal_abspath_tpath" = / ; then + # If we ascended to the root using ".." the result may be empty now. + if test -z "$func_normal_abspath_result" ; then + func_normal_abspath_result=/ + fi + break + fi + func_normal_abspath_tcomponent=`$ECHO "$func_normal_abspath_tpath" | $SED \ + -e "$pathcar"` + func_normal_abspath_tpath=`$ECHO "$func_normal_abspath_tpath" | $SED \ + -e "$pathcdr"` + # Figure out what to do with it + case $func_normal_abspath_tcomponent in + "") + # Trailing empty path component, ignore it. + ;; + ..) + # Parent dir; strip last assembled component from result. + func_dirname "$func_normal_abspath_result" + func_normal_abspath_result=$func_dirname_result + ;; + *) + # Actual path component, append it. + func_normal_abspath_result=$func_normal_abspath_result/$func_normal_abspath_tcomponent + ;; + esac + done + # Restore leading double-slash if one was found on entry. + func_normal_abspath_result=$func_normal_abspath_altnamespace$func_normal_abspath_result +} + +# func_relative_path SRCDIR DSTDIR +# generates a relative path from SRCDIR to DSTDIR, with a trailing +# slash if non-empty, suitable for immediately appending a filename +# without needing to append a separator. +# value returned in "$func_relative_path_result" +func_relative_path () +{ + func_relative_path_result= + func_normal_abspath "$1" + func_relative_path_tlibdir=$func_normal_abspath_result + func_normal_abspath "$2" + func_relative_path_tbindir=$func_normal_abspath_result + + # Ascend the tree starting from libdir + while :; do + # check if we have found a prefix of bindir + case $func_relative_path_tbindir in + $func_relative_path_tlibdir) + # found an exact match + func_relative_path_tcancelled= + break + ;; + $func_relative_path_tlibdir*) + # found a matching prefix + func_stripname "$func_relative_path_tlibdir" '' "$func_relative_path_tbindir" + func_relative_path_tcancelled=$func_stripname_result + if test -z "$func_relative_path_result"; then + func_relative_path_result=. + fi + break + ;; + *) + func_dirname $func_relative_path_tlibdir + func_relative_path_tlibdir=${func_dirname_result} + if test "x$func_relative_path_tlibdir" = x ; then + # Have to descend all the way to the root! + func_relative_path_result=../$func_relative_path_result + func_relative_path_tcancelled=$func_relative_path_tbindir + break + fi + func_relative_path_result=../$func_relative_path_result + ;; + esac + done + + # Now calculate path; take care to avoid doubling-up slashes. + func_stripname '' '/' "$func_relative_path_result" + func_relative_path_result=$func_stripname_result + func_stripname '/' '/' "$func_relative_path_tcancelled" + if test "x$func_stripname_result" != x ; then + func_relative_path_result=${func_relative_path_result}/${func_stripname_result} + fi + + # Normalisation. If bindir is libdir, return empty string, + # else relative path ending with a slash; either way, target + # file name can be directly appended. + if test ! -z "$func_relative_path_result"; then + func_stripname './' '' "$func_relative_path_result/" + func_relative_path_result=$func_stripname_result + fi +} + +# The name of this program: +func_dirname_and_basename "$progpath" +progname=$func_basename_result + +# Make sure we have an absolute path for reexecution: +case $progpath in + [\\/]*|[A-Za-z]:\\*) ;; + *[\\/]*) + progdir=$func_dirname_result + progdir=`cd "$progdir" && pwd` + progpath="$progdir/$progname" + ;; + *) + save_IFS="$IFS" + IFS=${PATH_SEPARATOR-:} + for progdir in $PATH; do + IFS="$save_IFS" + test -x "$progdir/$progname" && break + done + IFS="$save_IFS" + test -n "$progdir" || progdir=`pwd` + progpath="$progdir/$progname" + ;; +esac + +# Sed substitution that helps us do robust quoting. It backslashifies +# metacharacters that are still active within double-quoted strings. +Xsed="${SED}"' -e 1s/^X//' +sed_quote_subst='s/\([`"$\\]\)/\\\1/g' + +# Same as above, but do not quote variable references. +double_quote_subst='s/\(["`\\]\)/\\\1/g' + +# Sed substitution that turns a string into a regex matching for the +# string literally. +sed_make_literal_regex='s,[].[^$\\*\/],\\&,g' + +# Sed substitution that converts a w32 file name or path +# which contains forward slashes, into one that contains +# (escaped) backslashes. A very naive implementation. +lt_sed_naive_backslashify='s|\\\\*|\\|g;s|/|\\|g;s|\\|\\\\|g' + +# Re-`\' parameter expansions in output of double_quote_subst that were +# `\'-ed in input to the same. If an odd number of `\' preceded a '$' +# in input to double_quote_subst, that '$' was protected from expansion. +# Since each input `\' is now two `\'s, look for any number of runs of +# four `\'s followed by two `\'s and then a '$'. `\' that '$'. +bs='\\' +bs2='\\\\' +bs4='\\\\\\\\' +dollar='\$' +sed_double_backslash="\ + s/$bs4/&\\ +/g + s/^$bs2$dollar/$bs&/ + s/\\([^$bs]\\)$bs2$dollar/\\1$bs2$bs$dollar/g + s/\n//g" + +# Standard options: +opt_dry_run=false +opt_help=false +opt_quiet=false +opt_verbose=false +opt_warning=: + +# func_echo arg... +# Echo program name prefixed message, along with the current mode +# name if it has been set yet. +func_echo () +{ + $ECHO "$progname: ${opt_mode+$opt_mode: }$*" +} + +# func_verbose arg... +# Echo program name prefixed message in verbose mode only. +func_verbose () +{ + $opt_verbose && func_echo ${1+"$@"} + + # A bug in bash halts the script if the last line of a function + # fails when set -e is in force, so we need another command to + # work around that: + : +} + +# func_echo_all arg... +# Invoke $ECHO with all args, space-separated. +func_echo_all () +{ + $ECHO "$*" +} + +# func_error arg... +# Echo program name prefixed message to standard error. +func_error () +{ + $ECHO "$progname: ${opt_mode+$opt_mode: }"${1+"$@"} 1>&2 +} + +# func_warning arg... +# Echo program name prefixed warning message to standard error. +func_warning () +{ + $opt_warning && $ECHO "$progname: ${opt_mode+$opt_mode: }warning: "${1+"$@"} 1>&2 + + # bash bug again: + : +} + +# func_fatal_error arg... +# Echo program name prefixed message to standard error, and exit. +func_fatal_error () +{ + func_error ${1+"$@"} + exit $EXIT_FAILURE +} + +# func_fatal_help arg... +# Echo program name prefixed message to standard error, followed by +# a help hint, and exit. +func_fatal_help () +{ + func_error ${1+"$@"} + func_fatal_error "$help" +} +help="Try \`$progname --help' for more information." ## default + + +# func_grep expression filename +# Check whether EXPRESSION matches any line of FILENAME, without output. +func_grep () +{ + $GREP "$1" "$2" >/dev/null 2>&1 +} + + +# func_mkdir_p directory-path +# Make sure the entire path to DIRECTORY-PATH is available. +func_mkdir_p () +{ + my_directory_path="$1" + my_dir_list= + + if test -n "$my_directory_path" && test "$opt_dry_run" != ":"; then + + # Protect directory names starting with `-' + case $my_directory_path in + -*) my_directory_path="./$my_directory_path" ;; + esac + + # While some portion of DIR does not yet exist... + while test ! -d "$my_directory_path"; do + # ...make a list in topmost first order. Use a colon delimited + # list incase some portion of path contains whitespace. + my_dir_list="$my_directory_path:$my_dir_list" + + # If the last portion added has no slash in it, the list is done + case $my_directory_path in */*) ;; *) break ;; esac + + # ...otherwise throw away the child directory and loop + my_directory_path=`$ECHO "$my_directory_path" | $SED -e "$dirname"` + done + my_dir_list=`$ECHO "$my_dir_list" | $SED 's,:*$,,'` + + save_mkdir_p_IFS="$IFS"; IFS=':' + for my_dir in $my_dir_list; do + IFS="$save_mkdir_p_IFS" + # mkdir can fail with a `File exist' error if two processes + # try to create one of the directories concurrently. Don't + # stop in that case! + $MKDIR "$my_dir" 2>/dev/null || : + done + IFS="$save_mkdir_p_IFS" + + # Bail out if we (or some other process) failed to create a directory. + test -d "$my_directory_path" || \ + func_fatal_error "Failed to create \`$1'" + fi +} + + +# func_mktempdir [string] +# Make a temporary directory that won't clash with other running +# libtool processes, and avoids race conditions if possible. If +# given, STRING is the basename for that directory. +func_mktempdir () +{ + my_template="${TMPDIR-/tmp}/${1-$progname}" + + if test "$opt_dry_run" = ":"; then + # Return a directory name, but don't create it in dry-run mode + my_tmpdir="${my_template}-$$" + else + + # If mktemp works, use that first and foremost + my_tmpdir=`mktemp -d "${my_template}-XXXXXXXX" 2>/dev/null` + + if test ! -d "$my_tmpdir"; then + # Failing that, at least try and use $RANDOM to avoid a race + my_tmpdir="${my_template}-${RANDOM-0}$$" + + save_mktempdir_umask=`umask` + umask 0077 + $MKDIR "$my_tmpdir" + umask $save_mktempdir_umask + fi + + # If we're not in dry-run mode, bomb out on failure + test -d "$my_tmpdir" || \ + func_fatal_error "cannot create temporary directory \`$my_tmpdir'" + fi + + $ECHO "$my_tmpdir" +} + + +# func_quote_for_eval arg +# Aesthetically quote ARG to be evaled later. +# This function returns two values: FUNC_QUOTE_FOR_EVAL_RESULT +# is double-quoted, suitable for a subsequent eval, whereas +# FUNC_QUOTE_FOR_EVAL_UNQUOTED_RESULT has merely all characters +# which are still active within double quotes backslashified. +func_quote_for_eval () +{ + case $1 in + *[\\\`\"\$]*) + func_quote_for_eval_unquoted_result=`$ECHO "$1" | $SED "$sed_quote_subst"` ;; + *) + func_quote_for_eval_unquoted_result="$1" ;; + esac + + case $func_quote_for_eval_unquoted_result in + # Double-quote args containing shell metacharacters to delay + # word splitting, command substitution and and variable + # expansion for a subsequent eval. + # Many Bourne shells cannot handle close brackets correctly + # in scan sets, so we specify it separately. + *[\[\~\#\^\&\*\(\)\{\}\|\;\<\>\?\'\ \ ]*|*]*|"") + func_quote_for_eval_result="\"$func_quote_for_eval_unquoted_result\"" + ;; + *) + func_quote_for_eval_result="$func_quote_for_eval_unquoted_result" + esac +} + + +# func_quote_for_expand arg +# Aesthetically quote ARG to be evaled later; same as above, +# but do not quote variable references. +func_quote_for_expand () +{ + case $1 in + *[\\\`\"]*) + my_arg=`$ECHO "$1" | $SED \ + -e "$double_quote_subst" -e "$sed_double_backslash"` ;; + *) + my_arg="$1" ;; + esac + + case $my_arg in + # Double-quote args containing shell metacharacters to delay + # word splitting and command substitution for a subsequent eval. + # Many Bourne shells cannot handle close brackets correctly + # in scan sets, so we specify it separately. + *[\[\~\#\^\&\*\(\)\{\}\|\;\<\>\?\'\ \ ]*|*]*|"") + my_arg="\"$my_arg\"" + ;; + esac + + func_quote_for_expand_result="$my_arg" +} + + +# func_show_eval cmd [fail_exp] +# Unless opt_silent is true, then output CMD. Then, if opt_dryrun is +# not true, evaluate CMD. If the evaluation of CMD fails, and FAIL_EXP +# is given, then evaluate it. +func_show_eval () +{ + my_cmd="$1" + my_fail_exp="${2-:}" + + ${opt_silent-false} || { + func_quote_for_expand "$my_cmd" + eval "func_echo $func_quote_for_expand_result" + } + + if ${opt_dry_run-false}; then :; else + eval "$my_cmd" + my_status=$? + if test "$my_status" -eq 0; then :; else + eval "(exit $my_status); $my_fail_exp" + fi + fi +} + + +# func_show_eval_locale cmd [fail_exp] +# Unless opt_silent is true, then output CMD. Then, if opt_dryrun is +# not true, evaluate CMD. If the evaluation of CMD fails, and FAIL_EXP +# is given, then evaluate it. Use the saved locale for evaluation. +func_show_eval_locale () +{ + my_cmd="$1" + my_fail_exp="${2-:}" + + ${opt_silent-false} || { + func_quote_for_expand "$my_cmd" + eval "func_echo $func_quote_for_expand_result" + } + + if ${opt_dry_run-false}; then :; else + eval "$lt_user_locale + $my_cmd" + my_status=$? + eval "$lt_safe_locale" + if test "$my_status" -eq 0; then :; else + eval "(exit $my_status); $my_fail_exp" + fi + fi +} + +# func_tr_sh +# Turn $1 into a string suitable for a shell variable name. +# Result is stored in $func_tr_sh_result. All characters +# not in the set a-zA-Z0-9_ are replaced with '_'. Further, +# if $1 begins with a digit, a '_' is prepended as well. +func_tr_sh () +{ + case $1 in + [0-9]* | *[!a-zA-Z0-9_]*) + func_tr_sh_result=`$ECHO "$1" | $SED 's/^\([0-9]\)/_\1/; s/[^a-zA-Z0-9_]/_/g'` + ;; + * ) + func_tr_sh_result=$1 + ;; + esac +} + + +# func_version +# Echo version message to standard output and exit. +func_version () +{ + $opt_debug + + $SED -n '/(C)/!b go + :more + /\./!{ + N + s/\n# / / + b more + } + :go + /^# '$PROGRAM' (GNU /,/# warranty; / { + s/^# // + s/^# *$// + s/\((C)\)[ 0-9,-]*\( [1-9][0-9]*\)/\1\2/ + p + }' < "$progpath" + exit $? +} + +# func_usage +# Echo short help message to standard output and exit. +func_usage () +{ + $opt_debug + + $SED -n '/^# Usage:/,/^# *.*--help/ { + s/^# // + s/^# *$// + s/\$progname/'$progname'/ + p + }' < "$progpath" + echo + $ECHO "run \`$progname --help | more' for full usage" + exit $? +} + +# func_help [NOEXIT] +# Echo long help message to standard output and exit, +# unless 'noexit' is passed as argument. +func_help () +{ + $opt_debug + + $SED -n '/^# Usage:/,/# Report bugs to/ { + :print + s/^# // + s/^# *$// + s*\$progname*'$progname'* + s*\$host*'"$host"'* + s*\$SHELL*'"$SHELL"'* + s*\$LTCC*'"$LTCC"'* + s*\$LTCFLAGS*'"$LTCFLAGS"'* + s*\$LD*'"$LD"'* + s/\$with_gnu_ld/'"$with_gnu_ld"'/ + s/\$automake_version/'"`(${AUTOMAKE-automake} --version) 2>/dev/null |$SED 1q`"'/ + s/\$autoconf_version/'"`(${AUTOCONF-autoconf} --version) 2>/dev/null |$SED 1q`"'/ + p + d + } + /^# .* home page:/b print + /^# General help using/b print + ' < "$progpath" + ret=$? + if test -z "$1"; then + exit $ret + fi +} + +# func_missing_arg argname +# Echo program name prefixed message to standard error and set global +# exit_cmd. +func_missing_arg () +{ + $opt_debug + + func_error "missing argument for $1." + exit_cmd=exit +} + + +# func_split_short_opt shortopt +# Set func_split_short_opt_name and func_split_short_opt_arg shell +# variables after splitting SHORTOPT after the 2nd character. +func_split_short_opt () +{ + func_split_short_opt_arg=${1#??} + func_split_short_opt_name=${1%"$func_split_short_opt_arg"} +} # Extended-shell func_split_short_opt implementation + + +# func_split_long_opt longopt +# Set func_split_long_opt_name and func_split_long_opt_arg shell +# variables after splitting LONGOPT at the `=' sign. +func_split_long_opt () +{ + func_split_long_opt_name=${1%%=*} + func_split_long_opt_arg=${1#*=} +} # Extended-shell func_split_long_opt implementation + +exit_cmd=: + + + + + +magic="%%%MAGIC variable%%%" +magic_exe="%%%MAGIC EXE variable%%%" + +# Global variables. +nonopt= +preserve_args= +lo2o="s/\\.lo\$/.${objext}/" +o2lo="s/\\.${objext}\$/.lo/" +extracted_archives= +extracted_serial=0 + +# If this variable is set in any of the actions, the command in it +# will be execed at the end. This prevents here-documents from being +# left over by shells. +exec_cmd= + +# func_append var value +# Append VALUE to the end of shell variable VAR. +func_append () +{ + eval "${1}+=\${2}" +} # Extended-shell func_append implementation + +# func_append_quoted var value +# Quote VALUE and append to the end of shell variable VAR, separated +# by a space. +func_append_quoted () +{ + func_quote_for_eval "${2}" + eval "${1}+=\\ \$func_quote_for_eval_result" +} # Extended-shell func_append_quoted implementation + + +# func_arith arithmetic-term... +func_arith () +{ + func_arith_result=$(( $* )) +} # Extended-shell func_arith implementation + + +# func_len string +# STRING may not start with a hyphen. +func_len () +{ + func_len_result=${#1} +} # Extended-shell func_len implementation + + +# func_lo2o object +func_lo2o () +{ + case ${1} in + *.lo) func_lo2o_result=${1%.lo}.${objext} ;; + *) func_lo2o_result=${1} ;; + esac +} # Extended-shell func_lo2o implementation + + +# func_xform libobj-or-source +func_xform () +{ + func_xform_result=${1%.*}.lo +} # Extended-shell func_xform implementation + + +# func_fatal_configuration arg... +# Echo program name prefixed message to standard error, followed by +# a configuration failure hint, and exit. +func_fatal_configuration () +{ + func_error ${1+"$@"} + func_error "See the $PACKAGE documentation for more information." + func_fatal_error "Fatal configuration error." +} + + +# func_config +# Display the configuration for all the tags in this script. +func_config () +{ + re_begincf='^# ### BEGIN LIBTOOL' + re_endcf='^# ### END LIBTOOL' + + # Default configuration. + $SED "1,/$re_begincf CONFIG/d;/$re_endcf CONFIG/,\$d" < "$progpath" + + # Now print the configurations for the tags. + for tagname in $taglist; do + $SED -n "/$re_begincf TAG CONFIG: $tagname\$/,/$re_endcf TAG CONFIG: $tagname\$/p" < "$progpath" + done + + exit $? +} + +# func_features +# Display the features supported by this script. +func_features () +{ + echo "host: $host" + if test "$build_libtool_libs" = yes; then + echo "enable shared libraries" + else + echo "disable shared libraries" + fi + if test "$build_old_libs" = yes; then + echo "enable static libraries" + else + echo "disable static libraries" + fi + + exit $? +} + +# func_enable_tag tagname +# Verify that TAGNAME is valid, and either flag an error and exit, or +# enable the TAGNAME tag. We also add TAGNAME to the global $taglist +# variable here. +func_enable_tag () +{ + # Global variable: + tagname="$1" + + re_begincf="^# ### BEGIN LIBTOOL TAG CONFIG: $tagname\$" + re_endcf="^# ### END LIBTOOL TAG CONFIG: $tagname\$" + sed_extractcf="/$re_begincf/,/$re_endcf/p" + + # Validate tagname. + case $tagname in + *[!-_A-Za-z0-9,/]*) + func_fatal_error "invalid tag name: $tagname" + ;; + esac + + # Don't test for the "default" C tag, as we know it's + # there but not specially marked. + case $tagname in + CC) ;; + *) + if $GREP "$re_begincf" "$progpath" >/dev/null 2>&1; then + taglist="$taglist $tagname" + + # Evaluate the configuration. Be careful to quote the path + # and the sed script, to avoid splitting on whitespace, but + # also don't use non-portable quotes within backquotes within + # quotes we have to do it in 2 steps: + extractedcf=`$SED -n -e "$sed_extractcf" < "$progpath"` + eval "$extractedcf" + else + func_error "ignoring unknown tag $tagname" + fi + ;; + esac +} + +# func_check_version_match +# Ensure that we are using m4 macros, and libtool script from the same +# release of libtool. +func_check_version_match () +{ + if test "$package_revision" != "$macro_revision"; then + if test "$VERSION" != "$macro_version"; then + if test -z "$macro_version"; then + cat >&2 <<_LT_EOF +$progname: Version mismatch error. This is $PACKAGE $VERSION, but the +$progname: definition of this LT_INIT comes from an older release. +$progname: You should recreate aclocal.m4 with macros from $PACKAGE $VERSION +$progname: and run autoconf again. +_LT_EOF + else + cat >&2 <<_LT_EOF +$progname: Version mismatch error. This is $PACKAGE $VERSION, but the +$progname: definition of this LT_INIT comes from $PACKAGE $macro_version. +$progname: You should recreate aclocal.m4 with macros from $PACKAGE $VERSION +$progname: and run autoconf again. +_LT_EOF + fi + else + cat >&2 <<_LT_EOF +$progname: Version mismatch error. This is $PACKAGE $VERSION, revision $package_revision, +$progname: but the definition of this LT_INIT comes from revision $macro_revision. +$progname: You should recreate aclocal.m4 with macros from revision $package_revision +$progname: of $PACKAGE $VERSION and run autoconf again. +_LT_EOF + fi + + exit $EXIT_MISMATCH + fi +} + + +# Shorthand for --mode=foo, only valid as the first argument +case $1 in +clean|clea|cle|cl) + shift; set dummy --mode clean ${1+"$@"}; shift + ;; +compile|compil|compi|comp|com|co|c) + shift; set dummy --mode compile ${1+"$@"}; shift + ;; +execute|execut|execu|exec|exe|ex|e) + shift; set dummy --mode execute ${1+"$@"}; shift + ;; +finish|finis|fini|fin|fi|f) + shift; set dummy --mode finish ${1+"$@"}; shift + ;; +install|instal|insta|inst|ins|in|i) + shift; set dummy --mode install ${1+"$@"}; shift + ;; +link|lin|li|l) + shift; set dummy --mode link ${1+"$@"}; shift + ;; +uninstall|uninstal|uninsta|uninst|unins|unin|uni|un|u) + shift; set dummy --mode uninstall ${1+"$@"}; shift + ;; +esac + + + +# Option defaults: +opt_debug=: +opt_dry_run=false +opt_config=false +opt_preserve_dup_deps=false +opt_features=false +opt_finish=false +opt_help=false +opt_help_all=false +opt_silent=: +opt_warning=: +opt_verbose=: +opt_silent=false +opt_verbose=false + + +# Parse options once, thoroughly. This comes as soon as possible in the +# script to make things like `--version' happen as quickly as we can. +{ + # this just eases exit handling + while test $# -gt 0; do + opt="$1" + shift + case $opt in + --debug|-x) opt_debug='set -x' + func_echo "enabling shell trace mode" + $opt_debug + ;; + --dry-run|--dryrun|-n) + opt_dry_run=: + ;; + --config) + opt_config=: +func_config + ;; + --dlopen|-dlopen) + optarg="$1" + opt_dlopen="${opt_dlopen+$opt_dlopen +}$optarg" + shift + ;; + --preserve-dup-deps) + opt_preserve_dup_deps=: + ;; + --features) + opt_features=: +func_features + ;; + --finish) + opt_finish=: +set dummy --mode finish ${1+"$@"}; shift + ;; + --help) + opt_help=: + ;; + --help-all) + opt_help_all=: +opt_help=': help-all' + ;; + --mode) + test $# = 0 && func_missing_arg $opt && break + optarg="$1" + opt_mode="$optarg" +case $optarg in + # Valid mode arguments: + clean|compile|execute|finish|install|link|relink|uninstall) ;; + + # Catch anything else as an error + *) func_error "invalid argument for $opt" + exit_cmd=exit + break + ;; +esac + shift + ;; + --no-silent|--no-quiet) + opt_silent=false +preserve_args+=" $opt" + ;; + --no-warning|--no-warn) + opt_warning=false +preserve_args+=" $opt" + ;; + --no-verbose) + opt_verbose=false +preserve_args+=" $opt" + ;; + --silent|--quiet) + opt_silent=: +preserve_args+=" $opt" + opt_verbose=false + ;; + --verbose|-v) + opt_verbose=: +preserve_args+=" $opt" +opt_silent=false + ;; + --tag) + test $# = 0 && func_missing_arg $opt && break + optarg="$1" + opt_tag="$optarg" +preserve_args+=" $opt $optarg" +func_enable_tag "$optarg" + shift + ;; + + -\?|-h) func_usage ;; + --help) func_help ;; + --version) func_version ;; + + # Separate optargs to long options: + --*=*) + func_split_long_opt "$opt" + set dummy "$func_split_long_opt_name" "$func_split_long_opt_arg" ${1+"$@"} + shift + ;; + + # Separate non-argument short options: + -\?*|-h*|-n*|-v*) + func_split_short_opt "$opt" + set dummy "$func_split_short_opt_name" "-$func_split_short_opt_arg" ${1+"$@"} + shift + ;; + + --) break ;; + -*) func_fatal_help "unrecognized option \`$opt'" ;; + *) set dummy "$opt" ${1+"$@"}; shift; break ;; + esac + done + + # Validate options: + + # save first non-option argument + if test "$#" -gt 0; then + nonopt="$opt" + shift + fi + + # preserve --debug + test "$opt_debug" = : || preserve_args+=" --debug" + + case $host in + *cygwin* | *mingw* | *pw32* | *cegcc*) + # don't eliminate duplications in $postdeps and $predeps + opt_duplicate_compiler_generated_deps=: + ;; + *) + opt_duplicate_compiler_generated_deps=$opt_preserve_dup_deps + ;; + esac + + $opt_help || { + # Sanity checks first: + func_check_version_match + + if test "$build_libtool_libs" != yes && test "$build_old_libs" != yes; then + func_fatal_configuration "not configured to build any kind of library" + fi + + # Darwin sucks + eval std_shrext=\"$shrext_cmds\" + + # Only execute mode is allowed to have -dlopen flags. + if test -n "$opt_dlopen" && test "$opt_mode" != execute; then + func_error "unrecognized option \`-dlopen'" + $ECHO "$help" 1>&2 + exit $EXIT_FAILURE + fi + + # Change the help message to a mode-specific one. + generic_help="$help" + help="Try \`$progname --help --mode=$opt_mode' for more information." + } + + + # Bail if the options were screwed + $exit_cmd $EXIT_FAILURE +} + + + + +## ----------- ## +## Main. ## +## ----------- ## + +# func_lalib_p file +# True iff FILE is a libtool `.la' library or `.lo' object file. +# This function is only a basic sanity check; it will hardly flush out +# determined imposters. +func_lalib_p () +{ + test -f "$1" && + $SED -e 4q "$1" 2>/dev/null \ + | $GREP "^# Generated by .*$PACKAGE" > /dev/null 2>&1 +} + +# func_lalib_unsafe_p file +# True iff FILE is a libtool `.la' library or `.lo' object file. +# This function implements the same check as func_lalib_p without +# resorting to external programs. To this end, it redirects stdin and +# closes it afterwards, without saving the original file descriptor. +# As a safety measure, use it only where a negative result would be +# fatal anyway. Works if `file' does not exist. +func_lalib_unsafe_p () +{ + lalib_p=no + if test -f "$1" && test -r "$1" && exec 5<&0 <"$1"; then + for lalib_p_l in 1 2 3 4 + do + read lalib_p_line + case "$lalib_p_line" in + \#\ Generated\ by\ *$PACKAGE* ) lalib_p=yes; break;; + esac + done + exec 0<&5 5<&- + fi + test "$lalib_p" = yes +} + +# func_ltwrapper_script_p file +# True iff FILE is a libtool wrapper script +# This function is only a basic sanity check; it will hardly flush out +# determined imposters. +func_ltwrapper_script_p () +{ + func_lalib_p "$1" +} + +# func_ltwrapper_executable_p file +# True iff FILE is a libtool wrapper executable +# This function is only a basic sanity check; it will hardly flush out +# determined imposters. +func_ltwrapper_executable_p () +{ + func_ltwrapper_exec_suffix= + case $1 in + *.exe) ;; + *) func_ltwrapper_exec_suffix=.exe ;; + esac + $GREP "$magic_exe" "$1$func_ltwrapper_exec_suffix" >/dev/null 2>&1 +} + +# func_ltwrapper_scriptname file +# Assumes file is an ltwrapper_executable +# uses $file to determine the appropriate filename for a +# temporary ltwrapper_script. +func_ltwrapper_scriptname () +{ + func_dirname_and_basename "$1" "" "." + func_stripname '' '.exe' "$func_basename_result" + func_ltwrapper_scriptname_result="$func_dirname_result/$objdir/${func_stripname_result}_ltshwrapper" +} + +# func_ltwrapper_p file +# True iff FILE is a libtool wrapper script or wrapper executable +# This function is only a basic sanity check; it will hardly flush out +# determined imposters. +func_ltwrapper_p () +{ + func_ltwrapper_script_p "$1" || func_ltwrapper_executable_p "$1" +} + + +# func_execute_cmds commands fail_cmd +# Execute tilde-delimited COMMANDS. +# If FAIL_CMD is given, eval that upon failure. +# FAIL_CMD may read-access the current command in variable CMD! +func_execute_cmds () +{ + $opt_debug + save_ifs=$IFS; IFS='~' + for cmd in $1; do + IFS=$save_ifs + eval cmd=\"$cmd\" + func_show_eval "$cmd" "${2-:}" + done + IFS=$save_ifs +} + + +# func_source file +# Source FILE, adding directory component if necessary. +# Note that it is not necessary on cygwin/mingw to append a dot to +# FILE even if both FILE and FILE.exe exist: automatic-append-.exe +# behavior happens only for exec(3), not for open(2)! Also, sourcing +# `FILE.' does not work on cygwin managed mounts. +func_source () +{ + $opt_debug + case $1 in + */* | *\\*) . "$1" ;; + *) . "./$1" ;; + esac +} + + +# func_resolve_sysroot PATH +# Replace a leading = in PATH with a sysroot. Store the result into +# func_resolve_sysroot_result +func_resolve_sysroot () +{ + func_resolve_sysroot_result=$1 + case $func_resolve_sysroot_result in + =*) + func_stripname '=' '' "$func_resolve_sysroot_result" + func_resolve_sysroot_result=$lt_sysroot$func_stripname_result + ;; + esac +} + +# func_replace_sysroot PATH +# If PATH begins with the sysroot, replace it with = and +# store the result into func_replace_sysroot_result. +func_replace_sysroot () +{ + case "$lt_sysroot:$1" in + ?*:"$lt_sysroot"*) + func_stripname "$lt_sysroot" '' "$1" + func_replace_sysroot_result="=$func_stripname_result" + ;; + *) + # Including no sysroot. + func_replace_sysroot_result=$1 + ;; + esac +} + +# func_infer_tag arg +# Infer tagged configuration to use if any are available and +# if one wasn't chosen via the "--tag" command line option. +# Only attempt this if the compiler in the base compile +# command doesn't match the default compiler. +# arg is usually of the form 'gcc ...' +func_infer_tag () +{ + $opt_debug + if test -n "$available_tags" && test -z "$tagname"; then + CC_quoted= + for arg in $CC; do + func_append_quoted CC_quoted "$arg" + done + CC_expanded=`func_echo_all $CC` + CC_quoted_expanded=`func_echo_all $CC_quoted` + case $@ in + # Blanks in the command may have been stripped by the calling shell, + # but not from the CC environment variable when configure was run. + " $CC "* | "$CC "* | " $CC_expanded "* | "$CC_expanded "* | \ + " $CC_quoted"* | "$CC_quoted "* | " $CC_quoted_expanded "* | "$CC_quoted_expanded "*) ;; + # Blanks at the start of $base_compile will cause this to fail + # if we don't check for them as well. + *) + for z in $available_tags; do + if $GREP "^# ### BEGIN LIBTOOL TAG CONFIG: $z$" < "$progpath" > /dev/null; then + # Evaluate the configuration. + eval "`${SED} -n -e '/^# ### BEGIN LIBTOOL TAG CONFIG: '$z'$/,/^# ### END LIBTOOL TAG CONFIG: '$z'$/p' < $progpath`" + CC_quoted= + for arg in $CC; do + # Double-quote args containing other shell metacharacters. + func_append_quoted CC_quoted "$arg" + done + CC_expanded=`func_echo_all $CC` + CC_quoted_expanded=`func_echo_all $CC_quoted` + case "$@ " in + " $CC "* | "$CC "* | " $CC_expanded "* | "$CC_expanded "* | \ + " $CC_quoted"* | "$CC_quoted "* | " $CC_quoted_expanded "* | "$CC_quoted_expanded "*) + # The compiler in the base compile command matches + # the one in the tagged configuration. + # Assume this is the tagged configuration we want. + tagname=$z + break + ;; + esac + fi + done + # If $tagname still isn't set, then no tagged configuration + # was found and let the user know that the "--tag" command + # line option must be used. + if test -z "$tagname"; then + func_echo "unable to infer tagged configuration" + func_fatal_error "specify a tag with \`--tag'" +# else +# func_verbose "using $tagname tagged configuration" + fi + ;; + esac + fi +} + + + +# func_write_libtool_object output_name pic_name nonpic_name +# Create a libtool object file (analogous to a ".la" file), +# but don't create it if we're doing a dry run. +func_write_libtool_object () +{ + write_libobj=${1} + if test "$build_libtool_libs" = yes; then + write_lobj=\'${2}\' + else + write_lobj=none + fi + + if test "$build_old_libs" = yes; then + write_oldobj=\'${3}\' + else + write_oldobj=none + fi + + $opt_dry_run || { + cat >${write_libobj}T </dev/null` + if test "$?" -eq 0 && test -n "${func_convert_core_file_wine_to_w32_tmp}"; then + func_convert_core_file_wine_to_w32_result=`$ECHO "$func_convert_core_file_wine_to_w32_tmp" | + $SED -e "$lt_sed_naive_backslashify"` + else + func_convert_core_file_wine_to_w32_result= + fi + fi +} +# end: func_convert_core_file_wine_to_w32 + + +# func_convert_core_path_wine_to_w32 ARG +# Helper function used by path conversion functions when $build is *nix, and +# $host is mingw, cygwin, or some other w32 environment. Relies on a correctly +# configured wine environment available, with the winepath program in $build's +# $PATH. Assumes ARG has no leading or trailing path separator characters. +# +# ARG is path to be converted from $build format to win32. +# Result is available in $func_convert_core_path_wine_to_w32_result. +# Unconvertible file (directory) names in ARG are skipped; if no directory names +# are convertible, then the result may be empty. +func_convert_core_path_wine_to_w32 () +{ + $opt_debug + # unfortunately, winepath doesn't convert paths, only file names + func_convert_core_path_wine_to_w32_result="" + if test -n "$1"; then + oldIFS=$IFS + IFS=: + for func_convert_core_path_wine_to_w32_f in $1; do + IFS=$oldIFS + func_convert_core_file_wine_to_w32 "$func_convert_core_path_wine_to_w32_f" + if test -n "$func_convert_core_file_wine_to_w32_result" ; then + if test -z "$func_convert_core_path_wine_to_w32_result"; then + func_convert_core_path_wine_to_w32_result="$func_convert_core_file_wine_to_w32_result" + else + func_append func_convert_core_path_wine_to_w32_result ";$func_convert_core_file_wine_to_w32_result" + fi + fi + done + IFS=$oldIFS + fi +} +# end: func_convert_core_path_wine_to_w32 + + +# func_cygpath ARGS... +# Wrapper around calling the cygpath program via LT_CYGPATH. This is used when +# when (1) $build is *nix and Cygwin is hosted via a wine environment; or (2) +# $build is MSYS and $host is Cygwin, or (3) $build is Cygwin. In case (1) or +# (2), returns the Cygwin file name or path in func_cygpath_result (input +# file name or path is assumed to be in w32 format, as previously converted +# from $build's *nix or MSYS format). In case (3), returns the w32 file name +# or path in func_cygpath_result (input file name or path is assumed to be in +# Cygwin format). Returns an empty string on error. +# +# ARGS are passed to cygpath, with the last one being the file name or path to +# be converted. +# +# Specify the absolute *nix (or w32) name to cygpath in the LT_CYGPATH +# environment variable; do not put it in $PATH. +func_cygpath () +{ + $opt_debug + if test -n "$LT_CYGPATH" && test -f "$LT_CYGPATH"; then + func_cygpath_result=`$LT_CYGPATH "$@" 2>/dev/null` + if test "$?" -ne 0; then + # on failure, ensure result is empty + func_cygpath_result= + fi + else + func_cygpath_result= + func_error "LT_CYGPATH is empty or specifies non-existent file: \`$LT_CYGPATH'" + fi +} +#end: func_cygpath + + +# func_convert_core_msys_to_w32 ARG +# Convert file name or path ARG from MSYS format to w32 format. Return +# result in func_convert_core_msys_to_w32_result. +func_convert_core_msys_to_w32 () +{ + $opt_debug + # awkward: cmd appends spaces to result + func_convert_core_msys_to_w32_result=`( cmd //c echo "$1" ) 2>/dev/null | + $SED -e 's/[ ]*$//' -e "$lt_sed_naive_backslashify"` +} +#end: func_convert_core_msys_to_w32 + + +# func_convert_file_check ARG1 ARG2 +# Verify that ARG1 (a file name in $build format) was converted to $host +# format in ARG2. Otherwise, emit an error message, but continue (resetting +# func_to_host_file_result to ARG1). +func_convert_file_check () +{ + $opt_debug + if test -z "$2" && test -n "$1" ; then + func_error "Could not determine host file name corresponding to" + func_error " \`$1'" + func_error "Continuing, but uninstalled executables may not work." + # Fallback: + func_to_host_file_result="$1" + fi +} +# end func_convert_file_check + + +# func_convert_path_check FROM_PATHSEP TO_PATHSEP FROM_PATH TO_PATH +# Verify that FROM_PATH (a path in $build format) was converted to $host +# format in TO_PATH. Otherwise, emit an error message, but continue, resetting +# func_to_host_file_result to a simplistic fallback value (see below). +func_convert_path_check () +{ + $opt_debug + if test -z "$4" && test -n "$3"; then + func_error "Could not determine the host path corresponding to" + func_error " \`$3'" + func_error "Continuing, but uninstalled executables may not work." + # Fallback. This is a deliberately simplistic "conversion" and + # should not be "improved". See libtool.info. + if test "x$1" != "x$2"; then + lt_replace_pathsep_chars="s|$1|$2|g" + func_to_host_path_result=`echo "$3" | + $SED -e "$lt_replace_pathsep_chars"` + else + func_to_host_path_result="$3" + fi + fi +} +# end func_convert_path_check + + +# func_convert_path_front_back_pathsep FRONTPAT BACKPAT REPL ORIG +# Modifies func_to_host_path_result by prepending REPL if ORIG matches FRONTPAT +# and appending REPL if ORIG matches BACKPAT. +func_convert_path_front_back_pathsep () +{ + $opt_debug + case $4 in + $1 ) func_to_host_path_result="$3$func_to_host_path_result" + ;; + esac + case $4 in + $2 ) func_to_host_path_result+="$3" + ;; + esac +} +# end func_convert_path_front_back_pathsep + + +################################################## +# $build to $host FILE NAME CONVERSION FUNCTIONS # +################################################## +# invoked via `$to_host_file_cmd ARG' +# +# In each case, ARG is the path to be converted from $build to $host format. +# Result will be available in $func_to_host_file_result. + + +# func_to_host_file ARG +# Converts the file name ARG from $build format to $host format. Return result +# in func_to_host_file_result. +func_to_host_file () +{ + $opt_debug + $to_host_file_cmd "$1" +} +# end func_to_host_file + + +# func_to_tool_file ARG LAZY +# converts the file name ARG from $build format to toolchain format. Return +# result in func_to_tool_file_result. If the conversion in use is listed +# in (the comma separated) LAZY, no conversion takes place. +func_to_tool_file () +{ + $opt_debug + case ,$2, in + *,"$to_tool_file_cmd",*) + func_to_tool_file_result=$1 + ;; + *) + $to_tool_file_cmd "$1" + func_to_tool_file_result=$func_to_host_file_result + ;; + esac +} +# end func_to_tool_file + + +# func_convert_file_noop ARG +# Copy ARG to func_to_host_file_result. +func_convert_file_noop () +{ + func_to_host_file_result="$1" +} +# end func_convert_file_noop + + +# func_convert_file_msys_to_w32 ARG +# Convert file name ARG from (mingw) MSYS to (mingw) w32 format; automatic +# conversion to w32 is not available inside the cwrapper. Returns result in +# func_to_host_file_result. +func_convert_file_msys_to_w32 () +{ + $opt_debug + func_to_host_file_result="$1" + if test -n "$1"; then + func_convert_core_msys_to_w32 "$1" + func_to_host_file_result="$func_convert_core_msys_to_w32_result" + fi + func_convert_file_check "$1" "$func_to_host_file_result" +} +# end func_convert_file_msys_to_w32 + + +# func_convert_file_cygwin_to_w32 ARG +# Convert file name ARG from Cygwin to w32 format. Returns result in +# func_to_host_file_result. +func_convert_file_cygwin_to_w32 () +{ + $opt_debug + func_to_host_file_result="$1" + if test -n "$1"; then + # because $build is cygwin, we call "the" cygpath in $PATH; no need to use + # LT_CYGPATH in this case. + func_to_host_file_result=`cygpath -m "$1"` + fi + func_convert_file_check "$1" "$func_to_host_file_result" +} +# end func_convert_file_cygwin_to_w32 + + +# func_convert_file_nix_to_w32 ARG +# Convert file name ARG from *nix to w32 format. Requires a wine environment +# and a working winepath. Returns result in func_to_host_file_result. +func_convert_file_nix_to_w32 () +{ + $opt_debug + func_to_host_file_result="$1" + if test -n "$1"; then + func_convert_core_file_wine_to_w32 "$1" + func_to_host_file_result="$func_convert_core_file_wine_to_w32_result" + fi + func_convert_file_check "$1" "$func_to_host_file_result" +} +# end func_convert_file_nix_to_w32 + + +# func_convert_file_msys_to_cygwin ARG +# Convert file name ARG from MSYS to Cygwin format. Requires LT_CYGPATH set. +# Returns result in func_to_host_file_result. +func_convert_file_msys_to_cygwin () +{ + $opt_debug + func_to_host_file_result="$1" + if test -n "$1"; then + func_convert_core_msys_to_w32 "$1" + func_cygpath -u "$func_convert_core_msys_to_w32_result" + func_to_host_file_result="$func_cygpath_result" + fi + func_convert_file_check "$1" "$func_to_host_file_result" +} +# end func_convert_file_msys_to_cygwin + + +# func_convert_file_nix_to_cygwin ARG +# Convert file name ARG from *nix to Cygwin format. Requires Cygwin installed +# in a wine environment, working winepath, and LT_CYGPATH set. Returns result +# in func_to_host_file_result. +func_convert_file_nix_to_cygwin () +{ + $opt_debug + func_to_host_file_result="$1" + if test -n "$1"; then + # convert from *nix to w32, then use cygpath to convert from w32 to cygwin. + func_convert_core_file_wine_to_w32 "$1" + func_cygpath -u "$func_convert_core_file_wine_to_w32_result" + func_to_host_file_result="$func_cygpath_result" + fi + func_convert_file_check "$1" "$func_to_host_file_result" +} +# end func_convert_file_nix_to_cygwin + + +############################################# +# $build to $host PATH CONVERSION FUNCTIONS # +############################################# +# invoked via `$to_host_path_cmd ARG' +# +# In each case, ARG is the path to be converted from $build to $host format. +# The result will be available in $func_to_host_path_result. +# +# Path separators are also converted from $build format to $host format. If +# ARG begins or ends with a path separator character, it is preserved (but +# converted to $host format) on output. +# +# All path conversion functions are named using the following convention: +# file name conversion function : func_convert_file_X_to_Y () +# path conversion function : func_convert_path_X_to_Y () +# where, for any given $build/$host combination the 'X_to_Y' value is the +# same. If conversion functions are added for new $build/$host combinations, +# the two new functions must follow this pattern, or func_init_to_host_path_cmd +# will break. + + +# func_init_to_host_path_cmd +# Ensures that function "pointer" variable $to_host_path_cmd is set to the +# appropriate value, based on the value of $to_host_file_cmd. +to_host_path_cmd= +func_init_to_host_path_cmd () +{ + $opt_debug + if test -z "$to_host_path_cmd"; then + func_stripname 'func_convert_file_' '' "$to_host_file_cmd" + to_host_path_cmd="func_convert_path_${func_stripname_result}" + fi +} + + +# func_to_host_path ARG +# Converts the path ARG from $build format to $host format. Return result +# in func_to_host_path_result. +func_to_host_path () +{ + $opt_debug + func_init_to_host_path_cmd + $to_host_path_cmd "$1" +} +# end func_to_host_path + + +# func_convert_path_noop ARG +# Copy ARG to func_to_host_path_result. +func_convert_path_noop () +{ + func_to_host_path_result="$1" +} +# end func_convert_path_noop + + +# func_convert_path_msys_to_w32 ARG +# Convert path ARG from (mingw) MSYS to (mingw) w32 format; automatic +# conversion to w32 is not available inside the cwrapper. Returns result in +# func_to_host_path_result. +func_convert_path_msys_to_w32 () +{ + $opt_debug + func_to_host_path_result="$1" + if test -n "$1"; then + # Remove leading and trailing path separator characters from ARG. MSYS + # behavior is inconsistent here; cygpath turns them into '.;' and ';.'; + # and winepath ignores them completely. + func_stripname : : "$1" + func_to_host_path_tmp1=$func_stripname_result + func_convert_core_msys_to_w32 "$func_to_host_path_tmp1" + func_to_host_path_result="$func_convert_core_msys_to_w32_result" + func_convert_path_check : ";" \ + "$func_to_host_path_tmp1" "$func_to_host_path_result" + func_convert_path_front_back_pathsep ":*" "*:" ";" "$1" + fi +} +# end func_convert_path_msys_to_w32 + + +# func_convert_path_cygwin_to_w32 ARG +# Convert path ARG from Cygwin to w32 format. Returns result in +# func_to_host_file_result. +func_convert_path_cygwin_to_w32 () +{ + $opt_debug + func_to_host_path_result="$1" + if test -n "$1"; then + # See func_convert_path_msys_to_w32: + func_stripname : : "$1" + func_to_host_path_tmp1=$func_stripname_result + func_to_host_path_result=`cygpath -m -p "$func_to_host_path_tmp1"` + func_convert_path_check : ";" \ + "$func_to_host_path_tmp1" "$func_to_host_path_result" + func_convert_path_front_back_pathsep ":*" "*:" ";" "$1" + fi +} +# end func_convert_path_cygwin_to_w32 + + +# func_convert_path_nix_to_w32 ARG +# Convert path ARG from *nix to w32 format. Requires a wine environment and +# a working winepath. Returns result in func_to_host_file_result. +func_convert_path_nix_to_w32 () +{ + $opt_debug + func_to_host_path_result="$1" + if test -n "$1"; then + # See func_convert_path_msys_to_w32: + func_stripname : : "$1" + func_to_host_path_tmp1=$func_stripname_result + func_convert_core_path_wine_to_w32 "$func_to_host_path_tmp1" + func_to_host_path_result="$func_convert_core_path_wine_to_w32_result" + func_convert_path_check : ";" \ + "$func_to_host_path_tmp1" "$func_to_host_path_result" + func_convert_path_front_back_pathsep ":*" "*:" ";" "$1" + fi +} +# end func_convert_path_nix_to_w32 + + +# func_convert_path_msys_to_cygwin ARG +# Convert path ARG from MSYS to Cygwin format. Requires LT_CYGPATH set. +# Returns result in func_to_host_file_result. +func_convert_path_msys_to_cygwin () +{ + $opt_debug + func_to_host_path_result="$1" + if test -n "$1"; then + # See func_convert_path_msys_to_w32: + func_stripname : : "$1" + func_to_host_path_tmp1=$func_stripname_result + func_convert_core_msys_to_w32 "$func_to_host_path_tmp1" + func_cygpath -u -p "$func_convert_core_msys_to_w32_result" + func_to_host_path_result="$func_cygpath_result" + func_convert_path_check : : \ + "$func_to_host_path_tmp1" "$func_to_host_path_result" + func_convert_path_front_back_pathsep ":*" "*:" : "$1" + fi +} +# end func_convert_path_msys_to_cygwin + + +# func_convert_path_nix_to_cygwin ARG +# Convert path ARG from *nix to Cygwin format. Requires Cygwin installed in a +# a wine environment, working winepath, and LT_CYGPATH set. Returns result in +# func_to_host_file_result. +func_convert_path_nix_to_cygwin () +{ + $opt_debug + func_to_host_path_result="$1" + if test -n "$1"; then + # Remove leading and trailing path separator characters from + # ARG. msys behavior is inconsistent here, cygpath turns them + # into '.;' and ';.', and winepath ignores them completely. + func_stripname : : "$1" + func_to_host_path_tmp1=$func_stripname_result + func_convert_core_path_wine_to_w32 "$func_to_host_path_tmp1" + func_cygpath -u -p "$func_convert_core_path_wine_to_w32_result" + func_to_host_path_result="$func_cygpath_result" + func_convert_path_check : : \ + "$func_to_host_path_tmp1" "$func_to_host_path_result" + func_convert_path_front_back_pathsep ":*" "*:" : "$1" + fi +} +# end func_convert_path_nix_to_cygwin + + +# func_mode_compile arg... +func_mode_compile () +{ + $opt_debug + # Get the compilation command and the source file. + base_compile= + srcfile="$nonopt" # always keep a non-empty value in "srcfile" + suppress_opt=yes + suppress_output= + arg_mode=normal + libobj= + later= + pie_flag= + + for arg + do + case $arg_mode in + arg ) + # do not "continue". Instead, add this to base_compile + lastarg="$arg" + arg_mode=normal + ;; + + target ) + libobj="$arg" + arg_mode=normal + continue + ;; + + normal ) + # Accept any command-line options. + case $arg in + -o) + test -n "$libobj" && \ + func_fatal_error "you cannot specify \`-o' more than once" + arg_mode=target + continue + ;; + + -pie | -fpie | -fPIE) + pie_flag+=" $arg" + continue + ;; + + -shared | -static | -prefer-pic | -prefer-non-pic) + later+=" $arg" + continue + ;; + + -no-suppress) + suppress_opt=no + continue + ;; + + -Xcompiler) + arg_mode=arg # the next one goes into the "base_compile" arg list + continue # The current "srcfile" will either be retained or + ;; # replaced later. I would guess that would be a bug. + + -Wc,*) + func_stripname '-Wc,' '' "$arg" + args=$func_stripname_result + lastarg= + save_ifs="$IFS"; IFS=',' + for arg in $args; do + IFS="$save_ifs" + func_append_quoted lastarg "$arg" + done + IFS="$save_ifs" + func_stripname ' ' '' "$lastarg" + lastarg=$func_stripname_result + + # Add the arguments to base_compile. + base_compile+=" $lastarg" + continue + ;; + + *) + # Accept the current argument as the source file. + # The previous "srcfile" becomes the current argument. + # + lastarg="$srcfile" + srcfile="$arg" + ;; + esac # case $arg + ;; + esac # case $arg_mode + + # Aesthetically quote the previous argument. + func_append_quoted base_compile "$lastarg" + done # for arg + + case $arg_mode in + arg) + func_fatal_error "you must specify an argument for -Xcompile" + ;; + target) + func_fatal_error "you must specify a target with \`-o'" + ;; + *) + # Get the name of the library object. + test -z "$libobj" && { + func_basename "$srcfile" + libobj="$func_basename_result" + } + ;; + esac + + # Recognize several different file suffixes. + # If the user specifies -o file.o, it is replaced with file.lo + case $libobj in + *.[cCFSifmso] | \ + *.ada | *.adb | *.ads | *.asm | \ + *.c++ | *.cc | *.ii | *.class | *.cpp | *.cxx | \ + *.[fF][09]? | *.for | *.java | *.go | *.obj | *.sx | *.cu | *.cup) + func_xform "$libobj" + libobj=$func_xform_result + ;; + esac + + case $libobj in + *.lo) func_lo2o "$libobj"; obj=$func_lo2o_result ;; + *) + func_fatal_error "cannot determine name of library object from \`$libobj'" + ;; + esac + + func_infer_tag $base_compile + + for arg in $later; do + case $arg in + -shared) + test "$build_libtool_libs" != yes && \ + func_fatal_configuration "can not build a shared library" + build_old_libs=no + continue + ;; + + -static) + build_libtool_libs=no + build_old_libs=yes + continue + ;; + + -prefer-pic) + pic_mode=yes + continue + ;; + + -prefer-non-pic) + pic_mode=no + continue + ;; + esac + done + + func_quote_for_eval "$libobj" + test "X$libobj" != "X$func_quote_for_eval_result" \ + && $ECHO "X$libobj" | $GREP '[]~#^*{};<>?"'"'"' &()|`$[]' \ + && func_warning "libobj name \`$libobj' may not contain shell special characters." + func_dirname_and_basename "$obj" "/" "" + objname="$func_basename_result" + xdir="$func_dirname_result" + lobj=${xdir}$objdir/$objname + + test -z "$base_compile" && \ + func_fatal_help "you must specify a compilation command" + + # Delete any leftover library objects. + if test "$build_old_libs" = yes; then + removelist="$obj $lobj $libobj ${libobj}T" + else + removelist="$lobj $libobj ${libobj}T" + fi + + # On Cygwin there's no "real" PIC flag so we must build both object types + case $host_os in + cygwin* | mingw* | pw32* | os2* | cegcc*) + pic_mode=default + ;; + esac + if test "$pic_mode" = no && test "$deplibs_check_method" != pass_all; then + # non-PIC code in shared libraries is not supported + pic_mode=default + fi + + # Calculate the filename of the output object if compiler does + # not support -o with -c + if test "$compiler_c_o" = no; then + output_obj=`$ECHO "$srcfile" | $SED 's%^.*/%%; s%\.[^.]*$%%'`.${objext} + lockfile="$output_obj.lock" + else + output_obj= + need_locks=no + lockfile= + fi + + # Lock this critical section if it is needed + # We use this script file to make the link, it avoids creating a new file + if test "$need_locks" = yes; then + until $opt_dry_run || ln "$progpath" "$lockfile" 2>/dev/null; do + func_echo "Waiting for $lockfile to be removed" + sleep 2 + done + elif test "$need_locks" = warn; then + if test -f "$lockfile"; then + $ECHO "\ +*** ERROR, $lockfile exists and contains: +`cat $lockfile 2>/dev/null` + +This indicates that another process is trying to use the same +temporary object file, and libtool could not work around it because +your compiler does not support \`-c' and \`-o' together. If you +repeat this compilation, it may succeed, by chance, but you had better +avoid parallel builds (make -j) in this platform, or get a better +compiler." + + $opt_dry_run || $RM $removelist + exit $EXIT_FAILURE + fi + removelist+=" $output_obj" + $ECHO "$srcfile" > "$lockfile" + fi + + $opt_dry_run || $RM $removelist + removelist+=" $lockfile" + trap '$opt_dry_run || $RM $removelist; exit $EXIT_FAILURE' 1 2 15 + + func_to_tool_file "$srcfile" func_convert_file_msys_to_w32 + srcfile=$func_to_tool_file_result + func_quote_for_eval "$srcfile" + qsrcfile=$func_quote_for_eval_result + + # Only build a PIC object if we are building libtool libraries. + if test "$build_libtool_libs" = yes; then + # Without this assignment, base_compile gets emptied. + fbsd_hideous_sh_bug=$base_compile + + if test "$pic_mode" != no; then + command="$base_compile $qsrcfile $pic_flag" + else + # Don't build PIC code + command="$base_compile $qsrcfile" + fi + + func_mkdir_p "$xdir$objdir" + + if test -z "$output_obj"; then + # Place PIC objects in $objdir + command+=" -o $lobj" + fi + + func_show_eval_locale "$command" \ + 'test -n "$output_obj" && $RM $removelist; exit $EXIT_FAILURE' + + if test "$need_locks" = warn && + test "X`cat $lockfile 2>/dev/null`" != "X$srcfile"; then + $ECHO "\ +*** ERROR, $lockfile contains: +`cat $lockfile 2>/dev/null` + +but it should contain: +$srcfile + +This indicates that another process is trying to use the same +temporary object file, and libtool could not work around it because +your compiler does not support \`-c' and \`-o' together. If you +repeat this compilation, it may succeed, by chance, but you had better +avoid parallel builds (make -j) in this platform, or get a better +compiler." + + $opt_dry_run || $RM $removelist + exit $EXIT_FAILURE + fi + + # Just move the object if needed, then go on to compile the next one + if test -n "$output_obj" && test "X$output_obj" != "X$lobj"; then + func_show_eval '$MV "$output_obj" "$lobj"' \ + 'error=$?; $opt_dry_run || $RM $removelist; exit $error' + fi + + # Allow error messages only from the first compilation. + if test "$suppress_opt" = yes; then + suppress_output=' >/dev/null 2>&1' + fi + fi + + # Only build a position-dependent object if we build old libraries. + if test "$build_old_libs" = yes; then + if test "$pic_mode" != yes; then + # Don't build PIC code + command="$base_compile $qsrcfile$pie_flag" + else + command="$base_compile $qsrcfile $pic_flag" + fi + if test "$compiler_c_o" = yes; then + command+=" -o $obj" + fi + + # Suppress compiler output if we already did a PIC compilation. + command+="$suppress_output" + func_show_eval_locale "$command" \ + '$opt_dry_run || $RM $removelist; exit $EXIT_FAILURE' + + if test "$need_locks" = warn && + test "X`cat $lockfile 2>/dev/null`" != "X$srcfile"; then + $ECHO "\ +*** ERROR, $lockfile contains: +`cat $lockfile 2>/dev/null` + +but it should contain: +$srcfile + +This indicates that another process is trying to use the same +temporary object file, and libtool could not work around it because +your compiler does not support \`-c' and \`-o' together. If you +repeat this compilation, it may succeed, by chance, but you had better +avoid parallel builds (make -j) in this platform, or get a better +compiler." + + $opt_dry_run || $RM $removelist + exit $EXIT_FAILURE + fi + + # Just move the object if needed + if test -n "$output_obj" && test "X$output_obj" != "X$obj"; then + func_show_eval '$MV "$output_obj" "$obj"' \ + 'error=$?; $opt_dry_run || $RM $removelist; exit $error' + fi + fi + + $opt_dry_run || { + func_write_libtool_object "$libobj" "$objdir/$objname" "$objname" + + # Unlock the critical section if it was locked + if test "$need_locks" != no; then + removelist=$lockfile + $RM "$lockfile" + fi + } + + exit $EXIT_SUCCESS +} + +$opt_help || { + test "$opt_mode" = compile && func_mode_compile ${1+"$@"} +} + +func_mode_help () +{ + # We need to display help for each of the modes. + case $opt_mode in + "") + # Generic help is extracted from the usage comments + # at the start of this file. + func_help + ;; + + clean) + $ECHO \ +"Usage: $progname [OPTION]... --mode=clean RM [RM-OPTION]... FILE... + +Remove files from the build directory. + +RM is the name of the program to use to delete files associated with each FILE +(typically \`/bin/rm'). RM-OPTIONS are options (such as \`-f') to be passed +to RM. + +If FILE is a libtool library, object or program, all the files associated +with it are deleted. Otherwise, only FILE itself is deleted using RM." + ;; + + compile) + $ECHO \ +"Usage: $progname [OPTION]... --mode=compile COMPILE-COMMAND... SOURCEFILE + +Compile a source file into a libtool library object. + +This mode accepts the following additional options: + + -o OUTPUT-FILE set the output file name to OUTPUT-FILE + -no-suppress do not suppress compiler output for multiple passes + -prefer-pic try to build PIC objects only + -prefer-non-pic try to build non-PIC objects only + -shared do not build a \`.o' file suitable for static linking + -static only build a \`.o' file suitable for static linking + -Wc,FLAG pass FLAG directly to the compiler + +COMPILE-COMMAND is a command to be used in creating a \`standard' object file +from the given SOURCEFILE. + +The output file name is determined by removing the directory component from +SOURCEFILE, then substituting the C source code suffix \`.c' with the +library object suffix, \`.lo'." + ;; + + execute) + $ECHO \ +"Usage: $progname [OPTION]... --mode=execute COMMAND [ARGS]... + +Automatically set library path, then run a program. + +This mode accepts the following additional options: + + -dlopen FILE add the directory containing FILE to the library path + +This mode sets the library path environment variable according to \`-dlopen' +flags. + +If any of the ARGS are libtool executable wrappers, then they are translated +into their corresponding uninstalled binary, and any of their required library +directories are added to the library path. + +Then, COMMAND is executed, with ARGS as arguments." + ;; + + finish) + $ECHO \ +"Usage: $progname [OPTION]... --mode=finish [LIBDIR]... + +Complete the installation of libtool libraries. + +Each LIBDIR is a directory that contains libtool libraries. + +The commands that this mode executes may require superuser privileges. Use +the \`--dry-run' option if you just want to see what would be executed." + ;; + + install) + $ECHO \ +"Usage: $progname [OPTION]... --mode=install INSTALL-COMMAND... + +Install executables or libraries. + +INSTALL-COMMAND is the installation command. The first component should be +either the \`install' or \`cp' program. + +The following components of INSTALL-COMMAND are treated specially: + + -inst-prefix-dir PREFIX-DIR Use PREFIX-DIR as a staging area for installation + +The rest of the components are interpreted as arguments to that command (only +BSD-compatible install options are recognized)." + ;; + + link) + $ECHO \ +"Usage: $progname [OPTION]... --mode=link LINK-COMMAND... + +Link object files or libraries together to form another library, or to +create an executable program. + +LINK-COMMAND is a command using the C compiler that you would use to create +a program from several object files. + +The following components of LINK-COMMAND are treated specially: + + -all-static do not do any dynamic linking at all + -avoid-version do not add a version suffix if possible + -bindir BINDIR specify path to binaries directory (for systems where + libraries must be found in the PATH setting at runtime) + -dlopen FILE \`-dlpreopen' FILE if it cannot be dlopened at runtime + -dlpreopen FILE link in FILE and add its symbols to lt_preloaded_symbols + -export-dynamic allow symbols from OUTPUT-FILE to be resolved with dlsym(3) + -export-symbols SYMFILE + try to export only the symbols listed in SYMFILE + -export-symbols-regex REGEX + try to export only the symbols matching REGEX + -LLIBDIR search LIBDIR for required installed libraries + -lNAME OUTPUT-FILE requires the installed library libNAME + -module build a library that can dlopened + -no-fast-install disable the fast-install mode + -no-install link a not-installable executable + -no-undefined declare that a library does not refer to external symbols + -o OUTPUT-FILE create OUTPUT-FILE from the specified objects + -objectlist FILE Use a list of object files found in FILE to specify objects + -precious-files-regex REGEX + don't remove output files matching REGEX + -release RELEASE specify package release information + -rpath LIBDIR the created library will eventually be installed in LIBDIR + -R[ ]LIBDIR add LIBDIR to the runtime path of programs and libraries + -shared only do dynamic linking of libtool libraries + -shrext SUFFIX override the standard shared library file extension + -static do not do any dynamic linking of uninstalled libtool libraries + -static-libtool-libs + do not do any dynamic linking of libtool libraries + -version-info CURRENT[:REVISION[:AGE]] + specify library version info [each variable defaults to 0] + -weak LIBNAME declare that the target provides the LIBNAME interface + -Wc,FLAG + -Xcompiler FLAG pass linker-specific FLAG directly to the compiler + -Wl,FLAG + -Xlinker FLAG pass linker-specific FLAG directly to the linker + -XCClinker FLAG pass link-specific FLAG to the compiler driver (CC) + +All other options (arguments beginning with \`-') are ignored. + +Every other argument is treated as a filename. Files ending in \`.la' are +treated as uninstalled libtool libraries, other files are standard or library +object files. + +If the OUTPUT-FILE ends in \`.la', then a libtool library is created, +only library objects (\`.lo' files) may be specified, and \`-rpath' is +required, except when creating a convenience library. + +If OUTPUT-FILE ends in \`.a' or \`.lib', then a standard library is created +using \`ar' and \`ranlib', or on Windows using \`lib'. + +If OUTPUT-FILE ends in \`.lo' or \`.${objext}', then a reloadable object file +is created, otherwise an executable program is created." + ;; + + uninstall) + $ECHO \ +"Usage: $progname [OPTION]... --mode=uninstall RM [RM-OPTION]... FILE... + +Remove libraries from an installation directory. + +RM is the name of the program to use to delete files associated with each FILE +(typically \`/bin/rm'). RM-OPTIONS are options (such as \`-f') to be passed +to RM. + +If FILE is a libtool library, all the files associated with it are deleted. +Otherwise, only FILE itself is deleted using RM." + ;; + + *) + func_fatal_help "invalid operation mode \`$opt_mode'" + ;; + esac + + echo + $ECHO "Try \`$progname --help' for more information about other modes." +} + +# Now that we've collected a possible --mode arg, show help if necessary +if $opt_help; then + if test "$opt_help" = :; then + func_mode_help + else + { + func_help noexit + for opt_mode in compile link execute install finish uninstall clean; do + func_mode_help + done + } | sed -n '1p; 2,$s/^Usage:/ or: /p' + { + func_help noexit + for opt_mode in compile link execute install finish uninstall clean; do + echo + func_mode_help + done + } | + sed '1d + /^When reporting/,/^Report/{ + H + d + } + $x + /information about other modes/d + /more detailed .*MODE/d + s/^Usage:.*--mode=\([^ ]*\) .*/Description of \1 mode:/' + fi + exit $? +fi + + +# func_mode_execute arg... +func_mode_execute () +{ + $opt_debug + # The first argument is the command name. + cmd="$nonopt" + test -z "$cmd" && \ + func_fatal_help "you must specify a COMMAND" + + # Handle -dlopen flags immediately. + for file in $opt_dlopen; do + test -f "$file" \ + || func_fatal_help "\`$file' is not a file" + + dir= + case $file in + *.la) + func_resolve_sysroot "$file" + file=$func_resolve_sysroot_result + + # Check to see that this really is a libtool archive. + func_lalib_unsafe_p "$file" \ + || func_fatal_help "\`$lib' is not a valid libtool archive" + + # Read the libtool library. + dlname= + library_names= + func_source "$file" + + # Skip this library if it cannot be dlopened. + if test -z "$dlname"; then + # Warn if it was a shared library. + test -n "$library_names" && \ + func_warning "\`$file' was not linked with \`-export-dynamic'" + continue + fi + + func_dirname "$file" "" "." + dir="$func_dirname_result" + + if test -f "$dir/$objdir/$dlname"; then + dir+="/$objdir" + else + if test ! -f "$dir/$dlname"; then + func_fatal_error "cannot find \`$dlname' in \`$dir' or \`$dir/$objdir'" + fi + fi + ;; + + *.lo) + # Just add the directory containing the .lo file. + func_dirname "$file" "" "." + dir="$func_dirname_result" + ;; + + *) + func_warning "\`-dlopen' is ignored for non-libtool libraries and objects" + continue + ;; + esac + + # Get the absolute pathname. + absdir=`cd "$dir" && pwd` + test -n "$absdir" && dir="$absdir" + + # Now add the directory to shlibpath_var. + if eval "test -z \"\$$shlibpath_var\""; then + eval "$shlibpath_var=\"\$dir\"" + else + eval "$shlibpath_var=\"\$dir:\$$shlibpath_var\"" + fi + done + + # This variable tells wrapper scripts just to set shlibpath_var + # rather than running their programs. + libtool_execute_magic="$magic" + + # Check if any of the arguments is a wrapper script. + args= + for file + do + case $file in + -* | *.la | *.lo ) ;; + *) + # Do a test to see if this is really a libtool program. + if func_ltwrapper_script_p "$file"; then + func_source "$file" + # Transform arg to wrapped name. + file="$progdir/$program" + elif func_ltwrapper_executable_p "$file"; then + func_ltwrapper_scriptname "$file" + func_source "$func_ltwrapper_scriptname_result" + # Transform arg to wrapped name. + file="$progdir/$program" + fi + ;; + esac + # Quote arguments (to preserve shell metacharacters). + func_append_quoted args "$file" + done + + if test "X$opt_dry_run" = Xfalse; then + if test -n "$shlibpath_var"; then + # Export the shlibpath_var. + eval "export $shlibpath_var" + fi + + # Restore saved environment variables + for lt_var in LANG LANGUAGE LC_ALL LC_CTYPE LC_COLLATE LC_MESSAGES + do + eval "if test \"\${save_$lt_var+set}\" = set; then + $lt_var=\$save_$lt_var; export $lt_var + else + $lt_unset $lt_var + fi" + done + + # Now prepare to actually exec the command. + exec_cmd="\$cmd$args" + else + # Display what would be done. + if test -n "$shlibpath_var"; then + eval "\$ECHO \"\$shlibpath_var=\$$shlibpath_var\"" + echo "export $shlibpath_var" + fi + $ECHO "$cmd$args" + exit $EXIT_SUCCESS + fi +} + +test "$opt_mode" = execute && func_mode_execute ${1+"$@"} + + +# func_mode_finish arg... +func_mode_finish () +{ + $opt_debug + libs= + libdirs= + admincmds= + + for opt in "$nonopt" ${1+"$@"} + do + if test -d "$opt"; then + libdirs+=" $opt" + + elif test -f "$opt"; then + if func_lalib_unsafe_p "$opt"; then + libs+=" $opt" + else + func_warning "\`$opt' is not a valid libtool archive" + fi + + else + func_fatal_error "invalid argument \`$opt'" + fi + done + + if test -n "$libs"; then + if test -n "$lt_sysroot"; then + sysroot_regex=`$ECHO "$lt_sysroot" | $SED "$sed_make_literal_regex"` + sysroot_cmd="s/\([ ']\)$sysroot_regex/\1/g;" + else + sysroot_cmd= + fi + + # Remove sysroot references + if $opt_dry_run; then + for lib in $libs; do + echo "removing references to $lt_sysroot and \`=' prefixes from $lib" + done + else + tmpdir=`func_mktempdir` + for lib in $libs; do + sed -e "${sysroot_cmd} s/\([ ']-[LR]\)=/\1/g; s/\([ ']\)=/\1/g" $lib \ + > $tmpdir/tmp-la + mv -f $tmpdir/tmp-la $lib + done + ${RM}r "$tmpdir" + fi + fi + + if test -n "$finish_cmds$finish_eval" && test -n "$libdirs"; then + for libdir in $libdirs; do + if test -n "$finish_cmds"; then + # Do each command in the finish commands. + func_execute_cmds "$finish_cmds" 'admincmds="$admincmds +'"$cmd"'"' + fi + if test -n "$finish_eval"; then + # Do the single finish_eval. + eval cmds=\"$finish_eval\" + $opt_dry_run || eval "$cmds" || admincmds+=" + $cmds" + fi + done + fi + + # Exit here if they wanted silent mode. + $opt_silent && exit $EXIT_SUCCESS + + if test -n "$finish_cmds$finish_eval" && test -n "$libdirs"; then + echo "----------------------------------------------------------------------" + echo "Libraries have been installed in:" + for libdir in $libdirs; do + $ECHO " $libdir" + done + echo + echo "If you ever happen to want to link against installed libraries" + echo "in a given directory, LIBDIR, you must either use libtool, and" + echo "specify the full pathname of the library, or use the \`-LLIBDIR'" + echo "flag during linking and do at least one of the following:" + if test -n "$shlibpath_var"; then + echo " - add LIBDIR to the \`$shlibpath_var' environment variable" + echo " during execution" + fi + if test -n "$runpath_var"; then + echo " - add LIBDIR to the \`$runpath_var' environment variable" + echo " during linking" + fi + if test -n "$hardcode_libdir_flag_spec"; then + libdir=LIBDIR + eval flag=\"$hardcode_libdir_flag_spec\" + + $ECHO " - use the \`$flag' linker flag" + fi + if test -n "$admincmds"; then + $ECHO " - have your system administrator run these commands:$admincmds" + fi + if test -f /etc/ld.so.conf; then + echo " - have your system administrator add LIBDIR to \`/etc/ld.so.conf'" + fi + echo + + echo "See any operating system documentation about shared libraries for" + case $host in + solaris2.[6789]|solaris2.1[0-9]) + echo "more information, such as the ld(1), crle(1) and ld.so(8) manual" + echo "pages." + ;; + *) + echo "more information, such as the ld(1) and ld.so(8) manual pages." + ;; + esac + echo "----------------------------------------------------------------------" + fi + exit $EXIT_SUCCESS +} + +test "$opt_mode" = finish && func_mode_finish ${1+"$@"} + + +# func_mode_install arg... +func_mode_install () +{ + $opt_debug + # There may be an optional sh(1) argument at the beginning of + # install_prog (especially on Windows NT). + if test "$nonopt" = "$SHELL" || test "$nonopt" = /bin/sh || + # Allow the use of GNU shtool's install command. + case $nonopt in *shtool*) :;; *) false;; esac; then + # Aesthetically quote it. + func_quote_for_eval "$nonopt" + install_prog="$func_quote_for_eval_result " + arg=$1 + shift + else + install_prog= + arg=$nonopt + fi + + # The real first argument should be the name of the installation program. + # Aesthetically quote it. + func_quote_for_eval "$arg" + install_prog+="$func_quote_for_eval_result" + install_shared_prog=$install_prog + case " $install_prog " in + *[\\\ /]cp\ *) install_cp=: ;; + *) install_cp=false ;; + esac + + # We need to accept at least all the BSD install flags. + dest= + files= + opts= + prev= + install_type= + isdir=no + stripme= + no_mode=: + for arg + do + arg2= + if test -n "$dest"; then + files+=" $dest" + dest=$arg + continue + fi + + case $arg in + -d) isdir=yes ;; + -f) + if $install_cp; then :; else + prev=$arg + fi + ;; + -g | -m | -o) + prev=$arg + ;; + -s) + stripme=" -s" + continue + ;; + -*) + ;; + *) + # If the previous option needed an argument, then skip it. + if test -n "$prev"; then + if test "x$prev" = x-m && test -n "$install_override_mode"; then + arg2=$install_override_mode + no_mode=false + fi + prev= + else + dest=$arg + continue + fi + ;; + esac + + # Aesthetically quote the argument. + func_quote_for_eval "$arg" + install_prog+=" $func_quote_for_eval_result" + if test -n "$arg2"; then + func_quote_for_eval "$arg2" + fi + install_shared_prog+=" $func_quote_for_eval_result" + done + + test -z "$install_prog" && \ + func_fatal_help "you must specify an install program" + + test -n "$prev" && \ + func_fatal_help "the \`$prev' option requires an argument" + + if test -n "$install_override_mode" && $no_mode; then + if $install_cp; then :; else + func_quote_for_eval "$install_override_mode" + install_shared_prog+=" -m $func_quote_for_eval_result" + fi + fi + + if test -z "$files"; then + if test -z "$dest"; then + func_fatal_help "no file or destination specified" + else + func_fatal_help "you must specify a destination" + fi + fi + + # Strip any trailing slash from the destination. + func_stripname '' '/' "$dest" + dest=$func_stripname_result + + # Check to see that the destination is a directory. + test -d "$dest" && isdir=yes + if test "$isdir" = yes; then + destdir="$dest" + destname= + else + func_dirname_and_basename "$dest" "" "." + destdir="$func_dirname_result" + destname="$func_basename_result" + + # Not a directory, so check to see that there is only one file specified. + set dummy $files; shift + test "$#" -gt 1 && \ + func_fatal_help "\`$dest' is not a directory" + fi + case $destdir in + [\\/]* | [A-Za-z]:[\\/]*) ;; + *) + for file in $files; do + case $file in + *.lo) ;; + *) + func_fatal_help "\`$destdir' must be an absolute directory name" + ;; + esac + done + ;; + esac + + # This variable tells wrapper scripts just to set variables rather + # than running their programs. + libtool_install_magic="$magic" + + staticlibs= + future_libdirs= + current_libdirs= + for file in $files; do + + # Do each installation. + case $file in + *.$libext) + # Do the static libraries later. + staticlibs+=" $file" + ;; + + *.la) + func_resolve_sysroot "$file" + file=$func_resolve_sysroot_result + + # Check to see that this really is a libtool archive. + func_lalib_unsafe_p "$file" \ + || func_fatal_help "\`$file' is not a valid libtool archive" + + library_names= + old_library= + relink_command= + func_source "$file" + + # Add the libdir to current_libdirs if it is the destination. + if test "X$destdir" = "X$libdir"; then + case "$current_libdirs " in + *" $libdir "*) ;; + *) current_libdirs+=" $libdir" ;; + esac + else + # Note the libdir as a future libdir. + case "$future_libdirs " in + *" $libdir "*) ;; + *) future_libdirs+=" $libdir" ;; + esac + fi + + func_dirname "$file" "/" "" + dir="$func_dirname_result" + dir+="$objdir" + + if test -n "$relink_command"; then + # Determine the prefix the user has applied to our future dir. + inst_prefix_dir=`$ECHO "$destdir" | $SED -e "s%$libdir\$%%"` + + # Don't allow the user to place us outside of our expected + # location b/c this prevents finding dependent libraries that + # are installed to the same prefix. + # At present, this check doesn't affect windows .dll's that + # are installed into $libdir/../bin (currently, that works fine) + # but it's something to keep an eye on. + test "$inst_prefix_dir" = "$destdir" && \ + func_fatal_error "error: cannot install \`$file' to a directory not ending in $libdir" + + if test -n "$inst_prefix_dir"; then + # Stick the inst_prefix_dir data into the link command. + relink_command=`$ECHO "$relink_command" | $SED "s%@inst_prefix_dir@%-inst-prefix-dir $inst_prefix_dir%"` + else + relink_command=`$ECHO "$relink_command" | $SED "s%@inst_prefix_dir@%%"` + fi + + func_warning "relinking \`$file'" + func_show_eval "$relink_command" \ + 'func_fatal_error "error: relink \`$file'\'' with the above command before installing it"' + fi + + # See the names of the shared library. + set dummy $library_names; shift + if test -n "$1"; then + realname="$1" + shift + + srcname="$realname" + test -n "$relink_command" && srcname="$realname"T + + # Install the shared library and build the symlinks. + func_show_eval "$install_shared_prog $dir/$srcname $destdir/$realname" \ + 'exit $?' + tstripme="$stripme" + case $host_os in + cygwin* | mingw* | pw32* | cegcc*) + case $realname in + *.dll.a) + tstripme="" + ;; + esac + ;; + esac + if test -n "$tstripme" && test -n "$striplib"; then + func_show_eval "$striplib $destdir/$realname" 'exit $?' + fi + + if test "$#" -gt 0; then + # Delete the old symlinks, and create new ones. + # Try `ln -sf' first, because the `ln' binary might depend on + # the symlink we replace! Solaris /bin/ln does not understand -f, + # so we also need to try rm && ln -s. + for linkname + do + test "$linkname" != "$realname" \ + && func_show_eval "(cd $destdir && { $LN_S -f $realname $linkname || { $RM $linkname && $LN_S $realname $linkname; }; })" + done + fi + + # Do each command in the postinstall commands. + lib="$destdir/$realname" + func_execute_cmds "$postinstall_cmds" 'exit $?' + fi + + # Install the pseudo-library for information purposes. + func_basename "$file" + name="$func_basename_result" + instname="$dir/$name"i + func_show_eval "$install_prog $instname $destdir/$name" 'exit $?' + + # Maybe install the static library, too. + test -n "$old_library" && staticlibs+=" $dir/$old_library" + ;; + + *.lo) + # Install (i.e. copy) a libtool object. + + # Figure out destination file name, if it wasn't already specified. + if test -n "$destname"; then + destfile="$destdir/$destname" + else + func_basename "$file" + destfile="$func_basename_result" + destfile="$destdir/$destfile" + fi + + # Deduce the name of the destination old-style object file. + case $destfile in + *.lo) + func_lo2o "$destfile" + staticdest=$func_lo2o_result + ;; + *.$objext) + staticdest="$destfile" + destfile= + ;; + *) + func_fatal_help "cannot copy a libtool object to \`$destfile'" + ;; + esac + + # Install the libtool object if requested. + test -n "$destfile" && \ + func_show_eval "$install_prog $file $destfile" 'exit $?' + + # Install the old object if enabled. + if test "$build_old_libs" = yes; then + # Deduce the name of the old-style object file. + func_lo2o "$file" + staticobj=$func_lo2o_result + func_show_eval "$install_prog \$staticobj \$staticdest" 'exit $?' + fi + exit $EXIT_SUCCESS + ;; + + *) + # Figure out destination file name, if it wasn't already specified. + if test -n "$destname"; then + destfile="$destdir/$destname" + else + func_basename "$file" + destfile="$func_basename_result" + destfile="$destdir/$destfile" + fi + + # If the file is missing, and there is a .exe on the end, strip it + # because it is most likely a libtool script we actually want to + # install + stripped_ext="" + case $file in + *.exe) + if test ! -f "$file"; then + func_stripname '' '.exe' "$file" + file=$func_stripname_result + stripped_ext=".exe" + fi + ;; + esac + + # Do a test to see if this is really a libtool program. + case $host in + *cygwin* | *mingw*) + if func_ltwrapper_executable_p "$file"; then + func_ltwrapper_scriptname "$file" + wrapper=$func_ltwrapper_scriptname_result + else + func_stripname '' '.exe' "$file" + wrapper=$func_stripname_result + fi + ;; + *) + wrapper=$file + ;; + esac + if func_ltwrapper_script_p "$wrapper"; then + notinst_deplibs= + relink_command= + + func_source "$wrapper" + + # Check the variables that should have been set. + test -z "$generated_by_libtool_version" && \ + func_fatal_error "invalid libtool wrapper script \`$wrapper'" + + finalize=yes + for lib in $notinst_deplibs; do + # Check to see that each library is installed. + libdir= + if test -f "$lib"; then + func_source "$lib" + fi + libfile="$libdir/"`$ECHO "$lib" | $SED 's%^.*/%%g'` ### testsuite: skip nested quoting test + if test -n "$libdir" && test ! -f "$libfile"; then + func_warning "\`$lib' has not been installed in \`$libdir'" + finalize=no + fi + done + + relink_command= + func_source "$wrapper" + + outputname= + if test "$fast_install" = no && test -n "$relink_command"; then + $opt_dry_run || { + if test "$finalize" = yes; then + tmpdir=`func_mktempdir` + func_basename "$file$stripped_ext" + file="$func_basename_result" + outputname="$tmpdir/$file" + # Replace the output file specification. + relink_command=`$ECHO "$relink_command" | $SED 's%@OUTPUT@%'"$outputname"'%g'` + + $opt_silent || { + func_quote_for_expand "$relink_command" + eval "func_echo $func_quote_for_expand_result" + } + if eval "$relink_command"; then : + else + func_error "error: relink \`$file' with the above command before installing it" + $opt_dry_run || ${RM}r "$tmpdir" + continue + fi + file="$outputname" + else + func_warning "cannot relink \`$file'" + fi + } + else + # Install the binary that we compiled earlier. + file=`$ECHO "$file$stripped_ext" | $SED "s%\([^/]*\)$%$objdir/\1%"` + fi + fi + + # remove .exe since cygwin /usr/bin/install will append another + # one anyway + case $install_prog,$host in + */usr/bin/install*,*cygwin*) + case $file:$destfile in + *.exe:*.exe) + # this is ok + ;; + *.exe:*) + destfile=$destfile.exe + ;; + *:*.exe) + func_stripname '' '.exe' "$destfile" + destfile=$func_stripname_result + ;; + esac + ;; + esac + func_show_eval "$install_prog\$stripme \$file \$destfile" 'exit $?' + $opt_dry_run || if test -n "$outputname"; then + ${RM}r "$tmpdir" + fi + ;; + esac + done + + for file in $staticlibs; do + func_basename "$file" + name="$func_basename_result" + + # Set up the ranlib parameters. + oldlib="$destdir/$name" + func_to_tool_file "$oldlib" func_convert_file_msys_to_w32 + tool_oldlib=$func_to_tool_file_result + + func_show_eval "$install_prog \$file \$oldlib" 'exit $?' + + if test -n "$stripme" && test -n "$old_striplib"; then + func_show_eval "$old_striplib $tool_oldlib" 'exit $?' + fi + + # Do each command in the postinstall commands. + func_execute_cmds "$old_postinstall_cmds" 'exit $?' + done + + test -n "$future_libdirs" && \ + func_warning "remember to run \`$progname --finish$future_libdirs'" + + if test -n "$current_libdirs"; then + # Maybe just do a dry run. + $opt_dry_run && current_libdirs=" -n$current_libdirs" + exec_cmd='$SHELL $progpath $preserve_args --finish$current_libdirs' + else + exit $EXIT_SUCCESS + fi +} + +test "$opt_mode" = install && func_mode_install ${1+"$@"} + + +# func_generate_dlsyms outputname originator pic_p +# Extract symbols from dlprefiles and create ${outputname}S.o with +# a dlpreopen symbol table. +func_generate_dlsyms () +{ + $opt_debug + my_outputname="$1" + my_originator="$2" + my_pic_p="${3-no}" + my_prefix=`$ECHO "$my_originator" | sed 's%[^a-zA-Z0-9]%_%g'` + my_dlsyms= + + if test -n "$dlfiles$dlprefiles" || test "$dlself" != no; then + if test -n "$NM" && test -n "$global_symbol_pipe"; then + my_dlsyms="${my_outputname}S.c" + else + func_error "not configured to extract global symbols from dlpreopened files" + fi + fi + + if test -n "$my_dlsyms"; then + case $my_dlsyms in + "") ;; + *.c) + # Discover the nlist of each of the dlfiles. + nlist="$output_objdir/${my_outputname}.nm" + + func_show_eval "$RM $nlist ${nlist}S ${nlist}T" + + # Parse the name list into a source file. + func_verbose "creating $output_objdir/$my_dlsyms" + + $opt_dry_run || $ECHO > "$output_objdir/$my_dlsyms" "\ +/* $my_dlsyms - symbol resolution table for \`$my_outputname' dlsym emulation. */ +/* Generated by $PROGRAM (GNU $PACKAGE$TIMESTAMP) $VERSION */ + +#ifdef __cplusplus +extern \"C\" { +#endif + +#if defined(__GNUC__) && (((__GNUC__ == 4) && (__GNUC_MINOR__ >= 4)) || (__GNUC__ > 4)) +#pragma GCC diagnostic ignored \"-Wstrict-prototypes\" +#endif + +/* Keep this code in sync between libtool.m4, ltmain, lt_system.h, and tests. */ +#if defined(_WIN32) || defined(__CYGWIN__) || defined(_WIN32_WCE) +/* DATA imports from DLLs on WIN32 con't be const, because runtime + relocations are performed -- see ld's documentation on pseudo-relocs. */ +# define LT_DLSYM_CONST +#elif defined(__osf__) +/* This system does not cope well with relocations in const data. */ +# define LT_DLSYM_CONST +#else +# define LT_DLSYM_CONST const +#endif + +/* External symbol declarations for the compiler. */\ +" + + if test "$dlself" = yes; then + func_verbose "generating symbol list for \`$output'" + + $opt_dry_run || echo ': @PROGRAM@ ' > "$nlist" + + # Add our own program objects to the symbol list. + progfiles=`$ECHO "$objs$old_deplibs" | $SP2NL | $SED "$lo2o" | $NL2SP` + for progfile in $progfiles; do + func_to_tool_file "$progfile" func_convert_file_msys_to_w32 + func_verbose "extracting global C symbols from \`$func_to_tool_file_result'" + $opt_dry_run || eval "$NM $func_to_tool_file_result | $global_symbol_pipe >> '$nlist'" + done + + if test -n "$exclude_expsyms"; then + $opt_dry_run || { + eval '$EGREP -v " ($exclude_expsyms)$" "$nlist" > "$nlist"T' + eval '$MV "$nlist"T "$nlist"' + } + fi + + if test -n "$export_symbols_regex"; then + $opt_dry_run || { + eval '$EGREP -e "$export_symbols_regex" "$nlist" > "$nlist"T' + eval '$MV "$nlist"T "$nlist"' + } + fi + + # Prepare the list of exported symbols + if test -z "$export_symbols"; then + export_symbols="$output_objdir/$outputname.exp" + $opt_dry_run || { + $RM $export_symbols + eval "${SED} -n -e '/^: @PROGRAM@ $/d' -e 's/^.* \(.*\)$/\1/p' "'< "$nlist" > "$export_symbols"' + case $host in + *cygwin* | *mingw* | *cegcc* ) + eval "echo EXPORTS "'> "$output_objdir/$outputname.def"' + eval 'cat "$export_symbols" >> "$output_objdir/$outputname.def"' + ;; + esac + } + else + $opt_dry_run || { + eval "${SED} -e 's/\([].[*^$]\)/\\\\\1/g' -e 's/^/ /' -e 's/$/$/'"' < "$export_symbols" > "$output_objdir/$outputname.exp"' + eval '$GREP -f "$output_objdir/$outputname.exp" < "$nlist" > "$nlist"T' + eval '$MV "$nlist"T "$nlist"' + case $host in + *cygwin* | *mingw* | *cegcc* ) + eval "echo EXPORTS "'> "$output_objdir/$outputname.def"' + eval 'cat "$nlist" >> "$output_objdir/$outputname.def"' + ;; + esac + } + fi + fi + + for dlprefile in $dlprefiles; do + func_verbose "extracting global C symbols from \`$dlprefile'" + func_basename "$dlprefile" + name="$func_basename_result" + case $host in + *cygwin* | *mingw* | *cegcc* ) + # if an import library, we need to obtain dlname + if func_win32_import_lib_p "$dlprefile"; then + func_tr_sh "$dlprefile" + eval "curr_lafile=\$libfile_$func_tr_sh_result" + dlprefile_dlbasename="" + if test -n "$curr_lafile" && func_lalib_p "$curr_lafile"; then + # Use subshell, to avoid clobbering current variable values + dlprefile_dlname=`source "$curr_lafile" && echo "$dlname"` + if test -n "$dlprefile_dlname" ; then + func_basename "$dlprefile_dlname" + dlprefile_dlbasename="$func_basename_result" + else + # no lafile. user explicitly requested -dlpreopen . + $sharedlib_from_linklib_cmd "$dlprefile" + dlprefile_dlbasename=$sharedlib_from_linklib_result + fi + fi + $opt_dry_run || { + if test -n "$dlprefile_dlbasename" ; then + eval '$ECHO ": $dlprefile_dlbasename" >> "$nlist"' + else + func_warning "Could not compute DLL name from $name" + eval '$ECHO ": $name " >> "$nlist"' + fi + func_to_tool_file "$dlprefile" func_convert_file_msys_to_w32 + eval "$NM \"$func_to_tool_file_result\" 2>/dev/null | $global_symbol_pipe | + $SED -e '/I __imp/d' -e 's/I __nm_/D /;s/_nm__//' >> '$nlist'" + } + else # not an import lib + $opt_dry_run || { + eval '$ECHO ": $name " >> "$nlist"' + func_to_tool_file "$dlprefile" func_convert_file_msys_to_w32 + eval "$NM \"$func_to_tool_file_result\" 2>/dev/null | $global_symbol_pipe >> '$nlist'" + } + fi + ;; + *) + $opt_dry_run || { + eval '$ECHO ": $name " >> "$nlist"' + func_to_tool_file "$dlprefile" func_convert_file_msys_to_w32 + eval "$NM \"$func_to_tool_file_result\" 2>/dev/null | $global_symbol_pipe >> '$nlist'" + } + ;; + esac + done + + $opt_dry_run || { + # Make sure we have at least an empty file. + test -f "$nlist" || : > "$nlist" + + if test -n "$exclude_expsyms"; then + $EGREP -v " ($exclude_expsyms)$" "$nlist" > "$nlist"T + $MV "$nlist"T "$nlist" + fi + + # Try sorting and uniquifying the output. + if $GREP -v "^: " < "$nlist" | + if sort -k 3 /dev/null 2>&1; then + sort -k 3 + else + sort +2 + fi | + uniq > "$nlist"S; then + : + else + $GREP -v "^: " < "$nlist" > "$nlist"S + fi + + if test -f "$nlist"S; then + eval "$global_symbol_to_cdecl"' < "$nlist"S >> "$output_objdir/$my_dlsyms"' + else + echo '/* NONE */' >> "$output_objdir/$my_dlsyms" + fi + + echo >> "$output_objdir/$my_dlsyms" "\ + +/* The mapping between symbol names and symbols. */ +typedef struct { + const char *name; + void *address; +} lt_dlsymlist; +extern LT_DLSYM_CONST lt_dlsymlist +lt_${my_prefix}_LTX_preloaded_symbols[]; +LT_DLSYM_CONST lt_dlsymlist +lt_${my_prefix}_LTX_preloaded_symbols[] = +{\ + { \"$my_originator\", (void *) 0 }," + + case $need_lib_prefix in + no) + eval "$global_symbol_to_c_name_address" < "$nlist" >> "$output_objdir/$my_dlsyms" + ;; + *) + eval "$global_symbol_to_c_name_address_lib_prefix" < "$nlist" >> "$output_objdir/$my_dlsyms" + ;; + esac + echo >> "$output_objdir/$my_dlsyms" "\ + {0, (void *) 0} +}; + +/* This works around a problem in FreeBSD linker */ +#ifdef FREEBSD_WORKAROUND +static const void *lt_preloaded_setup() { + return lt_${my_prefix}_LTX_preloaded_symbols; +} +#endif + +#ifdef __cplusplus +} +#endif\ +" + } # !$opt_dry_run + + pic_flag_for_symtable= + case "$compile_command " in + *" -static "*) ;; + *) + case $host in + # compiling the symbol table file with pic_flag works around + # a FreeBSD bug that causes programs to crash when -lm is + # linked before any other PIC object. But we must not use + # pic_flag when linking with -static. The problem exists in + # FreeBSD 2.2.6 and is fixed in FreeBSD 3.1. + *-*-freebsd2.*|*-*-freebsd3.0*|*-*-freebsdelf3.0*) + pic_flag_for_symtable=" $pic_flag -DFREEBSD_WORKAROUND" ;; + *-*-hpux*) + pic_flag_for_symtable=" $pic_flag" ;; + *) + if test "X$my_pic_p" != Xno; then + pic_flag_for_symtable=" $pic_flag" + fi + ;; + esac + ;; + esac + symtab_cflags= + for arg in $LTCFLAGS; do + case $arg in + -pie | -fpie | -fPIE) ;; + *) symtab_cflags+=" $arg" ;; + esac + done + + # Now compile the dynamic symbol file. + func_show_eval '(cd $output_objdir && $LTCC$symtab_cflags -c$no_builtin_flag$pic_flag_for_symtable "$my_dlsyms")' 'exit $?' + + # Clean up the generated files. + func_show_eval '$RM "$output_objdir/$my_dlsyms" "$nlist" "${nlist}S" "${nlist}T"' + + # Transform the symbol file into the correct name. + symfileobj="$output_objdir/${my_outputname}S.$objext" + case $host in + *cygwin* | *mingw* | *cegcc* ) + if test -f "$output_objdir/$my_outputname.def"; then + compile_command=`$ECHO "$compile_command" | $SED "s%@SYMFILE@%$output_objdir/$my_outputname.def $symfileobj%"` + finalize_command=`$ECHO "$finalize_command" | $SED "s%@SYMFILE@%$output_objdir/$my_outputname.def $symfileobj%"` + else + compile_command=`$ECHO "$compile_command" | $SED "s%@SYMFILE@%$symfileobj%"` + finalize_command=`$ECHO "$finalize_command" | $SED "s%@SYMFILE@%$symfileobj%"` + fi + ;; + *) + compile_command=`$ECHO "$compile_command" | $SED "s%@SYMFILE@%$symfileobj%"` + finalize_command=`$ECHO "$finalize_command" | $SED "s%@SYMFILE@%$symfileobj%"` + ;; + esac + ;; + *) + func_fatal_error "unknown suffix for \`$my_dlsyms'" + ;; + esac + else + # We keep going just in case the user didn't refer to + # lt_preloaded_symbols. The linker will fail if global_symbol_pipe + # really was required. + + # Nullify the symbol file. + compile_command=`$ECHO "$compile_command" | $SED "s% @SYMFILE@%%"` + finalize_command=`$ECHO "$finalize_command" | $SED "s% @SYMFILE@%%"` + fi +} + +# func_win32_libid arg +# return the library type of file 'arg' +# +# Need a lot of goo to handle *both* DLLs and import libs +# Has to be a shell function in order to 'eat' the argument +# that is supplied when $file_magic_command is called. +# Despite the name, also deal with 64 bit binaries. +func_win32_libid () +{ + $opt_debug + win32_libid_type="unknown" + win32_fileres=`file -L $1 2>/dev/null` + case $win32_fileres in + *ar\ archive\ import\ library*) # definitely import + win32_libid_type="x86 archive import" + ;; + *ar\ archive*) # could be an import, or static + # Keep the egrep pattern in sync with the one in _LT_CHECK_MAGIC_METHOD. + if eval $OBJDUMP -f $1 | $SED -e '10q' 2>/dev/null | + $EGREP 'file format (pei*-i386(.*architecture: i386)?|pe-arm-wince|pe-x86-64)' >/dev/null; then + func_to_tool_file "$1" func_convert_file_msys_to_w32 + win32_nmres=`eval $NM -f posix -A \"$func_to_tool_file_result\" | + $SED -n -e ' + 1,100{ + / I /{ + s,.*,import, + p + q + } + }'` + case $win32_nmres in + import*) win32_libid_type="x86 archive import";; + *) win32_libid_type="x86 archive static";; + esac + fi + ;; + *DLL*) + win32_libid_type="x86 DLL" + ;; + *executable*) # but shell scripts are "executable" too... + case $win32_fileres in + *MS\ Windows\ PE\ Intel*) + win32_libid_type="x86 DLL" + ;; + esac + ;; + esac + $ECHO "$win32_libid_type" +} + +# func_cygming_dll_for_implib ARG +# +# Platform-specific function to extract the +# name of the DLL associated with the specified +# import library ARG. +# Invoked by eval'ing the libtool variable +# $sharedlib_from_linklib_cmd +# Result is available in the variable +# $sharedlib_from_linklib_result +func_cygming_dll_for_implib () +{ + $opt_debug + sharedlib_from_linklib_result=`$DLLTOOL --identify-strict --identify "$1"` +} + +# func_cygming_dll_for_implib_fallback_core SECTION_NAME LIBNAMEs +# +# The is the core of a fallback implementation of a +# platform-specific function to extract the name of the +# DLL associated with the specified import library LIBNAME. +# +# SECTION_NAME is either .idata$6 or .idata$7, depending +# on the platform and compiler that created the implib. +# +# Echos the name of the DLL associated with the +# specified import library. +func_cygming_dll_for_implib_fallback_core () +{ + $opt_debug + match_literal=`$ECHO "$1" | $SED "$sed_make_literal_regex"` + $OBJDUMP -s --section "$1" "$2" 2>/dev/null | + $SED '/^Contents of section '"$match_literal"':/{ + # Place marker at beginning of archive member dllname section + s/.*/====MARK====/ + p + d + } + # These lines can sometimes be longer than 43 characters, but + # are always uninteresting + /:[ ]*file format pe[i]\{,1\}-/d + /^In archive [^:]*:/d + # Ensure marker is printed + /^====MARK====/p + # Remove all lines with less than 43 characters + /^.\{43\}/!d + # From remaining lines, remove first 43 characters + s/^.\{43\}//' | + $SED -n ' + # Join marker and all lines until next marker into a single line + /^====MARK====/ b para + H + $ b para + b + :para + x + s/\n//g + # Remove the marker + s/^====MARK====// + # Remove trailing dots and whitespace + s/[\. \t]*$// + # Print + /./p' | + # we now have a list, one entry per line, of the stringified + # contents of the appropriate section of all members of the + # archive which possess that section. Heuristic: eliminate + # all those which have a first or second character that is + # a '.' (that is, objdump's representation of an unprintable + # character.) This should work for all archives with less than + # 0x302f exports -- but will fail for DLLs whose name actually + # begins with a literal '.' or a single character followed by + # a '.'. + # + # Of those that remain, print the first one. + $SED -e '/^\./d;/^.\./d;q' +} + +# func_cygming_gnu_implib_p ARG +# This predicate returns with zero status (TRUE) if +# ARG is a GNU/binutils-style import library. Returns +# with nonzero status (FALSE) otherwise. +func_cygming_gnu_implib_p () +{ + $opt_debug + func_to_tool_file "$1" func_convert_file_msys_to_w32 + func_cygming_gnu_implib_tmp=`$NM "$func_to_tool_file_result" | eval "$global_symbol_pipe" | $EGREP ' (_head_[A-Za-z0-9_]+_[ad]l*|[A-Za-z0-9_]+_[ad]l*_iname)$'` + test -n "$func_cygming_gnu_implib_tmp" +} + +# func_cygming_ms_implib_p ARG +# This predicate returns with zero status (TRUE) if +# ARG is an MS-style import library. Returns +# with nonzero status (FALSE) otherwise. +func_cygming_ms_implib_p () +{ + $opt_debug + func_to_tool_file "$1" func_convert_file_msys_to_w32 + func_cygming_ms_implib_tmp=`$NM "$func_to_tool_file_result" | eval "$global_symbol_pipe" | $GREP '_NULL_IMPORT_DESCRIPTOR'` + test -n "$func_cygming_ms_implib_tmp" +} + +# func_cygming_dll_for_implib_fallback ARG +# Platform-specific function to extract the +# name of the DLL associated with the specified +# import library ARG. +# +# This fallback implementation is for use when $DLLTOOL +# does not support the --identify-strict option. +# Invoked by eval'ing the libtool variable +# $sharedlib_from_linklib_cmd +# Result is available in the variable +# $sharedlib_from_linklib_result +func_cygming_dll_for_implib_fallback () +{ + $opt_debug + if func_cygming_gnu_implib_p "$1" ; then + # binutils import library + sharedlib_from_linklib_result=`func_cygming_dll_for_implib_fallback_core '.idata$7' "$1"` + elif func_cygming_ms_implib_p "$1" ; then + # ms-generated import library + sharedlib_from_linklib_result=`func_cygming_dll_for_implib_fallback_core '.idata$6' "$1"` + else + # unknown + sharedlib_from_linklib_result="" + fi +} + + +# func_extract_an_archive dir oldlib +func_extract_an_archive () +{ + $opt_debug + f_ex_an_ar_dir="$1"; shift + f_ex_an_ar_oldlib="$1" + if test "$lock_old_archive_extraction" = yes; then + lockfile=$f_ex_an_ar_oldlib.lock + until $opt_dry_run || ln "$progpath" "$lockfile" 2>/dev/null; do + func_echo "Waiting for $lockfile to be removed" + sleep 2 + done + fi + func_show_eval "(cd \$f_ex_an_ar_dir && $AR x \"\$f_ex_an_ar_oldlib\")" \ + 'stat=$?; rm -f "$lockfile"; exit $stat' + if test "$lock_old_archive_extraction" = yes; then + $opt_dry_run || rm -f "$lockfile" + fi + if ($AR t "$f_ex_an_ar_oldlib" | sort | sort -uc >/dev/null 2>&1); then + : + else + func_fatal_error "object name conflicts in archive: $f_ex_an_ar_dir/$f_ex_an_ar_oldlib" + fi +} + + +# func_extract_archives gentop oldlib ... +func_extract_archives () +{ + $opt_debug + my_gentop="$1"; shift + my_oldlibs=${1+"$@"} + my_oldobjs="" + my_xlib="" + my_xabs="" + my_xdir="" + + for my_xlib in $my_oldlibs; do + # Extract the objects. + case $my_xlib in + [\\/]* | [A-Za-z]:[\\/]*) my_xabs="$my_xlib" ;; + *) my_xabs=`pwd`"/$my_xlib" ;; + esac + func_basename "$my_xlib" + my_xlib="$func_basename_result" + my_xlib_u=$my_xlib + while :; do + case " $extracted_archives " in + *" $my_xlib_u "*) + func_arith $extracted_serial + 1 + extracted_serial=$func_arith_result + my_xlib_u=lt$extracted_serial-$my_xlib ;; + *) break ;; + esac + done + extracted_archives="$extracted_archives $my_xlib_u" + my_xdir="$my_gentop/$my_xlib_u" + + func_mkdir_p "$my_xdir" + + case $host in + *-darwin*) + func_verbose "Extracting $my_xabs" + # Do not bother doing anything if just a dry run + $opt_dry_run || { + darwin_orig_dir=`pwd` + cd $my_xdir || exit $? + darwin_archive=$my_xabs + darwin_curdir=`pwd` + darwin_base_archive=`basename "$darwin_archive"` + darwin_arches=`$LIPO -info "$darwin_archive" 2>/dev/null | $GREP Architectures 2>/dev/null || true` + if test -n "$darwin_arches"; then + darwin_arches=`$ECHO "$darwin_arches" | $SED -e 's/.*are://'` + darwin_arch= + func_verbose "$darwin_base_archive has multiple architectures $darwin_arches" + for darwin_arch in $darwin_arches ; do + func_mkdir_p "unfat-$$/${darwin_base_archive}-${darwin_arch}" + $LIPO -thin $darwin_arch -output "unfat-$$/${darwin_base_archive}-${darwin_arch}/${darwin_base_archive}" "${darwin_archive}" + cd "unfat-$$/${darwin_base_archive}-${darwin_arch}" + func_extract_an_archive "`pwd`" "${darwin_base_archive}" + cd "$darwin_curdir" + $RM "unfat-$$/${darwin_base_archive}-${darwin_arch}/${darwin_base_archive}" + done # $darwin_arches + ## Okay now we've a bunch of thin objects, gotta fatten them up :) + darwin_filelist=`find unfat-$$ -type f -name \*.o -print -o -name \*.lo -print | $SED -e "$basename" | sort -u` + darwin_file= + darwin_files= + for darwin_file in $darwin_filelist; do + darwin_files=`find unfat-$$ -name $darwin_file -print | sort | $NL2SP` + $LIPO -create -output "$darwin_file" $darwin_files + done # $darwin_filelist + $RM -rf unfat-$$ + cd "$darwin_orig_dir" + else + cd $darwin_orig_dir + func_extract_an_archive "$my_xdir" "$my_xabs" + fi # $darwin_arches + } # !$opt_dry_run + ;; + *) + func_extract_an_archive "$my_xdir" "$my_xabs" + ;; + esac + my_oldobjs="$my_oldobjs "`find $my_xdir -name \*.$objext -print -o -name \*.lo -print | sort | $NL2SP` + done + + func_extract_archives_result="$my_oldobjs" +} + + +# func_emit_wrapper [arg=no] +# +# Emit a libtool wrapper script on stdout. +# Don't directly open a file because we may want to +# incorporate the script contents within a cygwin/mingw +# wrapper executable. Must ONLY be called from within +# func_mode_link because it depends on a number of variables +# set therein. +# +# ARG is the value that the WRAPPER_SCRIPT_BELONGS_IN_OBJDIR +# variable will take. If 'yes', then the emitted script +# will assume that the directory in which it is stored is +# the $objdir directory. This is a cygwin/mingw-specific +# behavior. +func_emit_wrapper () +{ + func_emit_wrapper_arg1=${1-no} + + $ECHO "\ +#! $SHELL + +# $output - temporary wrapper script for $objdir/$outputname +# Generated by $PROGRAM (GNU $PACKAGE$TIMESTAMP) $VERSION +# +# The $output program cannot be directly executed until all the libtool +# libraries that it depends on are installed. +# +# This wrapper script should never be moved out of the build directory. +# If it is, it will not operate correctly. + +# Sed substitution that helps us do robust quoting. It backslashifies +# metacharacters that are still active within double-quoted strings. +sed_quote_subst='$sed_quote_subst' + +# Be Bourne compatible +if test -n \"\${ZSH_VERSION+set}\" && (emulate sh) >/dev/null 2>&1; then + emulate sh + NULLCMD=: + # Zsh 3.x and 4.x performs word splitting on \${1+\"\$@\"}, which + # is contrary to our usage. Disable this feature. + alias -g '\${1+\"\$@\"}'='\"\$@\"' + setopt NO_GLOB_SUBST +else + case \`(set -o) 2>/dev/null\` in *posix*) set -o posix;; esac +fi +BIN_SH=xpg4; export BIN_SH # for Tru64 +DUALCASE=1; export DUALCASE # for MKS sh + +# The HP-UX ksh and POSIX shell print the target directory to stdout +# if CDPATH is set. +(unset CDPATH) >/dev/null 2>&1 && unset CDPATH + +relink_command=\"$relink_command\" + +# This environment variable determines our operation mode. +if test \"\$libtool_install_magic\" = \"$magic\"; then + # install mode needs the following variables: + generated_by_libtool_version='$macro_version' + notinst_deplibs='$notinst_deplibs' +else + # When we are sourced in execute mode, \$file and \$ECHO are already set. + if test \"\$libtool_execute_magic\" != \"$magic\"; then + file=\"\$0\"" + + qECHO=`$ECHO "$ECHO" | $SED "$sed_quote_subst"` + $ECHO "\ + +# A function that is used when there is no print builtin or printf. +func_fallback_echo () +{ + eval 'cat <<_LTECHO_EOF +\$1 +_LTECHO_EOF' +} + ECHO=\"$qECHO\" + fi + +# Very basic option parsing. These options are (a) specific to +# the libtool wrapper, (b) are identical between the wrapper +# /script/ and the wrapper /executable/ which is used only on +# windows platforms, and (c) all begin with the string "--lt-" +# (application programs are unlikely to have options which match +# this pattern). +# +# There are only two supported options: --lt-debug and +# --lt-dump-script. There is, deliberately, no --lt-help. +# +# The first argument to this parsing function should be the +# script's $0 value, followed by "$@". +lt_option_debug= +func_parse_lt_options () +{ + lt_script_arg0=\$0 + shift + for lt_opt + do + case \"\$lt_opt\" in + --lt-debug) lt_option_debug=1 ;; + --lt-dump-script) + lt_dump_D=\`\$ECHO \"X\$lt_script_arg0\" | $SED -e 's/^X//' -e 's%/[^/]*$%%'\` + test \"X\$lt_dump_D\" = \"X\$lt_script_arg0\" && lt_dump_D=. + lt_dump_F=\`\$ECHO \"X\$lt_script_arg0\" | $SED -e 's/^X//' -e 's%^.*/%%'\` + cat \"\$lt_dump_D/\$lt_dump_F\" + exit 0 + ;; + --lt-*) + \$ECHO \"Unrecognized --lt- option: '\$lt_opt'\" 1>&2 + exit 1 + ;; + esac + done + + # Print the debug banner immediately: + if test -n \"\$lt_option_debug\"; then + echo \"${outputname}:${output}:\${LINENO}: libtool wrapper (GNU $PACKAGE$TIMESTAMP) $VERSION\" 1>&2 + fi +} + +# Used when --lt-debug. Prints its arguments to stdout +# (redirection is the responsibility of the caller) +func_lt_dump_args () +{ + lt_dump_args_N=1; + for lt_arg + do + \$ECHO \"${outputname}:${output}:\${LINENO}: newargv[\$lt_dump_args_N]: \$lt_arg\" + lt_dump_args_N=\`expr \$lt_dump_args_N + 1\` + done +} + +# Core function for launching the target application +func_exec_program_core () +{ +" + case $host in + # Backslashes separate directories on plain windows + *-*-mingw | *-*-os2* | *-cegcc*) + $ECHO "\ + if test -n \"\$lt_option_debug\"; then + \$ECHO \"${outputname}:${output}:\${LINENO}: newargv[0]: \$progdir\\\\\$program\" 1>&2 + func_lt_dump_args \${1+\"\$@\"} 1>&2 + fi + exec \"\$progdir\\\\\$program\" \${1+\"\$@\"} +" + ;; + + *) + $ECHO "\ + if test -n \"\$lt_option_debug\"; then + \$ECHO \"${outputname}:${output}:\${LINENO}: newargv[0]: \$progdir/\$program\" 1>&2 + func_lt_dump_args \${1+\"\$@\"} 1>&2 + fi + exec \"\$progdir/\$program\" \${1+\"\$@\"} +" + ;; + esac + $ECHO "\ + \$ECHO \"\$0: cannot exec \$program \$*\" 1>&2 + exit 1 +} + +# A function to encapsulate launching the target application +# Strips options in the --lt-* namespace from \$@ and +# launches target application with the remaining arguments. +func_exec_program () +{ + case \" \$* \" in + *\\ --lt-*) + for lt_wr_arg + do + case \$lt_wr_arg in + --lt-*) ;; + *) set x \"\$@\" \"\$lt_wr_arg\"; shift;; + esac + shift + done ;; + esac + func_exec_program_core \${1+\"\$@\"} +} + + # Parse options + func_parse_lt_options \"\$0\" \${1+\"\$@\"} + + # Find the directory that this script lives in. + thisdir=\`\$ECHO \"\$file\" | $SED 's%/[^/]*$%%'\` + test \"x\$thisdir\" = \"x\$file\" && thisdir=. + + # Follow symbolic links until we get to the real thisdir. + file=\`ls -ld \"\$file\" | $SED -n 's/.*-> //p'\` + while test -n \"\$file\"; do + destdir=\`\$ECHO \"\$file\" | $SED 's%/[^/]*\$%%'\` + + # If there was a directory component, then change thisdir. + if test \"x\$destdir\" != \"x\$file\"; then + case \"\$destdir\" in + [\\\\/]* | [A-Za-z]:[\\\\/]*) thisdir=\"\$destdir\" ;; + *) thisdir=\"\$thisdir/\$destdir\" ;; + esac + fi + + file=\`\$ECHO \"\$file\" | $SED 's%^.*/%%'\` + file=\`ls -ld \"\$thisdir/\$file\" | $SED -n 's/.*-> //p'\` + done + + # Usually 'no', except on cygwin/mingw when embedded into + # the cwrapper. + WRAPPER_SCRIPT_BELONGS_IN_OBJDIR=$func_emit_wrapper_arg1 + if test \"\$WRAPPER_SCRIPT_BELONGS_IN_OBJDIR\" = \"yes\"; then + # special case for '.' + if test \"\$thisdir\" = \".\"; then + thisdir=\`pwd\` + fi + # remove .libs from thisdir + case \"\$thisdir\" in + *[\\\\/]$objdir ) thisdir=\`\$ECHO \"\$thisdir\" | $SED 's%[\\\\/][^\\\\/]*$%%'\` ;; + $objdir ) thisdir=. ;; + esac + fi + + # Try to get the absolute directory name. + absdir=\`cd \"\$thisdir\" && pwd\` + test -n \"\$absdir\" && thisdir=\"\$absdir\" +" + + if test "$fast_install" = yes; then + $ECHO "\ + program=lt-'$outputname'$exeext + progdir=\"\$thisdir/$objdir\" + + if test ! -f \"\$progdir/\$program\" || + { file=\`ls -1dt \"\$progdir/\$program\" \"\$progdir/../\$program\" 2>/dev/null | ${SED} 1q\`; \\ + test \"X\$file\" != \"X\$progdir/\$program\"; }; then + + file=\"\$\$-\$program\" + + if test ! -d \"\$progdir\"; then + $MKDIR \"\$progdir\" + else + $RM \"\$progdir/\$file\" + fi" + + $ECHO "\ + + # relink executable if necessary + if test -n \"\$relink_command\"; then + if relink_command_output=\`eval \$relink_command 2>&1\`; then : + else + $ECHO \"\$relink_command_output\" >&2 + $RM \"\$progdir/\$file\" + exit 1 + fi + fi + + $MV \"\$progdir/\$file\" \"\$progdir/\$program\" 2>/dev/null || + { $RM \"\$progdir/\$program\"; + $MV \"\$progdir/\$file\" \"\$progdir/\$program\"; } + $RM \"\$progdir/\$file\" + fi" + else + $ECHO "\ + program='$outputname' + progdir=\"\$thisdir/$objdir\" +" + fi + + $ECHO "\ + + if test -f \"\$progdir/\$program\"; then" + + # fixup the dll searchpath if we need to. + # + # Fix the DLL searchpath if we need to. Do this before prepending + # to shlibpath, because on Windows, both are PATH and uninstalled + # libraries must come first. + if test -n "$dllsearchpath"; then + $ECHO "\ + # Add the dll search path components to the executable PATH + PATH=$dllsearchpath:\$PATH +" + fi + + # Export our shlibpath_var if we have one. + if test "$shlibpath_overrides_runpath" = yes && test -n "$shlibpath_var" && test -n "$temp_rpath"; then + $ECHO "\ + # Add our own library path to $shlibpath_var + $shlibpath_var=\"$temp_rpath\$$shlibpath_var\" + + # Some systems cannot cope with colon-terminated $shlibpath_var + # The second colon is a workaround for a bug in BeOS R4 sed + $shlibpath_var=\`\$ECHO \"\$$shlibpath_var\" | $SED 's/::*\$//'\` + + export $shlibpath_var +" + fi + + $ECHO "\ + if test \"\$libtool_execute_magic\" != \"$magic\"; then + # Run the actual program with our arguments. + func_exec_program \${1+\"\$@\"} + fi + else + # The program doesn't exist. + \$ECHO \"\$0: error: \\\`\$progdir/\$program' does not exist\" 1>&2 + \$ECHO \"This script is just a wrapper for \$program.\" 1>&2 + \$ECHO \"See the $PACKAGE documentation for more information.\" 1>&2 + exit 1 + fi +fi\ +" +} + + +# func_emit_cwrapperexe_src +# emit the source code for a wrapper executable on stdout +# Must ONLY be called from within func_mode_link because +# it depends on a number of variable set therein. +func_emit_cwrapperexe_src () +{ + cat < +#include +#ifdef _MSC_VER +# include +# include +# include +#else +# include +# include +# ifdef __CYGWIN__ +# include +# endif +#endif +#include +#include +#include +#include +#include +#include +#include +#include + +/* declarations of non-ANSI functions */ +#if defined(__MINGW32__) +# ifdef __STRICT_ANSI__ +int _putenv (const char *); +# endif +#elif defined(__CYGWIN__) +# ifdef __STRICT_ANSI__ +char *realpath (const char *, char *); +int putenv (char *); +int setenv (const char *, const char *, int); +# endif +/* #elif defined (other platforms) ... */ +#endif + +/* portability defines, excluding path handling macros */ +#if defined(_MSC_VER) +# define setmode _setmode +# define stat _stat +# define chmod _chmod +# define getcwd _getcwd +# define putenv _putenv +# define S_IXUSR _S_IEXEC +# ifndef _INTPTR_T_DEFINED +# define _INTPTR_T_DEFINED +# define intptr_t int +# endif +#elif defined(__MINGW32__) +# define setmode _setmode +# define stat _stat +# define chmod _chmod +# define getcwd _getcwd +# define putenv _putenv +#elif defined(__CYGWIN__) +# define HAVE_SETENV +# define FOPEN_WB "wb" +/* #elif defined (other platforms) ... */ +#endif + +#if defined(PATH_MAX) +# define LT_PATHMAX PATH_MAX +#elif defined(MAXPATHLEN) +# define LT_PATHMAX MAXPATHLEN +#else +# define LT_PATHMAX 1024 +#endif + +#ifndef S_IXOTH +# define S_IXOTH 0 +#endif +#ifndef S_IXGRP +# define S_IXGRP 0 +#endif + +/* path handling portability macros */ +#ifndef DIR_SEPARATOR +# define DIR_SEPARATOR '/' +# define PATH_SEPARATOR ':' +#endif + +#if defined (_WIN32) || defined (__MSDOS__) || defined (__DJGPP__) || \ + defined (__OS2__) +# define HAVE_DOS_BASED_FILE_SYSTEM +# define FOPEN_WB "wb" +# ifndef DIR_SEPARATOR_2 +# define DIR_SEPARATOR_2 '\\' +# endif +# ifndef PATH_SEPARATOR_2 +# define PATH_SEPARATOR_2 ';' +# endif +#endif + +#ifndef DIR_SEPARATOR_2 +# define IS_DIR_SEPARATOR(ch) ((ch) == DIR_SEPARATOR) +#else /* DIR_SEPARATOR_2 */ +# define IS_DIR_SEPARATOR(ch) \ + (((ch) == DIR_SEPARATOR) || ((ch) == DIR_SEPARATOR_2)) +#endif /* DIR_SEPARATOR_2 */ + +#ifndef PATH_SEPARATOR_2 +# define IS_PATH_SEPARATOR(ch) ((ch) == PATH_SEPARATOR) +#else /* PATH_SEPARATOR_2 */ +# define IS_PATH_SEPARATOR(ch) ((ch) == PATH_SEPARATOR_2) +#endif /* PATH_SEPARATOR_2 */ + +#ifndef FOPEN_WB +# define FOPEN_WB "w" +#endif +#ifndef _O_BINARY +# define _O_BINARY 0 +#endif + +#define XMALLOC(type, num) ((type *) xmalloc ((num) * sizeof(type))) +#define XFREE(stale) do { \ + if (stale) { free ((void *) stale); stale = 0; } \ +} while (0) + +#if defined(LT_DEBUGWRAPPER) +static int lt_debug = 1; +#else +static int lt_debug = 0; +#endif + +const char *program_name = "libtool-wrapper"; /* in case xstrdup fails */ + +void *xmalloc (size_t num); +char *xstrdup (const char *string); +const char *base_name (const char *name); +char *find_executable (const char *wrapper); +char *chase_symlinks (const char *pathspec); +int make_executable (const char *path); +int check_executable (const char *path); +char *strendzap (char *str, const char *pat); +void lt_debugprintf (const char *file, int line, const char *fmt, ...); +void lt_fatal (const char *file, int line, const char *message, ...); +static const char *nonnull (const char *s); +static const char *nonempty (const char *s); +void lt_setenv (const char *name, const char *value); +char *lt_extend_str (const char *orig_value, const char *add, int to_end); +void lt_update_exe_path (const char *name, const char *value); +void lt_update_lib_path (const char *name, const char *value); +char **prepare_spawn (char **argv); +void lt_dump_script (FILE *f); +EOF + + cat <= 0) + && (st.st_mode & (S_IXUSR | S_IXGRP | S_IXOTH))) + return 1; + else + return 0; +} + +int +make_executable (const char *path) +{ + int rval = 0; + struct stat st; + + lt_debugprintf (__FILE__, __LINE__, "(make_executable): %s\n", + nonempty (path)); + if ((!path) || (!*path)) + return 0; + + if (stat (path, &st) >= 0) + { + rval = chmod (path, st.st_mode | S_IXOTH | S_IXGRP | S_IXUSR); + } + return rval; +} + +/* Searches for the full path of the wrapper. Returns + newly allocated full path name if found, NULL otherwise + Does not chase symlinks, even on platforms that support them. +*/ +char * +find_executable (const char *wrapper) +{ + int has_slash = 0; + const char *p; + const char *p_next; + /* static buffer for getcwd */ + char tmp[LT_PATHMAX + 1]; + int tmp_len; + char *concat_name; + + lt_debugprintf (__FILE__, __LINE__, "(find_executable): %s\n", + nonempty (wrapper)); + + if ((wrapper == NULL) || (*wrapper == '\0')) + return NULL; + + /* Absolute path? */ +#if defined (HAVE_DOS_BASED_FILE_SYSTEM) + if (isalpha ((unsigned char) wrapper[0]) && wrapper[1] == ':') + { + concat_name = xstrdup (wrapper); + if (check_executable (concat_name)) + return concat_name; + XFREE (concat_name); + } + else + { +#endif + if (IS_DIR_SEPARATOR (wrapper[0])) + { + concat_name = xstrdup (wrapper); + if (check_executable (concat_name)) + return concat_name; + XFREE (concat_name); + } +#if defined (HAVE_DOS_BASED_FILE_SYSTEM) + } +#endif + + for (p = wrapper; *p; p++) + if (*p == '/') + { + has_slash = 1; + break; + } + if (!has_slash) + { + /* no slashes; search PATH */ + const char *path = getenv ("PATH"); + if (path != NULL) + { + for (p = path; *p; p = p_next) + { + const char *q; + size_t p_len; + for (q = p; *q; q++) + if (IS_PATH_SEPARATOR (*q)) + break; + p_len = q - p; + p_next = (*q == '\0' ? q : q + 1); + if (p_len == 0) + { + /* empty path: current directory */ + if (getcwd (tmp, LT_PATHMAX) == NULL) + lt_fatal (__FILE__, __LINE__, "getcwd failed: %s", + nonnull (strerror (errno))); + tmp_len = strlen (tmp); + concat_name = + XMALLOC (char, tmp_len + 1 + strlen (wrapper) + 1); + memcpy (concat_name, tmp, tmp_len); + concat_name[tmp_len] = '/'; + strcpy (concat_name + tmp_len + 1, wrapper); + } + else + { + concat_name = + XMALLOC (char, p_len + 1 + strlen (wrapper) + 1); + memcpy (concat_name, p, p_len); + concat_name[p_len] = '/'; + strcpy (concat_name + p_len + 1, wrapper); + } + if (check_executable (concat_name)) + return concat_name; + XFREE (concat_name); + } + } + /* not found in PATH; assume curdir */ + } + /* Relative path | not found in path: prepend cwd */ + if (getcwd (tmp, LT_PATHMAX) == NULL) + lt_fatal (__FILE__, __LINE__, "getcwd failed: %s", + nonnull (strerror (errno))); + tmp_len = strlen (tmp); + concat_name = XMALLOC (char, tmp_len + 1 + strlen (wrapper) + 1); + memcpy (concat_name, tmp, tmp_len); + concat_name[tmp_len] = '/'; + strcpy (concat_name + tmp_len + 1, wrapper); + + if (check_executable (concat_name)) + return concat_name; + XFREE (concat_name); + return NULL; +} + +char * +chase_symlinks (const char *pathspec) +{ +#ifndef S_ISLNK + return xstrdup (pathspec); +#else + char buf[LT_PATHMAX]; + struct stat s; + char *tmp_pathspec = xstrdup (pathspec); + char *p; + int has_symlinks = 0; + while (strlen (tmp_pathspec) && !has_symlinks) + { + lt_debugprintf (__FILE__, __LINE__, + "checking path component for symlinks: %s\n", + tmp_pathspec); + if (lstat (tmp_pathspec, &s) == 0) + { + if (S_ISLNK (s.st_mode) != 0) + { + has_symlinks = 1; + break; + } + + /* search backwards for last DIR_SEPARATOR */ + p = tmp_pathspec + strlen (tmp_pathspec) - 1; + while ((p > tmp_pathspec) && (!IS_DIR_SEPARATOR (*p))) + p--; + if ((p == tmp_pathspec) && (!IS_DIR_SEPARATOR (*p))) + { + /* no more DIR_SEPARATORS left */ + break; + } + *p = '\0'; + } + else + { + lt_fatal (__FILE__, __LINE__, + "error accessing file \"%s\": %s", + tmp_pathspec, nonnull (strerror (errno))); + } + } + XFREE (tmp_pathspec); + + if (!has_symlinks) + { + return xstrdup (pathspec); + } + + tmp_pathspec = realpath (pathspec, buf); + if (tmp_pathspec == 0) + { + lt_fatal (__FILE__, __LINE__, + "could not follow symlinks for %s", pathspec); + } + return xstrdup (tmp_pathspec); +#endif +} + +char * +strendzap (char *str, const char *pat) +{ + size_t len, patlen; + + assert (str != NULL); + assert (pat != NULL); + + len = strlen (str); + patlen = strlen (pat); + + if (patlen <= len) + { + str += len - patlen; + if (strcmp (str, pat) == 0) + *str = '\0'; + } + return str; +} + +void +lt_debugprintf (const char *file, int line, const char *fmt, ...) +{ + va_list args; + if (lt_debug) + { + (void) fprintf (stderr, "%s:%s:%d: ", program_name, file, line); + va_start (args, fmt); + (void) vfprintf (stderr, fmt, args); + va_end (args); + } +} + +static void +lt_error_core (int exit_status, const char *file, + int line, const char *mode, + const char *message, va_list ap) +{ + fprintf (stderr, "%s:%s:%d: %s: ", program_name, file, line, mode); + vfprintf (stderr, message, ap); + fprintf (stderr, ".\n"); + + if (exit_status >= 0) + exit (exit_status); +} + +void +lt_fatal (const char *file, int line, const char *message, ...) +{ + va_list ap; + va_start (ap, message); + lt_error_core (EXIT_FAILURE, file, line, "FATAL", message, ap); + va_end (ap); +} + +static const char * +nonnull (const char *s) +{ + return s ? s : "(null)"; +} + +static const char * +nonempty (const char *s) +{ + return (s && !*s) ? "(empty)" : nonnull (s); +} + +void +lt_setenv (const char *name, const char *value) +{ + lt_debugprintf (__FILE__, __LINE__, + "(lt_setenv) setting '%s' to '%s'\n", + nonnull (name), nonnull (value)); + { +#ifdef HAVE_SETENV + /* always make a copy, for consistency with !HAVE_SETENV */ + char *str = xstrdup (value); + setenv (name, str, 1); +#else + int len = strlen (name) + 1 + strlen (value) + 1; + char *str = XMALLOC (char, len); + sprintf (str, "%s=%s", name, value); + if (putenv (str) != EXIT_SUCCESS) + { + XFREE (str); + } +#endif + } +} + +char * +lt_extend_str (const char *orig_value, const char *add, int to_end) +{ + char *new_value; + if (orig_value && *orig_value) + { + int orig_value_len = strlen (orig_value); + int add_len = strlen (add); + new_value = XMALLOC (char, add_len + orig_value_len + 1); + if (to_end) + { + strcpy (new_value, orig_value); + strcpy (new_value + orig_value_len, add); + } + else + { + strcpy (new_value, add); + strcpy (new_value + add_len, orig_value); + } + } + else + { + new_value = xstrdup (add); + } + return new_value; +} + +void +lt_update_exe_path (const char *name, const char *value) +{ + lt_debugprintf (__FILE__, __LINE__, + "(lt_update_exe_path) modifying '%s' by prepending '%s'\n", + nonnull (name), nonnull (value)); + + if (name && *name && value && *value) + { + char *new_value = lt_extend_str (getenv (name), value, 0); + /* some systems can't cope with a ':'-terminated path #' */ + int len = strlen (new_value); + while (((len = strlen (new_value)) > 0) && IS_PATH_SEPARATOR (new_value[len-1])) + { + new_value[len-1] = '\0'; + } + lt_setenv (name, new_value); + XFREE (new_value); + } +} + +void +lt_update_lib_path (const char *name, const char *value) +{ + lt_debugprintf (__FILE__, __LINE__, + "(lt_update_lib_path) modifying '%s' by prepending '%s'\n", + nonnull (name), nonnull (value)); + + if (name && *name && value && *value) + { + char *new_value = lt_extend_str (getenv (name), value, 0); + lt_setenv (name, new_value); + XFREE (new_value); + } +} + +EOF + case $host_os in + mingw*) + cat <<"EOF" + +/* Prepares an argument vector before calling spawn(). + Note that spawn() does not by itself call the command interpreter + (getenv ("COMSPEC") != NULL ? getenv ("COMSPEC") : + ({ OSVERSIONINFO v; v.dwOSVersionInfoSize = sizeof(OSVERSIONINFO); + GetVersionEx(&v); + v.dwPlatformId == VER_PLATFORM_WIN32_NT; + }) ? "cmd.exe" : "command.com"). + Instead it simply concatenates the arguments, separated by ' ', and calls + CreateProcess(). We must quote the arguments since Win32 CreateProcess() + interprets characters like ' ', '\t', '\\', '"' (but not '<' and '>') in a + special way: + - Space and tab are interpreted as delimiters. They are not treated as + delimiters if they are surrounded by double quotes: "...". + - Unescaped double quotes are removed from the input. Their only effect is + that within double quotes, space and tab are treated like normal + characters. + - Backslashes not followed by double quotes are not special. + - But 2*n+1 backslashes followed by a double quote become + n backslashes followed by a double quote (n >= 0): + \" -> " + \\\" -> \" + \\\\\" -> \\" + */ +#define SHELL_SPECIAL_CHARS "\"\\ \001\002\003\004\005\006\007\010\011\012\013\014\015\016\017\020\021\022\023\024\025\026\027\030\031\032\033\034\035\036\037" +#define SHELL_SPACE_CHARS " \001\002\003\004\005\006\007\010\011\012\013\014\015\016\017\020\021\022\023\024\025\026\027\030\031\032\033\034\035\036\037" +char ** +prepare_spawn (char **argv) +{ + size_t argc; + char **new_argv; + size_t i; + + /* Count number of arguments. */ + for (argc = 0; argv[argc] != NULL; argc++) + ; + + /* Allocate new argument vector. */ + new_argv = XMALLOC (char *, argc + 1); + + /* Put quoted arguments into the new argument vector. */ + for (i = 0; i < argc; i++) + { + const char *string = argv[i]; + + if (string[0] == '\0') + new_argv[i] = xstrdup ("\"\""); + else if (strpbrk (string, SHELL_SPECIAL_CHARS) != NULL) + { + int quote_around = (strpbrk (string, SHELL_SPACE_CHARS) != NULL); + size_t length; + unsigned int backslashes; + const char *s; + char *quoted_string; + char *p; + + length = 0; + backslashes = 0; + if (quote_around) + length++; + for (s = string; *s != '\0'; s++) + { + char c = *s; + if (c == '"') + length += backslashes + 1; + length++; + if (c == '\\') + backslashes++; + else + backslashes = 0; + } + if (quote_around) + length += backslashes + 1; + + quoted_string = XMALLOC (char, length + 1); + + p = quoted_string; + backslashes = 0; + if (quote_around) + *p++ = '"'; + for (s = string; *s != '\0'; s++) + { + char c = *s; + if (c == '"') + { + unsigned int j; + for (j = backslashes + 1; j > 0; j--) + *p++ = '\\'; + } + *p++ = c; + if (c == '\\') + backslashes++; + else + backslashes = 0; + } + if (quote_around) + { + unsigned int j; + for (j = backslashes; j > 0; j--) + *p++ = '\\'; + *p++ = '"'; + } + *p = '\0'; + + new_argv[i] = quoted_string; + } + else + new_argv[i] = (char *) string; + } + new_argv[argc] = NULL; + + return new_argv; +} +EOF + ;; + esac + + cat <<"EOF" +void lt_dump_script (FILE* f) +{ +EOF + func_emit_wrapper yes | + $SED -n -e ' +s/^\(.\{79\}\)\(..*\)/\1\ +\2/ +h +s/\([\\"]\)/\\\1/g +s/$/\\n/ +s/\([^\n]*\).*/ fputs ("\1", f);/p +g +D' + cat <<"EOF" +} +EOF +} +# end: func_emit_cwrapperexe_src + +# func_win32_import_lib_p ARG +# True if ARG is an import lib, as indicated by $file_magic_cmd +func_win32_import_lib_p () +{ + $opt_debug + case `eval $file_magic_cmd \"\$1\" 2>/dev/null | $SED -e 10q` in + *import*) : ;; + *) false ;; + esac +} + +# func_mode_link arg... +func_mode_link () +{ + $opt_debug + case $host in + *-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-os2* | *-cegcc*) + # It is impossible to link a dll without this setting, and + # we shouldn't force the makefile maintainer to figure out + # which system we are compiling for in order to pass an extra + # flag for every libtool invocation. + # allow_undefined=no + + # FIXME: Unfortunately, there are problems with the above when trying + # to make a dll which has undefined symbols, in which case not + # even a static library is built. For now, we need to specify + # -no-undefined on the libtool link line when we can be certain + # that all symbols are satisfied, otherwise we get a static library. + allow_undefined=yes + ;; + *) + allow_undefined=yes + ;; + esac + libtool_args=$nonopt + base_compile="$nonopt $@" + compile_command=$nonopt + finalize_command=$nonopt + + compile_rpath= + finalize_rpath= + compile_shlibpath= + finalize_shlibpath= + convenience= + old_convenience= + deplibs= + old_deplibs= + compiler_flags= + linker_flags= + dllsearchpath= + lib_search_path=`pwd` + inst_prefix_dir= + new_inherited_linker_flags= + + avoid_version=no + bindir= + dlfiles= + dlprefiles= + dlself=no + export_dynamic=no + export_symbols= + export_symbols_regex= + generated= + libobjs= + ltlibs= + module=no + no_install=no + objs= + non_pic_objects= + precious_files_regex= + prefer_static_libs=no + preload=no + prev= + prevarg= + release= + rpath= + xrpath= + perm_rpath= + temp_rpath= + thread_safe=no + vinfo= + vinfo_number=no + weak_libs= + single_module="${wl}-single_module" + func_infer_tag $base_compile + + # We need to know -static, to get the right output filenames. + for arg + do + case $arg in + -shared) + test "$build_libtool_libs" != yes && \ + func_fatal_configuration "can not build a shared library" + build_old_libs=no + break + ;; + -all-static | -static | -static-libtool-libs) + case $arg in + -all-static) + if test "$build_libtool_libs" = yes && test -z "$link_static_flag"; then + func_warning "complete static linking is impossible in this configuration" + fi + if test -n "$link_static_flag"; then + dlopen_self=$dlopen_self_static + fi + prefer_static_libs=yes + ;; + -static) + if test -z "$pic_flag" && test -n "$link_static_flag"; then + dlopen_self=$dlopen_self_static + fi + prefer_static_libs=built + ;; + -static-libtool-libs) + if test -z "$pic_flag" && test -n "$link_static_flag"; then + dlopen_self=$dlopen_self_static + fi + prefer_static_libs=yes + ;; + esac + build_libtool_libs=no + build_old_libs=yes + break + ;; + esac + done + + # See if our shared archives depend on static archives. + test -n "$old_archive_from_new_cmds" && build_old_libs=yes + + # Go through the arguments, transforming them on the way. + while test "$#" -gt 0; do + arg="$1" + shift + func_quote_for_eval "$arg" + qarg=$func_quote_for_eval_unquoted_result + libtool_args+=" $func_quote_for_eval_result" + + # If the previous option needs an argument, assign it. + if test -n "$prev"; then + case $prev in + output) + compile_command+=" @OUTPUT@" + finalize_command+=" @OUTPUT@" + ;; + esac + + case $prev in + bindir) + bindir="$arg" + prev= + continue + ;; + dlfiles|dlprefiles) + if test "$preload" = no; then + # Add the symbol object into the linking commands. + compile_command+=" @SYMFILE@" + finalize_command+=" @SYMFILE@" + preload=yes + fi + case $arg in + *.la | *.lo) ;; # We handle these cases below. + force) + if test "$dlself" = no; then + dlself=needless + export_dynamic=yes + fi + prev= + continue + ;; + self) + if test "$prev" = dlprefiles; then + dlself=yes + elif test "$prev" = dlfiles && test "$dlopen_self" != yes; then + dlself=yes + else + dlself=needless + export_dynamic=yes + fi + prev= + continue + ;; + *) + if test "$prev" = dlfiles; then + dlfiles+=" $arg" + else + dlprefiles+=" $arg" + fi + prev= + continue + ;; + esac + ;; + expsyms) + export_symbols="$arg" + test -f "$arg" \ + || func_fatal_error "symbol file \`$arg' does not exist" + prev= + continue + ;; + expsyms_regex) + export_symbols_regex="$arg" + prev= + continue + ;; + framework) + case $host in + *-*-darwin*) + case "$deplibs " in + *" $qarg.ltframework "*) ;; + *) deplibs+=" $qarg.ltframework" # this is fixed later + ;; + esac + ;; + esac + prev= + continue + ;; + inst_prefix) + inst_prefix_dir="$arg" + prev= + continue + ;; + objectlist) + if test -f "$arg"; then + save_arg=$arg + moreargs= + for fil in `cat "$save_arg"` + do +# moreargs+=" $fil" + arg=$fil + # A libtool-controlled object. + + # Check to see that this really is a libtool object. + if func_lalib_unsafe_p "$arg"; then + pic_object= + non_pic_object= + + # Read the .lo file + func_source "$arg" + + if test -z "$pic_object" || + test -z "$non_pic_object" || + test "$pic_object" = none && + test "$non_pic_object" = none; then + func_fatal_error "cannot find name of object for \`$arg'" + fi + + # Extract subdirectory from the argument. + func_dirname "$arg" "/" "" + xdir="$func_dirname_result" + + if test "$pic_object" != none; then + # Prepend the subdirectory the object is found in. + pic_object="$xdir$pic_object" + + if test "$prev" = dlfiles; then + if test "$build_libtool_libs" = yes && test "$dlopen_support" = yes; then + dlfiles+=" $pic_object" + prev= + continue + else + # If libtool objects are unsupported, then we need to preload. + prev=dlprefiles + fi + fi + + # CHECK ME: I think I busted this. -Ossama + if test "$prev" = dlprefiles; then + # Preload the old-style object. + dlprefiles+=" $pic_object" + prev= + fi + + # A PIC object. + libobjs+=" $pic_object" + arg="$pic_object" + fi + + # Non-PIC object. + if test "$non_pic_object" != none; then + # Prepend the subdirectory the object is found in. + non_pic_object="$xdir$non_pic_object" + + # A standard non-PIC object + non_pic_objects+=" $non_pic_object" + if test -z "$pic_object" || test "$pic_object" = none ; then + arg="$non_pic_object" + fi + else + # If the PIC object exists, use it instead. + # $xdir was prepended to $pic_object above. + non_pic_object="$pic_object" + non_pic_objects+=" $non_pic_object" + fi + else + # Only an error if not doing a dry-run. + if $opt_dry_run; then + # Extract subdirectory from the argument. + func_dirname "$arg" "/" "" + xdir="$func_dirname_result" + + func_lo2o "$arg" + pic_object=$xdir$objdir/$func_lo2o_result + non_pic_object=$xdir$func_lo2o_result + libobjs+=" $pic_object" + non_pic_objects+=" $non_pic_object" + else + func_fatal_error "\`$arg' is not a valid libtool object" + fi + fi + done + else + func_fatal_error "link input file \`$arg' does not exist" + fi + arg=$save_arg + prev= + continue + ;; + precious_regex) + precious_files_regex="$arg" + prev= + continue + ;; + release) + release="-$arg" + prev= + continue + ;; + rpath | xrpath) + # We need an absolute path. + case $arg in + [\\/]* | [A-Za-z]:[\\/]*) ;; + *) + func_fatal_error "only absolute run-paths are allowed" + ;; + esac + if test "$prev" = rpath; then + case "$rpath " in + *" $arg "*) ;; + *) rpath+=" $arg" ;; + esac + else + case "$xrpath " in + *" $arg "*) ;; + *) xrpath+=" $arg" ;; + esac + fi + prev= + continue + ;; + shrext) + shrext_cmds="$arg" + prev= + continue + ;; + weak) + weak_libs+=" $arg" + prev= + continue + ;; + xcclinker) + linker_flags+=" $qarg" + compiler_flags+=" $qarg" + prev= + compile_command+=" $qarg" + finalize_command+=" $qarg" + continue + ;; + xcompiler) + compiler_flags+=" $qarg" + prev= + compile_command+=" $qarg" + finalize_command+=" $qarg" + continue + ;; + xlinker) + linker_flags+=" $qarg" + compiler_flags+=" $wl$qarg" + prev= + compile_command+=" $wl$qarg" + finalize_command+=" $wl$qarg" + continue + ;; + *) + eval "$prev=\"\$arg\"" + prev= + continue + ;; + esac + fi # test -n "$prev" + + prevarg="$arg" + + case $arg in + -all-static) + if test -n "$link_static_flag"; then + # See comment for -static flag below, for more details. + compile_command+=" $link_static_flag" + finalize_command+=" $link_static_flag" + fi + continue + ;; + + -allow-undefined) + # FIXME: remove this flag sometime in the future. + func_fatal_error "\`-allow-undefined' must not be used because it is the default" + ;; + + -avoid-version) + avoid_version=yes + continue + ;; + + -bindir) + prev=bindir + continue + ;; + + -dlopen) + prev=dlfiles + continue + ;; + + -dlpreopen) + prev=dlprefiles + continue + ;; + + -export-dynamic) + export_dynamic=yes + continue + ;; + + -export-symbols | -export-symbols-regex) + if test -n "$export_symbols" || test -n "$export_symbols_regex"; then + func_fatal_error "more than one -exported-symbols argument is not allowed" + fi + if test "X$arg" = "X-export-symbols"; then + prev=expsyms + else + prev=expsyms_regex + fi + continue + ;; + + -framework) + prev=framework + continue + ;; + + -inst-prefix-dir) + prev=inst_prefix + continue + ;; + + # The native IRIX linker understands -LANG:*, -LIST:* and -LNO:* + # so, if we see these flags be careful not to treat them like -L + -L[A-Z][A-Z]*:*) + case $with_gcc/$host in + no/*-*-irix* | /*-*-irix*) + compile_command+=" $arg" + finalize_command+=" $arg" + ;; + esac + continue + ;; + + -L*) + func_stripname "-L" '' "$arg" + if test -z "$func_stripname_result"; then + if test "$#" -gt 0; then + func_fatal_error "require no space between \`-L' and \`$1'" + else + func_fatal_error "need path for \`-L' option" + fi + fi + func_resolve_sysroot "$func_stripname_result" + dir=$func_resolve_sysroot_result + # We need an absolute path. + case $dir in + [\\/]* | [A-Za-z]:[\\/]*) ;; + *) + absdir=`cd "$dir" && pwd` + test -z "$absdir" && \ + func_fatal_error "cannot determine absolute directory name of \`$dir'" + dir="$absdir" + ;; + esac + case "$deplibs " in + *" -L$dir "* | *" $arg "*) + # Will only happen for absolute or sysroot arguments + ;; + *) + # Preserve sysroot, but never include relative directories + case $dir in + [\\/]* | [A-Za-z]:[\\/]* | =*) deplibs+=" $arg" ;; + *) deplibs+=" -L$dir" ;; + esac + lib_search_path+=" $dir" + ;; + esac + case $host in + *-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-os2* | *-cegcc*) + testbindir=`$ECHO "$dir" | $SED 's*/lib$*/bin*'` + case :$dllsearchpath: in + *":$dir:"*) ;; + ::) dllsearchpath=$dir;; + *) dllsearchpath+=":$dir";; + esac + case :$dllsearchpath: in + *":$testbindir:"*) ;; + ::) dllsearchpath=$testbindir;; + *) dllsearchpath+=":$testbindir";; + esac + ;; + esac + continue + ;; + + -l*) + if test "X$arg" = "X-lc" || test "X$arg" = "X-lm"; then + case $host in + *-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-beos* | *-cegcc* | *-*-haiku*) + # These systems don't actually have a C or math library (as such) + continue + ;; + *-*-os2*) + # These systems don't actually have a C library (as such) + test "X$arg" = "X-lc" && continue + ;; + *-*-openbsd* | *-*-freebsd* | *-*-dragonfly*) + # Do not include libc due to us having libc/libc_r. + test "X$arg" = "X-lc" && continue + ;; + *-*-rhapsody* | *-*-darwin1.[012]) + # Rhapsody C and math libraries are in the System framework + deplibs+=" System.ltframework" + continue + ;; + *-*-sco3.2v5* | *-*-sco5v6*) + # Causes problems with __ctype + test "X$arg" = "X-lc" && continue + ;; + *-*-sysv4.2uw2* | *-*-sysv5* | *-*-unixware* | *-*-OpenUNIX*) + # Compiler inserts libc in the correct place for threads to work + test "X$arg" = "X-lc" && continue + ;; + esac + elif test "X$arg" = "X-lc_r"; then + case $host in + *-*-openbsd* | *-*-freebsd* | *-*-dragonfly*) + # Do not include libc_r directly, use -pthread flag. + continue + ;; + esac + fi + deplibs+=" $arg" + continue + ;; + + -module) + module=yes + continue + ;; + + # Tru64 UNIX uses -model [arg] to determine the layout of C++ + # classes, name mangling, and exception handling. + # Darwin uses the -arch flag to determine output architecture. + -model|-arch|-isysroot|--sysroot) + compiler_flags+=" $arg" + compile_command+=" $arg" + finalize_command+=" $arg" + prev=xcompiler + continue + ;; + + -mt|-mthreads|-kthread|-Kthread|-pthread|-pthreads|--thread-safe \ + |-threads|-fopenmp|-openmp|-mp|-xopenmp|-omp|-qsmp=*) + compiler_flags+=" $arg" + compile_command+=" $arg" + finalize_command+=" $arg" + case "$new_inherited_linker_flags " in + *" $arg "*) ;; + * ) new_inherited_linker_flags+=" $arg" ;; + esac + continue + ;; + + -multi_module) + single_module="${wl}-multi_module" + continue + ;; + + -no-fast-install) + fast_install=no + continue + ;; + + -no-install) + case $host in + *-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-os2* | *-*-darwin* | *-cegcc*) + # The PATH hackery in wrapper scripts is required on Windows + # and Darwin in order for the loader to find any dlls it needs. + func_warning "\`-no-install' is ignored for $host" + func_warning "assuming \`-no-fast-install' instead" + fast_install=no + ;; + *) no_install=yes ;; + esac + continue + ;; + + -no-undefined) + allow_undefined=no + continue + ;; + + -objectlist) + prev=objectlist + continue + ;; + + -o) prev=output ;; + + -precious-files-regex) + prev=precious_regex + continue + ;; + + -release) + prev=release + continue + ;; + + -rpath) + prev=rpath + continue + ;; + + -R) + prev=xrpath + continue + ;; + + -R*) + func_stripname '-R' '' "$arg" + dir=$func_stripname_result + # We need an absolute path. + case $dir in + [\\/]* | [A-Za-z]:[\\/]*) ;; + =*) + func_stripname '=' '' "$dir" + dir=$lt_sysroot$func_stripname_result + ;; + *) + func_fatal_error "only absolute run-paths are allowed" + ;; + esac + case "$xrpath " in + *" $dir "*) ;; + *) xrpath+=" $dir" ;; + esac + continue + ;; + + -shared) + # The effects of -shared are defined in a previous loop. + continue + ;; + + -shrext) + prev=shrext + continue + ;; + + -static | -static-libtool-libs) + # The effects of -static are defined in a previous loop. + # We used to do the same as -all-static on platforms that + # didn't have a PIC flag, but the assumption that the effects + # would be equivalent was wrong. It would break on at least + # Digital Unix and AIX. + continue + ;; + + -thread-safe) + thread_safe=yes + continue + ;; + + -version-info) + prev=vinfo + continue + ;; + + -version-number) + prev=vinfo + vinfo_number=yes + continue + ;; + + -weak) + prev=weak + continue + ;; + + -Wc,*) + func_stripname '-Wc,' '' "$arg" + args=$func_stripname_result + arg= + save_ifs="$IFS"; IFS=',' + for flag in $args; do + IFS="$save_ifs" + func_quote_for_eval "$flag" + arg+=" $func_quote_for_eval_result" + compiler_flags+=" $func_quote_for_eval_result" + done + IFS="$save_ifs" + func_stripname ' ' '' "$arg" + arg=$func_stripname_result + ;; + + -Wl,*) + func_stripname '-Wl,' '' "$arg" + args=$func_stripname_result + arg= + save_ifs="$IFS"; IFS=',' + for flag in $args; do + IFS="$save_ifs" + func_quote_for_eval "$flag" + arg+=" $wl$func_quote_for_eval_result" + compiler_flags+=" $wl$func_quote_for_eval_result" + linker_flags+=" $func_quote_for_eval_result" + done + IFS="$save_ifs" + func_stripname ' ' '' "$arg" + arg=$func_stripname_result + ;; + + -Xcompiler) + prev=xcompiler + continue + ;; + + -Xlinker) + prev=xlinker + continue + ;; + + -XCClinker) + prev=xcclinker + continue + ;; + + # -msg_* for osf cc + -msg_*) + func_quote_for_eval "$arg" + arg="$func_quote_for_eval_result" + ;; + + # Flags to be passed through unchanged, with rationale: + # -64, -mips[0-9] enable 64-bit mode for the SGI compiler + # -r[0-9][0-9]* specify processor for the SGI compiler + # -xarch=*, -xtarget=* enable 64-bit mode for the Sun compiler + # +DA*, +DD* enable 64-bit mode for the HP compiler + # -q* compiler args for the IBM compiler + # -m*, -t[45]*, -txscale* architecture-specific flags for GCC + # -F/path path to uninstalled frameworks, gcc on darwin + # -p, -pg, --coverage, -fprofile-* profiling flags for GCC + # @file GCC response files + # -tp=* Portland pgcc target processor selection + # --sysroot=* for sysroot support + # -O*, -flto*, -fwhopr*, -fuse-linker-plugin GCC link-time optimization + -64|-mips[0-9]|-r[0-9][0-9]*|-xarch=*|-xtarget=*|+DA*|+DD*|-q*|-m*| \ + -t[45]*|-txscale*|-p|-pg|--coverage|-fprofile-*|-F*|@*|-tp=*|--sysroot=*| \ + -O*|-flto*|-fwhopr*|-fuse-linker-plugin) + func_quote_for_eval "$arg" + arg="$func_quote_for_eval_result" + compile_command+=" $arg" + finalize_command+=" $arg" + compiler_flags+=" $arg" + continue + ;; + + # Some other compiler flag. + -* | +*) + func_quote_for_eval "$arg" + arg="$func_quote_for_eval_result" + ;; + + *.$objext) + # A standard object. + objs+=" $arg" + ;; + + *.lo) + # A libtool-controlled object. + + # Check to see that this really is a libtool object. + if func_lalib_unsafe_p "$arg"; then + pic_object= + non_pic_object= + + # Read the .lo file + func_source "$arg" + + if test -z "$pic_object" || + test -z "$non_pic_object" || + test "$pic_object" = none && + test "$non_pic_object" = none; then + func_fatal_error "cannot find name of object for \`$arg'" + fi + + # Extract subdirectory from the argument. + func_dirname "$arg" "/" "" + xdir="$func_dirname_result" + + if test "$pic_object" != none; then + # Prepend the subdirectory the object is found in. + pic_object="$xdir$pic_object" + + if test "$prev" = dlfiles; then + if test "$build_libtool_libs" = yes && test "$dlopen_support" = yes; then + dlfiles+=" $pic_object" + prev= + continue + else + # If libtool objects are unsupported, then we need to preload. + prev=dlprefiles + fi + fi + + # CHECK ME: I think I busted this. -Ossama + if test "$prev" = dlprefiles; then + # Preload the old-style object. + dlprefiles+=" $pic_object" + prev= + fi + + # A PIC object. + libobjs+=" $pic_object" + arg="$pic_object" + fi + + # Non-PIC object. + if test "$non_pic_object" != none; then + # Prepend the subdirectory the object is found in. + non_pic_object="$xdir$non_pic_object" + + # A standard non-PIC object + non_pic_objects+=" $non_pic_object" + if test -z "$pic_object" || test "$pic_object" = none ; then + arg="$non_pic_object" + fi + else + # If the PIC object exists, use it instead. + # $xdir was prepended to $pic_object above. + non_pic_object="$pic_object" + non_pic_objects+=" $non_pic_object" + fi + else + # Only an error if not doing a dry-run. + if $opt_dry_run; then + # Extract subdirectory from the argument. + func_dirname "$arg" "/" "" + xdir="$func_dirname_result" + + func_lo2o "$arg" + pic_object=$xdir$objdir/$func_lo2o_result + non_pic_object=$xdir$func_lo2o_result + libobjs+=" $pic_object" + non_pic_objects+=" $non_pic_object" + else + func_fatal_error "\`$arg' is not a valid libtool object" + fi + fi + ;; + + *.$libext) + # An archive. + deplibs+=" $arg" + old_deplibs+=" $arg" + continue + ;; + + *.la) + # A libtool-controlled library. + + func_resolve_sysroot "$arg" + if test "$prev" = dlfiles; then + # This library was specified with -dlopen. + dlfiles+=" $func_resolve_sysroot_result" + prev= + elif test "$prev" = dlprefiles; then + # The library was specified with -dlpreopen. + dlprefiles+=" $func_resolve_sysroot_result" + prev= + else + deplibs+=" $func_resolve_sysroot_result" + fi + continue + ;; + + # Some other compiler argument. + *) + # Unknown arguments in both finalize_command and compile_command need + # to be aesthetically quoted because they are evaled later. + func_quote_for_eval "$arg" + arg="$func_quote_for_eval_result" + ;; + esac # arg + + # Now actually substitute the argument into the commands. + if test -n "$arg"; then + compile_command+=" $arg" + finalize_command+=" $arg" + fi + done # argument parsing loop + + test -n "$prev" && \ + func_fatal_help "the \`$prevarg' option requires an argument" + + if test "$export_dynamic" = yes && test -n "$export_dynamic_flag_spec"; then + eval arg=\"$export_dynamic_flag_spec\" + compile_command+=" $arg" + finalize_command+=" $arg" + fi + + oldlibs= + # calculate the name of the file, without its directory + func_basename "$output" + outputname="$func_basename_result" + libobjs_save="$libobjs" + + if test -n "$shlibpath_var"; then + # get the directories listed in $shlibpath_var + eval shlib_search_path=\`\$ECHO \"\${$shlibpath_var}\" \| \$SED \'s/:/ /g\'\` + else + shlib_search_path= + fi + eval sys_lib_search_path=\"$sys_lib_search_path_spec\" + eval sys_lib_dlsearch_path=\"$sys_lib_dlsearch_path_spec\" + + func_dirname "$output" "/" "" + output_objdir="$func_dirname_result$objdir" + func_to_tool_file "$output_objdir/" + tool_output_objdir=$func_to_tool_file_result + # Create the object directory. + func_mkdir_p "$output_objdir" + + # Determine the type of output + case $output in + "") + func_fatal_help "you must specify an output file" + ;; + *.$libext) linkmode=oldlib ;; + *.lo | *.$objext) linkmode=obj ;; + *.la) linkmode=lib ;; + *) linkmode=prog ;; # Anything else should be a program. + esac + + specialdeplibs= + + libs= + # Find all interdependent deplibs by searching for libraries + # that are linked more than once (e.g. -la -lb -la) + for deplib in $deplibs; do + if $opt_preserve_dup_deps ; then + case "$libs " in + *" $deplib "*) specialdeplibs+=" $deplib" ;; + esac + fi + libs+=" $deplib" + done + + if test "$linkmode" = lib; then + libs="$predeps $libs $compiler_lib_search_path $postdeps" + + # Compute libraries that are listed more than once in $predeps + # $postdeps and mark them as special (i.e., whose duplicates are + # not to be eliminated). + pre_post_deps= + if $opt_duplicate_compiler_generated_deps; then + for pre_post_dep in $predeps $postdeps; do + case "$pre_post_deps " in + *" $pre_post_dep "*) specialdeplibs+=" $pre_post_deps" ;; + esac + pre_post_deps+=" $pre_post_dep" + done + fi + pre_post_deps= + fi + + deplibs= + newdependency_libs= + newlib_search_path= + need_relink=no # whether we're linking any uninstalled libtool libraries + notinst_deplibs= # not-installed libtool libraries + notinst_path= # paths that contain not-installed libtool libraries + + case $linkmode in + lib) + passes="conv dlpreopen link" + for file in $dlfiles $dlprefiles; do + case $file in + *.la) ;; + *) + func_fatal_help "libraries can \`-dlopen' only libtool libraries: $file" + ;; + esac + done + ;; + prog) + compile_deplibs= + finalize_deplibs= + alldeplibs=no + newdlfiles= + newdlprefiles= + passes="conv scan dlopen dlpreopen link" + ;; + *) passes="conv" + ;; + esac + + for pass in $passes; do + # The preopen pass in lib mode reverses $deplibs; put it back here + # so that -L comes before libs that need it for instance... + if test "$linkmode,$pass" = "lib,link"; then + ## FIXME: Find the place where the list is rebuilt in the wrong + ## order, and fix it there properly + tmp_deplibs= + for deplib in $deplibs; do + tmp_deplibs="$deplib $tmp_deplibs" + done + deplibs="$tmp_deplibs" + fi + + if test "$linkmode,$pass" = "lib,link" || + test "$linkmode,$pass" = "prog,scan"; then + libs="$deplibs" + deplibs= + fi + if test "$linkmode" = prog; then + case $pass in + dlopen) libs="$dlfiles" ;; + dlpreopen) libs="$dlprefiles" ;; + link) libs="$deplibs %DEPLIBS% $dependency_libs" ;; + esac + fi + if test "$linkmode,$pass" = "lib,dlpreopen"; then + # Collect and forward deplibs of preopened libtool libs + for lib in $dlprefiles; do + # Ignore non-libtool-libs + dependency_libs= + func_resolve_sysroot "$lib" + case $lib in + *.la) func_source "$func_resolve_sysroot_result" ;; + esac + + # Collect preopened libtool deplibs, except any this library + # has declared as weak libs + for deplib in $dependency_libs; do + func_basename "$deplib" + deplib_base=$func_basename_result + case " $weak_libs " in + *" $deplib_base "*) ;; + *) deplibs+=" $deplib" ;; + esac + done + done + libs="$dlprefiles" + fi + if test "$pass" = dlopen; then + # Collect dlpreopened libraries + save_deplibs="$deplibs" + deplibs= + fi + + for deplib in $libs; do + lib= + found=no + case $deplib in + -mt|-mthreads|-kthread|-Kthread|-pthread|-pthreads|--thread-safe \ + |-threads|-fopenmp|-openmp|-mp|-xopenmp|-omp|-qsmp=*) + if test "$linkmode,$pass" = "prog,link"; then + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + else + compiler_flags+=" $deplib" + if test "$linkmode" = lib ; then + case "$new_inherited_linker_flags " in + *" $deplib "*) ;; + * ) new_inherited_linker_flags+=" $deplib" ;; + esac + fi + fi + continue + ;; + -l*) + if test "$linkmode" != lib && test "$linkmode" != prog; then + func_warning "\`-l' is ignored for archives/objects" + continue + fi + func_stripname '-l' '' "$deplib" + name=$func_stripname_result + if test "$linkmode" = lib; then + searchdirs="$newlib_search_path $lib_search_path $compiler_lib_search_dirs $sys_lib_search_path $shlib_search_path" + else + searchdirs="$newlib_search_path $lib_search_path $sys_lib_search_path $shlib_search_path" + fi + for searchdir in $searchdirs; do + for search_ext in .la $std_shrext .so .a; do + # Search the libtool library + lib="$searchdir/lib${name}${search_ext}" + if test -f "$lib"; then + if test "$search_ext" = ".la"; then + found=yes + else + found=no + fi + break 2 + fi + done + done + if test "$found" != yes; then + # deplib doesn't seem to be a libtool library + if test "$linkmode,$pass" = "prog,link"; then + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + else + deplibs="$deplib $deplibs" + test "$linkmode" = lib && newdependency_libs="$deplib $newdependency_libs" + fi + continue + else # deplib is a libtool library + # If $allow_libtool_libs_with_static_runtimes && $deplib is a stdlib, + # We need to do some special things here, and not later. + if test "X$allow_libtool_libs_with_static_runtimes" = "Xyes" ; then + case " $predeps $postdeps " in + *" $deplib "*) + if func_lalib_p "$lib"; then + library_names= + old_library= + func_source "$lib" + for l in $old_library $library_names; do + ll="$l" + done + if test "X$ll" = "X$old_library" ; then # only static version available + found=no + func_dirname "$lib" "" "." + ladir="$func_dirname_result" + lib=$ladir/$old_library + if test "$linkmode,$pass" = "prog,link"; then + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + else + deplibs="$deplib $deplibs" + test "$linkmode" = lib && newdependency_libs="$deplib $newdependency_libs" + fi + continue + fi + fi + ;; + *) ;; + esac + fi + fi + ;; # -l + *.ltframework) + if test "$linkmode,$pass" = "prog,link"; then + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + else + deplibs="$deplib $deplibs" + if test "$linkmode" = lib ; then + case "$new_inherited_linker_flags " in + *" $deplib "*) ;; + * ) new_inherited_linker_flags+=" $deplib" ;; + esac + fi + fi + continue + ;; + -L*) + case $linkmode in + lib) + deplibs="$deplib $deplibs" + test "$pass" = conv && continue + newdependency_libs="$deplib $newdependency_libs" + func_stripname '-L' '' "$deplib" + func_resolve_sysroot "$func_stripname_result" + newlib_search_path+=" $func_resolve_sysroot_result" + ;; + prog) + if test "$pass" = conv; then + deplibs="$deplib $deplibs" + continue + fi + if test "$pass" = scan; then + deplibs="$deplib $deplibs" + else + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + fi + func_stripname '-L' '' "$deplib" + func_resolve_sysroot "$func_stripname_result" + newlib_search_path+=" $func_resolve_sysroot_result" + ;; + *) + func_warning "\`-L' is ignored for archives/objects" + ;; + esac # linkmode + continue + ;; # -L + -R*) + if test "$pass" = link; then + func_stripname '-R' '' "$deplib" + func_resolve_sysroot "$func_stripname_result" + dir=$func_resolve_sysroot_result + # Make sure the xrpath contains only unique directories. + case "$xrpath " in + *" $dir "*) ;; + *) xrpath+=" $dir" ;; + esac + fi + deplibs="$deplib $deplibs" + continue + ;; + *.la) + func_resolve_sysroot "$deplib" + lib=$func_resolve_sysroot_result + ;; + *.$libext) + if test "$pass" = conv; then + deplibs="$deplib $deplibs" + continue + fi + case $linkmode in + lib) + # Linking convenience modules into shared libraries is allowed, + # but linking other static libraries is non-portable. + case " $dlpreconveniencelibs " in + *" $deplib "*) ;; + *) + valid_a_lib=no + case $deplibs_check_method in + match_pattern*) + set dummy $deplibs_check_method; shift + match_pattern_regex=`expr "$deplibs_check_method" : "$1 \(.*\)"` + if eval "\$ECHO \"$deplib\"" 2>/dev/null | $SED 10q \ + | $EGREP "$match_pattern_regex" > /dev/null; then + valid_a_lib=yes + fi + ;; + pass_all) + valid_a_lib=yes + ;; + esac + if test "$valid_a_lib" != yes; then + echo + $ECHO "*** Warning: Trying to link with static lib archive $deplib." + echo "*** I have the capability to make that library automatically link in when" + echo "*** you link to this library. But I can only do this if you have a" + echo "*** shared version of the library, which you do not appear to have" + echo "*** because the file extensions .$libext of this argument makes me believe" + echo "*** that it is just a static archive that I should not use here." + else + echo + $ECHO "*** Warning: Linking the shared library $output against the" + $ECHO "*** static library $deplib is not portable!" + deplibs="$deplib $deplibs" + fi + ;; + esac + continue + ;; + prog) + if test "$pass" != link; then + deplibs="$deplib $deplibs" + else + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + fi + continue + ;; + esac # linkmode + ;; # *.$libext + *.lo | *.$objext) + if test "$pass" = conv; then + deplibs="$deplib $deplibs" + elif test "$linkmode" = prog; then + if test "$pass" = dlpreopen || test "$dlopen_support" != yes || test "$build_libtool_libs" = no; then + # If there is no dlopen support or we're linking statically, + # we need to preload. + newdlprefiles+=" $deplib" + compile_deplibs="$deplib $compile_deplibs" + finalize_deplibs="$deplib $finalize_deplibs" + else + newdlfiles+=" $deplib" + fi + fi + continue + ;; + %DEPLIBS%) + alldeplibs=yes + continue + ;; + esac # case $deplib + + if test "$found" = yes || test -f "$lib"; then : + else + func_fatal_error "cannot find the library \`$lib' or unhandled argument \`$deplib'" + fi + + # Check to see that this really is a libtool archive. + func_lalib_unsafe_p "$lib" \ + || func_fatal_error "\`$lib' is not a valid libtool archive" + + func_dirname "$lib" "" "." + ladir="$func_dirname_result" + + dlname= + dlopen= + dlpreopen= + libdir= + library_names= + old_library= + inherited_linker_flags= + # If the library was installed with an old release of libtool, + # it will not redefine variables installed, or shouldnotlink + installed=yes + shouldnotlink=no + avoidtemprpath= + + + # Read the .la file + func_source "$lib" + + # Convert "-framework foo" to "foo.ltframework" + if test -n "$inherited_linker_flags"; then + tmp_inherited_linker_flags=`$ECHO "$inherited_linker_flags" | $SED 's/-framework \([^ $]*\)/\1.ltframework/g'` + for tmp_inherited_linker_flag in $tmp_inherited_linker_flags; do + case " $new_inherited_linker_flags " in + *" $tmp_inherited_linker_flag "*) ;; + *) new_inherited_linker_flags+=" $tmp_inherited_linker_flag";; + esac + done + fi + dependency_libs=`$ECHO " $dependency_libs" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + if test "$linkmode,$pass" = "lib,link" || + test "$linkmode,$pass" = "prog,scan" || + { test "$linkmode" != prog && test "$linkmode" != lib; }; then + test -n "$dlopen" && dlfiles+=" $dlopen" + test -n "$dlpreopen" && dlprefiles+=" $dlpreopen" + fi + + if test "$pass" = conv; then + # Only check for convenience libraries + deplibs="$lib $deplibs" + if test -z "$libdir"; then + if test -z "$old_library"; then + func_fatal_error "cannot find name of link library for \`$lib'" + fi + # It is a libtool convenience library, so add in its objects. + convenience+=" $ladir/$objdir/$old_library" + old_convenience+=" $ladir/$objdir/$old_library" + elif test "$linkmode" != prog && test "$linkmode" != lib; then + func_fatal_error "\`$lib' is not a convenience library" + fi + tmp_libs= + for deplib in $dependency_libs; do + deplibs="$deplib $deplibs" + if $opt_preserve_dup_deps ; then + case "$tmp_libs " in + *" $deplib "*) specialdeplibs+=" $deplib" ;; + esac + fi + tmp_libs+=" $deplib" + done + continue + fi # $pass = conv + + + # Get the name of the library we link against. + linklib= + if test -n "$old_library" && + { test "$prefer_static_libs" = yes || + test "$prefer_static_libs,$installed" = "built,no"; }; then + linklib=$old_library + else + for l in $old_library $library_names; do + linklib="$l" + done + fi + if test -z "$linklib"; then + func_fatal_error "cannot find name of link library for \`$lib'" + fi + + # This library was specified with -dlopen. + if test "$pass" = dlopen; then + if test -z "$libdir"; then + func_fatal_error "cannot -dlopen a convenience library: \`$lib'" + fi + if test -z "$dlname" || + test "$dlopen_support" != yes || + test "$build_libtool_libs" = no; then + # If there is no dlname, no dlopen support or we're linking + # statically, we need to preload. We also need to preload any + # dependent libraries so libltdl's deplib preloader doesn't + # bomb out in the load deplibs phase. + dlprefiles+=" $lib $dependency_libs" + else + newdlfiles+=" $lib" + fi + continue + fi # $pass = dlopen + + # We need an absolute path. + case $ladir in + [\\/]* | [A-Za-z]:[\\/]*) abs_ladir="$ladir" ;; + *) + abs_ladir=`cd "$ladir" && pwd` + if test -z "$abs_ladir"; then + func_warning "cannot determine absolute directory name of \`$ladir'" + func_warning "passing it literally to the linker, although it might fail" + abs_ladir="$ladir" + fi + ;; + esac + func_basename "$lib" + laname="$func_basename_result" + + # Find the relevant object directory and library name. + if test "X$installed" = Xyes; then + if test ! -f "$lt_sysroot$libdir/$linklib" && test -f "$abs_ladir/$linklib"; then + func_warning "library \`$lib' was moved." + dir="$ladir" + absdir="$abs_ladir" + libdir="$abs_ladir" + else + dir="$lt_sysroot$libdir" + absdir="$lt_sysroot$libdir" + fi + test "X$hardcode_automatic" = Xyes && avoidtemprpath=yes + else + if test ! -f "$ladir/$objdir/$linklib" && test -f "$abs_ladir/$linklib"; then + dir="$ladir" + absdir="$abs_ladir" + # Remove this search path later + notinst_path+=" $abs_ladir" + else + dir="$ladir/$objdir" + absdir="$abs_ladir/$objdir" + # Remove this search path later + notinst_path+=" $abs_ladir" + fi + fi # $installed = yes + func_stripname 'lib' '.la' "$laname" + name=$func_stripname_result + + # This library was specified with -dlpreopen. + if test "$pass" = dlpreopen; then + if test -z "$libdir" && test "$linkmode" = prog; then + func_fatal_error "only libraries may -dlpreopen a convenience library: \`$lib'" + fi + case "$host" in + # special handling for platforms with PE-DLLs. + *cygwin* | *mingw* | *cegcc* ) + # Linker will automatically link against shared library if both + # static and shared are present. Therefore, ensure we extract + # symbols from the import library if a shared library is present + # (otherwise, the dlopen module name will be incorrect). We do + # this by putting the import library name into $newdlprefiles. + # We recover the dlopen module name by 'saving' the la file + # name in a special purpose variable, and (later) extracting the + # dlname from the la file. + if test -n "$dlname"; then + func_tr_sh "$dir/$linklib" + eval "libfile_$func_tr_sh_result=\$abs_ladir/\$laname" + newdlprefiles+=" $dir/$linklib" + else + newdlprefiles+=" $dir/$old_library" + # Keep a list of preopened convenience libraries to check + # that they are being used correctly in the link pass. + test -z "$libdir" && \ + dlpreconveniencelibs+=" $dir/$old_library" + fi + ;; + * ) + # Prefer using a static library (so that no silly _DYNAMIC symbols + # are required to link). + if test -n "$old_library"; then + newdlprefiles+=" $dir/$old_library" + # Keep a list of preopened convenience libraries to check + # that they are being used correctly in the link pass. + test -z "$libdir" && \ + dlpreconveniencelibs+=" $dir/$old_library" + # Otherwise, use the dlname, so that lt_dlopen finds it. + elif test -n "$dlname"; then + newdlprefiles+=" $dir/$dlname" + else + newdlprefiles+=" $dir/$linklib" + fi + ;; + esac + fi # $pass = dlpreopen + + if test -z "$libdir"; then + # Link the convenience library + if test "$linkmode" = lib; then + deplibs="$dir/$old_library $deplibs" + elif test "$linkmode,$pass" = "prog,link"; then + compile_deplibs="$dir/$old_library $compile_deplibs" + finalize_deplibs="$dir/$old_library $finalize_deplibs" + else + deplibs="$lib $deplibs" # used for prog,scan pass + fi + continue + fi + + + if test "$linkmode" = prog && test "$pass" != link; then + newlib_search_path+=" $ladir" + deplibs="$lib $deplibs" + + linkalldeplibs=no + if test "$link_all_deplibs" != no || test -z "$library_names" || + test "$build_libtool_libs" = no; then + linkalldeplibs=yes + fi + + tmp_libs= + for deplib in $dependency_libs; do + case $deplib in + -L*) func_stripname '-L' '' "$deplib" + func_resolve_sysroot "$func_stripname_result" + newlib_search_path+=" $func_resolve_sysroot_result" + ;; + esac + # Need to link against all dependency_libs? + if test "$linkalldeplibs" = yes; then + deplibs="$deplib $deplibs" + else + # Need to hardcode shared library paths + # or/and link against static libraries + newdependency_libs="$deplib $newdependency_libs" + fi + if $opt_preserve_dup_deps ; then + case "$tmp_libs " in + *" $deplib "*) specialdeplibs+=" $deplib" ;; + esac + fi + tmp_libs+=" $deplib" + done # for deplib + continue + fi # $linkmode = prog... + + if test "$linkmode,$pass" = "prog,link"; then + if test -n "$library_names" && + { { test "$prefer_static_libs" = no || + test "$prefer_static_libs,$installed" = "built,yes"; } || + test -z "$old_library"; }; then + # We need to hardcode the library path + if test -n "$shlibpath_var" && test -z "$avoidtemprpath" ; then + # Make sure the rpath contains only unique directories. + case "$temp_rpath:" in + *"$absdir:"*) ;; + *) temp_rpath+="$absdir:" ;; + esac + fi + + # Hardcode the library path. + # Skip directories that are in the system default run-time + # search path. + case " $sys_lib_dlsearch_path " in + *" $absdir "*) ;; + *) + case "$compile_rpath " in + *" $absdir "*) ;; + *) compile_rpath+=" $absdir" ;; + esac + ;; + esac + case " $sys_lib_dlsearch_path " in + *" $libdir "*) ;; + *) + case "$finalize_rpath " in + *" $libdir "*) ;; + *) finalize_rpath+=" $libdir" ;; + esac + ;; + esac + fi # $linkmode,$pass = prog,link... + + if test "$alldeplibs" = yes && + { test "$deplibs_check_method" = pass_all || + { test "$build_libtool_libs" = yes && + test -n "$library_names"; }; }; then + # We only need to search for static libraries + continue + fi + fi + + link_static=no # Whether the deplib will be linked statically + use_static_libs=$prefer_static_libs + if test "$use_static_libs" = built && test "$installed" = yes; then + use_static_libs=no + fi + if test -n "$library_names" && + { test "$use_static_libs" = no || test -z "$old_library"; }; then + case $host in + *cygwin* | *mingw* | *cegcc*) + # No point in relinking DLLs because paths are not encoded + notinst_deplibs+=" $lib" + need_relink=no + ;; + *) + if test "$installed" = no; then + notinst_deplibs+=" $lib" + need_relink=yes + fi + ;; + esac + # This is a shared library + + # Warn about portability, can't link against -module's on some + # systems (darwin). Don't bleat about dlopened modules though! + dlopenmodule="" + for dlpremoduletest in $dlprefiles; do + if test "X$dlpremoduletest" = "X$lib"; then + dlopenmodule="$dlpremoduletest" + break + fi + done + if test -z "$dlopenmodule" && test "$shouldnotlink" = yes && test "$pass" = link; then + echo + if test "$linkmode" = prog; then + $ECHO "*** Warning: Linking the executable $output against the loadable module" + else + $ECHO "*** Warning: Linking the shared library $output against the loadable module" + fi + $ECHO "*** $linklib is not portable!" + fi + if test "$linkmode" = lib && + test "$hardcode_into_libs" = yes; then + # Hardcode the library path. + # Skip directories that are in the system default run-time + # search path. + case " $sys_lib_dlsearch_path " in + *" $absdir "*) ;; + *) + case "$compile_rpath " in + *" $absdir "*) ;; + *) compile_rpath+=" $absdir" ;; + esac + ;; + esac + case " $sys_lib_dlsearch_path " in + *" $libdir "*) ;; + *) + case "$finalize_rpath " in + *" $libdir "*) ;; + *) finalize_rpath+=" $libdir" ;; + esac + ;; + esac + fi + + if test -n "$old_archive_from_expsyms_cmds"; then + # figure out the soname + set dummy $library_names + shift + realname="$1" + shift + libname=`eval "\\$ECHO \"$libname_spec\""` + # use dlname if we got it. it's perfectly good, no? + if test -n "$dlname"; then + soname="$dlname" + elif test -n "$soname_spec"; then + # bleh windows + case $host in + *cygwin* | mingw* | *cegcc*) + func_arith $current - $age + major=$func_arith_result + versuffix="-$major" + ;; + esac + eval soname=\"$soname_spec\" + else + soname="$realname" + fi + + # Make a new name for the extract_expsyms_cmds to use + soroot="$soname" + func_basename "$soroot" + soname="$func_basename_result" + func_stripname 'lib' '.dll' "$soname" + newlib=libimp-$func_stripname_result.a + + # If the library has no export list, then create one now + if test -f "$output_objdir/$soname-def"; then : + else + func_verbose "extracting exported symbol list from \`$soname'" + func_execute_cmds "$extract_expsyms_cmds" 'exit $?' + fi + + # Create $newlib + if test -f "$output_objdir/$newlib"; then :; else + func_verbose "generating import library for \`$soname'" + func_execute_cmds "$old_archive_from_expsyms_cmds" 'exit $?' + fi + # make sure the library variables are pointing to the new library + dir=$output_objdir + linklib=$newlib + fi # test -n "$old_archive_from_expsyms_cmds" + + if test "$linkmode" = prog || test "$opt_mode" != relink; then + add_shlibpath= + add_dir= + add= + lib_linked=yes + case $hardcode_action in + immediate | unsupported) + if test "$hardcode_direct" = no; then + add="$dir/$linklib" + case $host in + *-*-sco3.2v5.0.[024]*) add_dir="-L$dir" ;; + *-*-sysv4*uw2*) add_dir="-L$dir" ;; + *-*-sysv5OpenUNIX* | *-*-sysv5UnixWare7.[01].[10]* | \ + *-*-unixware7*) add_dir="-L$dir" ;; + *-*-darwin* ) + # if the lib is a (non-dlopened) module then we can not + # link against it, someone is ignoring the earlier warnings + if /usr/bin/file -L $add 2> /dev/null | + $GREP ": [^:]* bundle" >/dev/null ; then + if test "X$dlopenmodule" != "X$lib"; then + $ECHO "*** Warning: lib $linklib is a module, not a shared library" + if test -z "$old_library" ; then + echo + echo "*** And there doesn't seem to be a static archive available" + echo "*** The link will probably fail, sorry" + else + add="$dir/$old_library" + fi + elif test -n "$old_library"; then + add="$dir/$old_library" + fi + fi + esac + elif test "$hardcode_minus_L" = no; then + case $host in + *-*-sunos*) add_shlibpath="$dir" ;; + esac + add_dir="-L$dir" + add="-l$name" + elif test "$hardcode_shlibpath_var" = no; then + add_shlibpath="$dir" + add="-l$name" + else + lib_linked=no + fi + ;; + relink) + if test "$hardcode_direct" = yes && + test "$hardcode_direct_absolute" = no; then + add="$dir/$linklib" + elif test "$hardcode_minus_L" = yes; then + add_dir="-L$absdir" + # Try looking first in the location we're being installed to. + if test -n "$inst_prefix_dir"; then + case $libdir in + [\\/]*) + add_dir+=" -L$inst_prefix_dir$libdir" + ;; + esac + fi + add="-l$name" + elif test "$hardcode_shlibpath_var" = yes; then + add_shlibpath="$dir" + add="-l$name" + else + lib_linked=no + fi + ;; + *) lib_linked=no ;; + esac + + if test "$lib_linked" != yes; then + func_fatal_configuration "unsupported hardcode properties" + fi + + if test -n "$add_shlibpath"; then + case :$compile_shlibpath: in + *":$add_shlibpath:"*) ;; + *) compile_shlibpath+="$add_shlibpath:" ;; + esac + fi + if test "$linkmode" = prog; then + test -n "$add_dir" && compile_deplibs="$add_dir $compile_deplibs" + test -n "$add" && compile_deplibs="$add $compile_deplibs" + else + test -n "$add_dir" && deplibs="$add_dir $deplibs" + test -n "$add" && deplibs="$add $deplibs" + if test "$hardcode_direct" != yes && + test "$hardcode_minus_L" != yes && + test "$hardcode_shlibpath_var" = yes; then + case :$finalize_shlibpath: in + *":$libdir:"*) ;; + *) finalize_shlibpath+="$libdir:" ;; + esac + fi + fi + fi + + if test "$linkmode" = prog || test "$opt_mode" = relink; then + add_shlibpath= + add_dir= + add= + # Finalize command for both is simple: just hardcode it. + if test "$hardcode_direct" = yes && + test "$hardcode_direct_absolute" = no; then + add="$libdir/$linklib" + elif test "$hardcode_minus_L" = yes; then + add_dir="-L$libdir" + add="-l$name" + elif test "$hardcode_shlibpath_var" = yes; then + case :$finalize_shlibpath: in + *":$libdir:"*) ;; + *) finalize_shlibpath+="$libdir:" ;; + esac + add="-l$name" + elif test "$hardcode_automatic" = yes; then + if test -n "$inst_prefix_dir" && + test -f "$inst_prefix_dir$libdir/$linklib" ; then + add="$inst_prefix_dir$libdir/$linklib" + else + add="$libdir/$linklib" + fi + else + # We cannot seem to hardcode it, guess we'll fake it. + add_dir="-L$libdir" + # Try looking first in the location we're being installed to. + if test -n "$inst_prefix_dir"; then + case $libdir in + [\\/]*) + add_dir+=" -L$inst_prefix_dir$libdir" + ;; + esac + fi + add="-l$name" + fi + + if test "$linkmode" = prog; then + test -n "$add_dir" && finalize_deplibs="$add_dir $finalize_deplibs" + test -n "$add" && finalize_deplibs="$add $finalize_deplibs" + else + test -n "$add_dir" && deplibs="$add_dir $deplibs" + test -n "$add" && deplibs="$add $deplibs" + fi + fi + elif test "$linkmode" = prog; then + # Here we assume that one of hardcode_direct or hardcode_minus_L + # is not unsupported. This is valid on all known static and + # shared platforms. + if test "$hardcode_direct" != unsupported; then + test -n "$old_library" && linklib="$old_library" + compile_deplibs="$dir/$linklib $compile_deplibs" + finalize_deplibs="$dir/$linklib $finalize_deplibs" + else + compile_deplibs="-l$name -L$dir $compile_deplibs" + finalize_deplibs="-l$name -L$dir $finalize_deplibs" + fi + elif test "$build_libtool_libs" = yes; then + # Not a shared library + if test "$deplibs_check_method" != pass_all; then + # We're trying link a shared library against a static one + # but the system doesn't support it. + + # Just print a warning and add the library to dependency_libs so + # that the program can be linked against the static library. + echo + $ECHO "*** Warning: This system can not link to static lib archive $lib." + echo "*** I have the capability to make that library automatically link in when" + echo "*** you link to this library. But I can only do this if you have a" + echo "*** shared version of the library, which you do not appear to have." + if test "$module" = yes; then + echo "*** But as you try to build a module library, libtool will still create " + echo "*** a static module, that should work as long as the dlopening application" + echo "*** is linked with the -dlopen flag to resolve symbols at runtime." + if test -z "$global_symbol_pipe"; then + echo + echo "*** However, this would only work if libtool was able to extract symbol" + echo "*** lists from a program, using \`nm' or equivalent, but libtool could" + echo "*** not find such a program. So, this module is probably useless." + echo "*** \`nm' from GNU binutils and a full rebuild may help." + fi + if test "$build_old_libs" = no; then + build_libtool_libs=module + build_old_libs=yes + else + build_libtool_libs=no + fi + fi + else + deplibs="$dir/$old_library $deplibs" + link_static=yes + fi + fi # link shared/static library? + + if test "$linkmode" = lib; then + if test -n "$dependency_libs" && + { test "$hardcode_into_libs" != yes || + test "$build_old_libs" = yes || + test "$link_static" = yes; }; then + # Extract -R from dependency_libs + temp_deplibs= + for libdir in $dependency_libs; do + case $libdir in + -R*) func_stripname '-R' '' "$libdir" + temp_xrpath=$func_stripname_result + case " $xrpath " in + *" $temp_xrpath "*) ;; + *) xrpath+=" $temp_xrpath";; + esac;; + *) temp_deplibs+=" $libdir";; + esac + done + dependency_libs="$temp_deplibs" + fi + + newlib_search_path+=" $absdir" + # Link against this library + test "$link_static" = no && newdependency_libs="$abs_ladir/$laname $newdependency_libs" + # ... and its dependency_libs + tmp_libs= + for deplib in $dependency_libs; do + newdependency_libs="$deplib $newdependency_libs" + case $deplib in + -L*) func_stripname '-L' '' "$deplib" + func_resolve_sysroot "$func_stripname_result";; + *) func_resolve_sysroot "$deplib" ;; + esac + if $opt_preserve_dup_deps ; then + case "$tmp_libs " in + *" $func_resolve_sysroot_result "*) + specialdeplibs+=" $func_resolve_sysroot_result" ;; + esac + fi + tmp_libs+=" $func_resolve_sysroot_result" + done + + if test "$link_all_deplibs" != no; then + # Add the search paths of all dependency libraries + for deplib in $dependency_libs; do + path= + case $deplib in + -L*) path="$deplib" ;; + *.la) + func_resolve_sysroot "$deplib" + deplib=$func_resolve_sysroot_result + func_dirname "$deplib" "" "." + dir=$func_dirname_result + # We need an absolute path. + case $dir in + [\\/]* | [A-Za-z]:[\\/]*) absdir="$dir" ;; + *) + absdir=`cd "$dir" && pwd` + if test -z "$absdir"; then + func_warning "cannot determine absolute directory name of \`$dir'" + absdir="$dir" + fi + ;; + esac + if $GREP "^installed=no" $deplib > /dev/null; then + case $host in + *-*-darwin*) + depdepl= + eval deplibrary_names=`${SED} -n -e 's/^library_names=\(.*\)$/\1/p' $deplib` + if test -n "$deplibrary_names" ; then + for tmp in $deplibrary_names ; do + depdepl=$tmp + done + if test -f "$absdir/$objdir/$depdepl" ; then + depdepl="$absdir/$objdir/$depdepl" + darwin_install_name=`${OTOOL} -L $depdepl | awk '{if (NR == 2) {print $1;exit}}'` + if test -z "$darwin_install_name"; then + darwin_install_name=`${OTOOL64} -L $depdepl | awk '{if (NR == 2) {print $1;exit}}'` + fi + compiler_flags+=" ${wl}-dylib_file ${wl}${darwin_install_name}:${depdepl}" + linker_flags+=" -dylib_file ${darwin_install_name}:${depdepl}" + path= + fi + fi + ;; + *) + path="-L$absdir/$objdir" + ;; + esac + else + eval libdir=`${SED} -n -e 's/^libdir=\(.*\)$/\1/p' $deplib` + test -z "$libdir" && \ + func_fatal_error "\`$deplib' is not a valid libtool archive" + test "$absdir" != "$libdir" && \ + func_warning "\`$deplib' seems to be moved" + + path="-L$absdir" + fi + ;; + esac + case " $deplibs " in + *" $path "*) ;; + *) deplibs="$path $deplibs" ;; + esac + done + fi # link_all_deplibs != no + fi # linkmode = lib + done # for deplib in $libs + if test "$pass" = link; then + if test "$linkmode" = "prog"; then + compile_deplibs="$new_inherited_linker_flags $compile_deplibs" + finalize_deplibs="$new_inherited_linker_flags $finalize_deplibs" + else + compiler_flags="$compiler_flags "`$ECHO " $new_inherited_linker_flags" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + fi + fi + dependency_libs="$newdependency_libs" + if test "$pass" = dlpreopen; then + # Link the dlpreopened libraries before other libraries + for deplib in $save_deplibs; do + deplibs="$deplib $deplibs" + done + fi + if test "$pass" != dlopen; then + if test "$pass" != conv; then + # Make sure lib_search_path contains only unique directories. + lib_search_path= + for dir in $newlib_search_path; do + case "$lib_search_path " in + *" $dir "*) ;; + *) lib_search_path+=" $dir" ;; + esac + done + newlib_search_path= + fi + + if test "$linkmode,$pass" != "prog,link"; then + vars="deplibs" + else + vars="compile_deplibs finalize_deplibs" + fi + for var in $vars dependency_libs; do + # Add libraries to $var in reverse order + eval tmp_libs=\"\$$var\" + new_libs= + for deplib in $tmp_libs; do + # FIXME: Pedantically, this is the right thing to do, so + # that some nasty dependency loop isn't accidentally + # broken: + #new_libs="$deplib $new_libs" + # Pragmatically, this seems to cause very few problems in + # practice: + case $deplib in + -L*) new_libs="$deplib $new_libs" ;; + -R*) ;; + *) + # And here is the reason: when a library appears more + # than once as an explicit dependence of a library, or + # is implicitly linked in more than once by the + # compiler, it is considered special, and multiple + # occurrences thereof are not removed. Compare this + # with having the same library being listed as a + # dependency of multiple other libraries: in this case, + # we know (pedantically, we assume) the library does not + # need to be listed more than once, so we keep only the + # last copy. This is not always right, but it is rare + # enough that we require users that really mean to play + # such unportable linking tricks to link the library + # using -Wl,-lname, so that libtool does not consider it + # for duplicate removal. + case " $specialdeplibs " in + *" $deplib "*) new_libs="$deplib $new_libs" ;; + *) + case " $new_libs " in + *" $deplib "*) ;; + *) new_libs="$deplib $new_libs" ;; + esac + ;; + esac + ;; + esac + done + tmp_libs= + for deplib in $new_libs; do + case $deplib in + -L*) + case " $tmp_libs " in + *" $deplib "*) ;; + *) tmp_libs+=" $deplib" ;; + esac + ;; + *) tmp_libs+=" $deplib" ;; + esac + done + eval $var=\"$tmp_libs\" + done # for var + fi + # Last step: remove runtime libs from dependency_libs + # (they stay in deplibs) + tmp_libs= + for i in $dependency_libs ; do + case " $predeps $postdeps $compiler_lib_search_path " in + *" $i "*) + i="" + ;; + esac + if test -n "$i" ; then + tmp_libs+=" $i" + fi + done + dependency_libs=$tmp_libs + done # for pass + if test "$linkmode" = prog; then + dlfiles="$newdlfiles" + fi + if test "$linkmode" = prog || test "$linkmode" = lib; then + dlprefiles="$newdlprefiles" + fi + + case $linkmode in + oldlib) + if test -n "$dlfiles$dlprefiles" || test "$dlself" != no; then + func_warning "\`-dlopen' is ignored for archives" + fi + + case " $deplibs" in + *\ -l* | *\ -L*) + func_warning "\`-l' and \`-L' are ignored for archives" ;; + esac + + test -n "$rpath" && \ + func_warning "\`-rpath' is ignored for archives" + + test -n "$xrpath" && \ + func_warning "\`-R' is ignored for archives" + + test -n "$vinfo" && \ + func_warning "\`-version-info/-version-number' is ignored for archives" + + test -n "$release" && \ + func_warning "\`-release' is ignored for archives" + + test -n "$export_symbols$export_symbols_regex" && \ + func_warning "\`-export-symbols' is ignored for archives" + + # Now set the variables for building old libraries. + build_libtool_libs=no + oldlibs="$output" + objs+="$old_deplibs" + ;; + + lib) + # Make sure we only generate libraries of the form `libNAME.la'. + case $outputname in + lib*) + func_stripname 'lib' '.la' "$outputname" + name=$func_stripname_result + eval shared_ext=\"$shrext_cmds\" + eval libname=\"$libname_spec\" + ;; + *) + test "$module" = no && \ + func_fatal_help "libtool library \`$output' must begin with \`lib'" + + if test "$need_lib_prefix" != no; then + # Add the "lib" prefix for modules if required + func_stripname '' '.la' "$outputname" + name=$func_stripname_result + eval shared_ext=\"$shrext_cmds\" + eval libname=\"$libname_spec\" + else + func_stripname '' '.la' "$outputname" + libname=$func_stripname_result + fi + ;; + esac + + if test -n "$objs"; then + if test "$deplibs_check_method" != pass_all; then + func_fatal_error "cannot build libtool library \`$output' from non-libtool objects on this host:$objs" + else + echo + $ECHO "*** Warning: Linking the shared library $output against the non-libtool" + $ECHO "*** objects $objs is not portable!" + libobjs+=" $objs" + fi + fi + + test "$dlself" != no && \ + func_warning "\`-dlopen self' is ignored for libtool libraries" + + set dummy $rpath + shift + test "$#" -gt 1 && \ + func_warning "ignoring multiple \`-rpath's for a libtool library" + + install_libdir="$1" + + oldlibs= + if test -z "$rpath"; then + if test "$build_libtool_libs" = yes; then + # Building a libtool convenience library. + # Some compilers have problems with a `.al' extension so + # convenience libraries should have the same extension an + # archive normally would. + oldlibs="$output_objdir/$libname.$libext $oldlibs" + build_libtool_libs=convenience + build_old_libs=yes + fi + + test -n "$vinfo" && \ + func_warning "\`-version-info/-version-number' is ignored for convenience libraries" + + test -n "$release" && \ + func_warning "\`-release' is ignored for convenience libraries" + else + + # Parse the version information argument. + save_ifs="$IFS"; IFS=':' + set dummy $vinfo 0 0 0 + shift + IFS="$save_ifs" + + test -n "$7" && \ + func_fatal_help "too many parameters to \`-version-info'" + + # convert absolute version numbers to libtool ages + # this retains compatibility with .la files and attempts + # to make the code below a bit more comprehensible + + case $vinfo_number in + yes) + number_major="$1" + number_minor="$2" + number_revision="$3" + # + # There are really only two kinds -- those that + # use the current revision as the major version + # and those that subtract age and use age as + # a minor version. But, then there is irix + # which has an extra 1 added just for fun + # + case $version_type in + # correct linux to gnu/linux during the next big refactor + darwin|linux|osf|windows|none) + func_arith $number_major + $number_minor + current=$func_arith_result + age="$number_minor" + revision="$number_revision" + ;; + freebsd-aout|freebsd-elf|qnx|sunos) + current="$number_major" + revision="$number_minor" + age="0" + ;; + irix|nonstopux) + func_arith $number_major + $number_minor + current=$func_arith_result + age="$number_minor" + revision="$number_minor" + lt_irix_increment=no + ;; + esac + ;; + no) + current="$1" + revision="$2" + age="$3" + ;; + esac + + # Check that each of the things are valid numbers. + case $current in + 0|[1-9]|[1-9][0-9]|[1-9][0-9][0-9]|[1-9][0-9][0-9][0-9]|[1-9][0-9][0-9][0-9][0-9]) ;; + *) + func_error "CURRENT \`$current' must be a nonnegative integer" + func_fatal_error "\`$vinfo' is not valid version information" + ;; + esac + + case $revision in + 0|[1-9]|[1-9][0-9]|[1-9][0-9][0-9]|[1-9][0-9][0-9][0-9]|[1-9][0-9][0-9][0-9][0-9]) ;; + *) + func_error "REVISION \`$revision' must be a nonnegative integer" + func_fatal_error "\`$vinfo' is not valid version information" + ;; + esac + + case $age in + 0|[1-9]|[1-9][0-9]|[1-9][0-9][0-9]|[1-9][0-9][0-9][0-9]|[1-9][0-9][0-9][0-9][0-9]) ;; + *) + func_error "AGE \`$age' must be a nonnegative integer" + func_fatal_error "\`$vinfo' is not valid version information" + ;; + esac + + if test "$age" -gt "$current"; then + func_error "AGE \`$age' is greater than the current interface number \`$current'" + func_fatal_error "\`$vinfo' is not valid version information" + fi + + # Calculate the version variables. + major= + versuffix= + verstring= + case $version_type in + none) ;; + + darwin) + # Like Linux, but with the current version available in + # verstring for coding it into the library header + func_arith $current - $age + major=.$func_arith_result + versuffix="$major.$age.$revision" + # Darwin ld doesn't like 0 for these options... + func_arith $current + 1 + minor_current=$func_arith_result + xlcverstring="${wl}-compatibility_version ${wl}$minor_current ${wl}-current_version ${wl}$minor_current.$revision" + verstring="-compatibility_version $minor_current -current_version $minor_current.$revision" + ;; + + freebsd-aout) + major=".$current" + versuffix=".$current.$revision"; + ;; + + freebsd-elf) + major=".$current" + versuffix=".$current" + ;; + + irix | nonstopux) + if test "X$lt_irix_increment" = "Xno"; then + func_arith $current - $age + else + func_arith $current - $age + 1 + fi + major=$func_arith_result + + case $version_type in + nonstopux) verstring_prefix=nonstopux ;; + *) verstring_prefix=sgi ;; + esac + verstring="$verstring_prefix$major.$revision" + + # Add in all the interfaces that we are compatible with. + loop=$revision + while test "$loop" -ne 0; do + func_arith $revision - $loop + iface=$func_arith_result + func_arith $loop - 1 + loop=$func_arith_result + verstring="$verstring_prefix$major.$iface:$verstring" + done + + # Before this point, $major must not contain `.'. + major=.$major + versuffix="$major.$revision" + ;; + + linux) # correct to gnu/linux during the next big refactor + func_arith $current - $age + major=.$func_arith_result + versuffix="$major.$age.$revision" + ;; + + osf) + func_arith $current - $age + major=.$func_arith_result + versuffix=".$current.$age.$revision" + verstring="$current.$age.$revision" + + # Add in all the interfaces that we are compatible with. + loop=$age + while test "$loop" -ne 0; do + func_arith $current - $loop + iface=$func_arith_result + func_arith $loop - 1 + loop=$func_arith_result + verstring="$verstring:${iface}.0" + done + + # Make executables depend on our current version. + verstring+=":${current}.0" + ;; + + qnx) + major=".$current" + versuffix=".$current" + ;; + + sunos) + major=".$current" + versuffix=".$current.$revision" + ;; + + windows) + # Use '-' rather than '.', since we only want one + # extension on DOS 8.3 filesystems. + func_arith $current - $age + major=$func_arith_result + versuffix="-$major" + ;; + + *) + func_fatal_configuration "unknown library version type \`$version_type'" + ;; + esac + + # Clear the version info if we defaulted, and they specified a release. + if test -z "$vinfo" && test -n "$release"; then + major= + case $version_type in + darwin) + # we can't check for "0.0" in archive_cmds due to quoting + # problems, so we reset it completely + verstring= + ;; + *) + verstring="0.0" + ;; + esac + if test "$need_version" = no; then + versuffix= + else + versuffix=".0.0" + fi + fi + + # Remove version info from name if versioning should be avoided + if test "$avoid_version" = yes && test "$need_version" = no; then + major= + versuffix= + verstring="" + fi + + # Check to see if the archive will have undefined symbols. + if test "$allow_undefined" = yes; then + if test "$allow_undefined_flag" = unsupported; then + func_warning "undefined symbols not allowed in $host shared libraries" + build_libtool_libs=no + build_old_libs=yes + fi + else + # Don't allow undefined symbols. + allow_undefined_flag="$no_undefined_flag" + fi + + fi + + func_generate_dlsyms "$libname" "$libname" "yes" + libobjs+=" $symfileobj" + test "X$libobjs" = "X " && libobjs= + + if test "$opt_mode" != relink; then + # Remove our outputs, but don't remove object files since they + # may have been created when compiling PIC objects. + removelist= + tempremovelist=`$ECHO "$output_objdir/*"` + for p in $tempremovelist; do + case $p in + *.$objext | *.gcno) + ;; + $output_objdir/$outputname | $output_objdir/$libname.* | $output_objdir/${libname}${release}.*) + if test "X$precious_files_regex" != "X"; then + if $ECHO "$p" | $EGREP -e "$precious_files_regex" >/dev/null 2>&1 + then + continue + fi + fi + removelist+=" $p" + ;; + *) ;; + esac + done + test -n "$removelist" && \ + func_show_eval "${RM}r \$removelist" + fi + + # Now set the variables for building old libraries. + if test "$build_old_libs" = yes && test "$build_libtool_libs" != convenience ; then + oldlibs+=" $output_objdir/$libname.$libext" + + # Transform .lo files to .o files. + oldobjs="$objs "`$ECHO "$libobjs" | $SP2NL | $SED "/\.${libext}$/d; $lo2o" | $NL2SP` + fi + + # Eliminate all temporary directories. + #for path in $notinst_path; do + # lib_search_path=`$ECHO "$lib_search_path " | $SED "s% $path % %g"` + # deplibs=`$ECHO "$deplibs " | $SED "s% -L$path % %g"` + # dependency_libs=`$ECHO "$dependency_libs " | $SED "s% -L$path % %g"` + #done + + if test -n "$xrpath"; then + # If the user specified any rpath flags, then add them. + temp_xrpath= + for libdir in $xrpath; do + func_replace_sysroot "$libdir" + temp_xrpath+=" -R$func_replace_sysroot_result" + case "$finalize_rpath " in + *" $libdir "*) ;; + *) finalize_rpath+=" $libdir" ;; + esac + done + if test "$hardcode_into_libs" != yes || test "$build_old_libs" = yes; then + dependency_libs="$temp_xrpath $dependency_libs" + fi + fi + + # Make sure dlfiles contains only unique files that won't be dlpreopened + old_dlfiles="$dlfiles" + dlfiles= + for lib in $old_dlfiles; do + case " $dlprefiles $dlfiles " in + *" $lib "*) ;; + *) dlfiles+=" $lib" ;; + esac + done + + # Make sure dlprefiles contains only unique files + old_dlprefiles="$dlprefiles" + dlprefiles= + for lib in $old_dlprefiles; do + case "$dlprefiles " in + *" $lib "*) ;; + *) dlprefiles+=" $lib" ;; + esac + done + + if test "$build_libtool_libs" = yes; then + if test -n "$rpath"; then + case $host in + *-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-os2* | *-*-beos* | *-cegcc* | *-*-haiku*) + # these systems don't actually have a c library (as such)! + ;; + *-*-rhapsody* | *-*-darwin1.[012]) + # Rhapsody C library is in the System framework + deplibs+=" System.ltframework" + ;; + *-*-netbsd*) + # Don't link with libc until the a.out ld.so is fixed. + ;; + *-*-openbsd* | *-*-freebsd* | *-*-dragonfly*) + # Do not include libc due to us having libc/libc_r. + ;; + *-*-sco3.2v5* | *-*-sco5v6*) + # Causes problems with __ctype + ;; + *-*-sysv4.2uw2* | *-*-sysv5* | *-*-unixware* | *-*-OpenUNIX*) + # Compiler inserts libc in the correct place for threads to work + ;; + *) + # Add libc to deplibs on all other systems if necessary. + if test "$build_libtool_need_lc" = "yes"; then + deplibs+=" -lc" + fi + ;; + esac + fi + + # Transform deplibs into only deplibs that can be linked in shared. + name_save=$name + libname_save=$libname + release_save=$release + versuffix_save=$versuffix + major_save=$major + # I'm not sure if I'm treating the release correctly. I think + # release should show up in the -l (ie -lgmp5) so we don't want to + # add it in twice. Is that correct? + release="" + versuffix="" + major="" + newdeplibs= + droppeddeps=no + case $deplibs_check_method in + pass_all) + # Don't check for shared/static. Everything works. + # This might be a little naive. We might want to check + # whether the library exists or not. But this is on + # osf3 & osf4 and I'm not really sure... Just + # implementing what was already the behavior. + newdeplibs=$deplibs + ;; + test_compile) + # This code stresses the "libraries are programs" paradigm to its + # limits. Maybe even breaks it. We compile a program, linking it + # against the deplibs as a proxy for the library. Then we can check + # whether they linked in statically or dynamically with ldd. + $opt_dry_run || $RM conftest.c + cat > conftest.c </dev/null` + $nocaseglob + else + potential_libs=`ls $i/$libnameglob[.-]* 2>/dev/null` + fi + for potent_lib in $potential_libs; do + # Follow soft links. + if ls -lLd "$potent_lib" 2>/dev/null | + $GREP " -> " >/dev/null; then + continue + fi + # The statement above tries to avoid entering an + # endless loop below, in case of cyclic links. + # We might still enter an endless loop, since a link + # loop can be closed while we follow links, + # but so what? + potlib="$potent_lib" + while test -h "$potlib" 2>/dev/null; do + potliblink=`ls -ld $potlib | ${SED} 's/.* -> //'` + case $potliblink in + [\\/]* | [A-Za-z]:[\\/]*) potlib="$potliblink";; + *) potlib=`$ECHO "$potlib" | $SED 's,[^/]*$,,'`"$potliblink";; + esac + done + if eval $file_magic_cmd \"\$potlib\" 2>/dev/null | + $SED -e 10q | + $EGREP "$file_magic_regex" > /dev/null; then + newdeplibs+=" $a_deplib" + a_deplib="" + break 2 + fi + done + done + fi + if test -n "$a_deplib" ; then + droppeddeps=yes + echo + $ECHO "*** Warning: linker path does not have real file for library $a_deplib." + echo "*** I have the capability to make that library automatically link in when" + echo "*** you link to this library. But I can only do this if you have a" + echo "*** shared version of the library, which you do not appear to have" + echo "*** because I did check the linker path looking for a file starting" + if test -z "$potlib" ; then + $ECHO "*** with $libname but no candidates were found. (...for file magic test)" + else + $ECHO "*** with $libname and none of the candidates passed a file format test" + $ECHO "*** using a file magic. Last file checked: $potlib" + fi + fi + ;; + *) + # Add a -L argument. + newdeplibs+=" $a_deplib" + ;; + esac + done # Gone through all deplibs. + ;; + match_pattern*) + set dummy $deplibs_check_method; shift + match_pattern_regex=`expr "$deplibs_check_method" : "$1 \(.*\)"` + for a_deplib in $deplibs; do + case $a_deplib in + -l*) + func_stripname -l '' "$a_deplib" + name=$func_stripname_result + if test "X$allow_libtool_libs_with_static_runtimes" = "Xyes" ; then + case " $predeps $postdeps " in + *" $a_deplib "*) + newdeplibs+=" $a_deplib" + a_deplib="" + ;; + esac + fi + if test -n "$a_deplib" ; then + libname=`eval "\\$ECHO \"$libname_spec\""` + for i in $lib_search_path $sys_lib_search_path $shlib_search_path; do + potential_libs=`ls $i/$libname[.-]* 2>/dev/null` + for potent_lib in $potential_libs; do + potlib="$potent_lib" # see symlink-check above in file_magic test + if eval "\$ECHO \"$potent_lib\"" 2>/dev/null | $SED 10q | \ + $EGREP "$match_pattern_regex" > /dev/null; then + newdeplibs+=" $a_deplib" + a_deplib="" + break 2 + fi + done + done + fi + if test -n "$a_deplib" ; then + droppeddeps=yes + echo + $ECHO "*** Warning: linker path does not have real file for library $a_deplib." + echo "*** I have the capability to make that library automatically link in when" + echo "*** you link to this library. But I can only do this if you have a" + echo "*** shared version of the library, which you do not appear to have" + echo "*** because I did check the linker path looking for a file starting" + if test -z "$potlib" ; then + $ECHO "*** with $libname but no candidates were found. (...for regex pattern test)" + else + $ECHO "*** with $libname and none of the candidates passed a file format test" + $ECHO "*** using a regex pattern. Last file checked: $potlib" + fi + fi + ;; + *) + # Add a -L argument. + newdeplibs+=" $a_deplib" + ;; + esac + done # Gone through all deplibs. + ;; + none | unknown | *) + newdeplibs="" + tmp_deplibs=`$ECHO " $deplibs" | $SED 's/ -lc$//; s/ -[LR][^ ]*//g'` + if test "X$allow_libtool_libs_with_static_runtimes" = "Xyes" ; then + for i in $predeps $postdeps ; do + # can't use Xsed below, because $i might contain '/' + tmp_deplibs=`$ECHO " $tmp_deplibs" | $SED "s,$i,,"` + done + fi + case $tmp_deplibs in + *[!\ \ ]*) + echo + if test "X$deplibs_check_method" = "Xnone"; then + echo "*** Warning: inter-library dependencies are not supported in this platform." + else + echo "*** Warning: inter-library dependencies are not known to be supported." + fi + echo "*** All declared inter-library dependencies are being dropped." + droppeddeps=yes + ;; + esac + ;; + esac + versuffix=$versuffix_save + major=$major_save + release=$release_save + libname=$libname_save + name=$name_save + + case $host in + *-*-rhapsody* | *-*-darwin1.[012]) + # On Rhapsody replace the C library with the System framework + newdeplibs=`$ECHO " $newdeplibs" | $SED 's/ -lc / System.ltframework /'` + ;; + esac + + if test "$droppeddeps" = yes; then + if test "$module" = yes; then + echo + echo "*** Warning: libtool could not satisfy all declared inter-library" + $ECHO "*** dependencies of module $libname. Therefore, libtool will create" + echo "*** a static module, that should work as long as the dlopening" + echo "*** application is linked with the -dlopen flag." + if test -z "$global_symbol_pipe"; then + echo + echo "*** However, this would only work if libtool was able to extract symbol" + echo "*** lists from a program, using \`nm' or equivalent, but libtool could" + echo "*** not find such a program. So, this module is probably useless." + echo "*** \`nm' from GNU binutils and a full rebuild may help." + fi + if test "$build_old_libs" = no; then + oldlibs="$output_objdir/$libname.$libext" + build_libtool_libs=module + build_old_libs=yes + else + build_libtool_libs=no + fi + else + echo "*** The inter-library dependencies that have been dropped here will be" + echo "*** automatically added whenever a program is linked with this library" + echo "*** or is declared to -dlopen it." + + if test "$allow_undefined" = no; then + echo + echo "*** Since this library must not contain undefined symbols," + echo "*** because either the platform does not support them or" + echo "*** it was explicitly requested with -no-undefined," + echo "*** libtool will only create a static version of it." + if test "$build_old_libs" = no; then + oldlibs="$output_objdir/$libname.$libext" + build_libtool_libs=module + build_old_libs=yes + else + build_libtool_libs=no + fi + fi + fi + fi + # Done checking deplibs! + deplibs=$newdeplibs + fi + # Time to change all our "foo.ltframework" stuff back to "-framework foo" + case $host in + *-*-darwin*) + newdeplibs=`$ECHO " $newdeplibs" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + new_inherited_linker_flags=`$ECHO " $new_inherited_linker_flags" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + deplibs=`$ECHO " $deplibs" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + ;; + esac + + # move library search paths that coincide with paths to not yet + # installed libraries to the beginning of the library search list + new_libs= + for path in $notinst_path; do + case " $new_libs " in + *" -L$path/$objdir "*) ;; + *) + case " $deplibs " in + *" -L$path/$objdir "*) + new_libs+=" -L$path/$objdir" ;; + esac + ;; + esac + done + for deplib in $deplibs; do + case $deplib in + -L*) + case " $new_libs " in + *" $deplib "*) ;; + *) new_libs+=" $deplib" ;; + esac + ;; + *) new_libs+=" $deplib" ;; + esac + done + deplibs="$new_libs" + + # All the library-specific variables (install_libdir is set above). + library_names= + old_library= + dlname= + + # Test again, we may have decided not to build it any more + if test "$build_libtool_libs" = yes; then + # Remove ${wl} instances when linking with ld. + # FIXME: should test the right _cmds variable. + case $archive_cmds in + *\$LD\ *) wl= ;; + esac + if test "$hardcode_into_libs" = yes; then + # Hardcode the library paths + hardcode_libdirs= + dep_rpath= + rpath="$finalize_rpath" + test "$opt_mode" != relink && rpath="$compile_rpath$rpath" + for libdir in $rpath; do + if test -n "$hardcode_libdir_flag_spec"; then + if test -n "$hardcode_libdir_separator"; then + func_replace_sysroot "$libdir" + libdir=$func_replace_sysroot_result + if test -z "$hardcode_libdirs"; then + hardcode_libdirs="$libdir" + else + # Just accumulate the unique libdirs. + case $hardcode_libdir_separator$hardcode_libdirs$hardcode_libdir_separator in + *"$hardcode_libdir_separator$libdir$hardcode_libdir_separator"*) + ;; + *) + hardcode_libdirs+="$hardcode_libdir_separator$libdir" + ;; + esac + fi + else + eval flag=\"$hardcode_libdir_flag_spec\" + dep_rpath+=" $flag" + fi + elif test -n "$runpath_var"; then + case "$perm_rpath " in + *" $libdir "*) ;; + *) perm_rpath+=" $libdir" ;; + esac + fi + done + # Substitute the hardcoded libdirs into the rpath. + if test -n "$hardcode_libdir_separator" && + test -n "$hardcode_libdirs"; then + libdir="$hardcode_libdirs" + eval "dep_rpath=\"$hardcode_libdir_flag_spec\"" + fi + if test -n "$runpath_var" && test -n "$perm_rpath"; then + # We should set the runpath_var. + rpath= + for dir in $perm_rpath; do + rpath+="$dir:" + done + eval "$runpath_var='$rpath\$$runpath_var'; export $runpath_var" + fi + test -n "$dep_rpath" && deplibs="$dep_rpath $deplibs" + fi + + shlibpath="$finalize_shlibpath" + test "$opt_mode" != relink && shlibpath="$compile_shlibpath$shlibpath" + if test -n "$shlibpath"; then + eval "$shlibpath_var='$shlibpath\$$shlibpath_var'; export $shlibpath_var" + fi + + # Get the real and link names of the library. + eval shared_ext=\"$shrext_cmds\" + eval library_names=\"$library_names_spec\" + set dummy $library_names + shift + realname="$1" + shift + + if test -n "$soname_spec"; then + eval soname=\"$soname_spec\" + else + soname="$realname" + fi + if test -z "$dlname"; then + dlname=$soname + fi + + lib="$output_objdir/$realname" + linknames= + for link + do + linknames+=" $link" + done + + # Use standard objects if they are pic + test -z "$pic_flag" && libobjs=`$ECHO "$libobjs" | $SP2NL | $SED "$lo2o" | $NL2SP` + test "X$libobjs" = "X " && libobjs= + + delfiles= + if test -n "$export_symbols" && test -n "$include_expsyms"; then + $opt_dry_run || cp "$export_symbols" "$output_objdir/$libname.uexp" + export_symbols="$output_objdir/$libname.uexp" + delfiles+=" $export_symbols" + fi + + orig_export_symbols= + case $host_os in + cygwin* | mingw* | cegcc*) + if test -n "$export_symbols" && test -z "$export_symbols_regex"; then + # exporting using user supplied symfile + if test "x`$SED 1q $export_symbols`" != xEXPORTS; then + # and it's NOT already a .def file. Must figure out + # which of the given symbols are data symbols and tag + # them as such. So, trigger use of export_symbols_cmds. + # export_symbols gets reassigned inside the "prepare + # the list of exported symbols" if statement, so the + # include_expsyms logic still works. + orig_export_symbols="$export_symbols" + export_symbols= + always_export_symbols=yes + fi + fi + ;; + esac + + # Prepare the list of exported symbols + if test -z "$export_symbols"; then + if test "$always_export_symbols" = yes || test -n "$export_symbols_regex"; then + func_verbose "generating symbol list for \`$libname.la'" + export_symbols="$output_objdir/$libname.exp" + $opt_dry_run || $RM $export_symbols + cmds=$export_symbols_cmds + save_ifs="$IFS"; IFS='~' + for cmd1 in $cmds; do + IFS="$save_ifs" + # Take the normal branch if the nm_file_list_spec branch + # doesn't work or if tool conversion is not needed. + case $nm_file_list_spec~$to_tool_file_cmd in + *~func_convert_file_noop | *~func_convert_file_msys_to_w32 | ~*) + try_normal_branch=yes + eval cmd=\"$cmd1\" + func_len " $cmd" + len=$func_len_result + ;; + *) + try_normal_branch=no + ;; + esac + if test "$try_normal_branch" = yes \ + && { test "$len" -lt "$max_cmd_len" \ + || test "$max_cmd_len" -le -1; } + then + func_show_eval "$cmd" 'exit $?' + skipped_export=false + elif test -n "$nm_file_list_spec"; then + func_basename "$output" + output_la=$func_basename_result + save_libobjs=$libobjs + save_output=$output + output=${output_objdir}/${output_la}.nm + func_to_tool_file "$output" + libobjs=$nm_file_list_spec$func_to_tool_file_result + delfiles+=" $output" + func_verbose "creating $NM input file list: $output" + for obj in $save_libobjs; do + func_to_tool_file "$obj" + $ECHO "$func_to_tool_file_result" + done > "$output" + eval cmd=\"$cmd1\" + func_show_eval "$cmd" 'exit $?' + output=$save_output + libobjs=$save_libobjs + skipped_export=false + else + # The command line is too long to execute in one step. + func_verbose "using reloadable object file for export list..." + skipped_export=: + # Break out early, otherwise skipped_export may be + # set to false by a later but shorter cmd. + break + fi + done + IFS="$save_ifs" + if test -n "$export_symbols_regex" && test "X$skipped_export" != "X:"; then + func_show_eval '$EGREP -e "$export_symbols_regex" "$export_symbols" > "${export_symbols}T"' + func_show_eval '$MV "${export_symbols}T" "$export_symbols"' + fi + fi + fi + + if test -n "$export_symbols" && test -n "$include_expsyms"; then + tmp_export_symbols="$export_symbols" + test -n "$orig_export_symbols" && tmp_export_symbols="$orig_export_symbols" + $opt_dry_run || eval '$ECHO "$include_expsyms" | $SP2NL >> "$tmp_export_symbols"' + fi + + if test "X$skipped_export" != "X:" && test -n "$orig_export_symbols"; then + # The given exports_symbols file has to be filtered, so filter it. + func_verbose "filter symbol list for \`$libname.la' to tag DATA exports" + # FIXME: $output_objdir/$libname.filter potentially contains lots of + # 's' commands which not all seds can handle. GNU sed should be fine + # though. Also, the filter scales superlinearly with the number of + # global variables. join(1) would be nice here, but unfortunately + # isn't a blessed tool. + $opt_dry_run || $SED -e '/[ ,]DATA/!d;s,\(.*\)\([ \,].*\),s|^\1$|\1\2|,' < $export_symbols > $output_objdir/$libname.filter + delfiles+=" $export_symbols $output_objdir/$libname.filter" + export_symbols=$output_objdir/$libname.def + $opt_dry_run || $SED -f $output_objdir/$libname.filter < $orig_export_symbols > $export_symbols + fi + + tmp_deplibs= + for test_deplib in $deplibs; do + case " $convenience " in + *" $test_deplib "*) ;; + *) + tmp_deplibs+=" $test_deplib" + ;; + esac + done + deplibs="$tmp_deplibs" + + if test -n "$convenience"; then + if test -n "$whole_archive_flag_spec" && + test "$compiler_needs_object" = yes && + test -z "$libobjs"; then + # extract the archives, so we have objects to list. + # TODO: could optimize this to just extract one archive. + whole_archive_flag_spec= + fi + if test -n "$whole_archive_flag_spec"; then + save_libobjs=$libobjs + eval libobjs=\"\$libobjs $whole_archive_flag_spec\" + test "X$libobjs" = "X " && libobjs= + else + gentop="$output_objdir/${outputname}x" + generated+=" $gentop" + + func_extract_archives $gentop $convenience + libobjs+=" $func_extract_archives_result" + test "X$libobjs" = "X " && libobjs= + fi + fi + + if test "$thread_safe" = yes && test -n "$thread_safe_flag_spec"; then + eval flag=\"$thread_safe_flag_spec\" + linker_flags+=" $flag" + fi + + # Make a backup of the uninstalled library when relinking + if test "$opt_mode" = relink; then + $opt_dry_run || eval '(cd $output_objdir && $RM ${realname}U && $MV $realname ${realname}U)' || exit $? + fi + + # Do each of the archive commands. + if test "$module" = yes && test -n "$module_cmds" ; then + if test -n "$export_symbols" && test -n "$module_expsym_cmds"; then + eval test_cmds=\"$module_expsym_cmds\" + cmds=$module_expsym_cmds + else + eval test_cmds=\"$module_cmds\" + cmds=$module_cmds + fi + else + if test -n "$export_symbols" && test -n "$archive_expsym_cmds"; then + eval test_cmds=\"$archive_expsym_cmds\" + cmds=$archive_expsym_cmds + else + eval test_cmds=\"$archive_cmds\" + cmds=$archive_cmds + fi + fi + + if test "X$skipped_export" != "X:" && + func_len " $test_cmds" && + len=$func_len_result && + test "$len" -lt "$max_cmd_len" || test "$max_cmd_len" -le -1; then + : + else + # The command line is too long to link in one step, link piecewise + # or, if using GNU ld and skipped_export is not :, use a linker + # script. + + # Save the value of $output and $libobjs because we want to + # use them later. If we have whole_archive_flag_spec, we + # want to use save_libobjs as it was before + # whole_archive_flag_spec was expanded, because we can't + # assume the linker understands whole_archive_flag_spec. + # This may have to be revisited, in case too many + # convenience libraries get linked in and end up exceeding + # the spec. + if test -z "$convenience" || test -z "$whole_archive_flag_spec"; then + save_libobjs=$libobjs + fi + save_output=$output + func_basename "$output" + output_la=$func_basename_result + + # Clear the reloadable object creation command queue and + # initialize k to one. + test_cmds= + concat_cmds= + objlist= + last_robj= + k=1 + + if test -n "$save_libobjs" && test "X$skipped_export" != "X:" && test "$with_gnu_ld" = yes; then + output=${output_objdir}/${output_la}.lnkscript + func_verbose "creating GNU ld script: $output" + echo 'INPUT (' > $output + for obj in $save_libobjs + do + func_to_tool_file "$obj" + $ECHO "$func_to_tool_file_result" >> $output + done + echo ')' >> $output + delfiles+=" $output" + func_to_tool_file "$output" + output=$func_to_tool_file_result + elif test -n "$save_libobjs" && test "X$skipped_export" != "X:" && test "X$file_list_spec" != X; then + output=${output_objdir}/${output_la}.lnk + func_verbose "creating linker input file list: $output" + : > $output + set x $save_libobjs + shift + firstobj= + if test "$compiler_needs_object" = yes; then + firstobj="$1 " + shift + fi + for obj + do + func_to_tool_file "$obj" + $ECHO "$func_to_tool_file_result" >> $output + done + delfiles+=" $output" + func_to_tool_file "$output" + output=$firstobj\"$file_list_spec$func_to_tool_file_result\" + else + if test -n "$save_libobjs"; then + func_verbose "creating reloadable object files..." + output=$output_objdir/$output_la-${k}.$objext + eval test_cmds=\"$reload_cmds\" + func_len " $test_cmds" + len0=$func_len_result + len=$len0 + + # Loop over the list of objects to be linked. + for obj in $save_libobjs + do + func_len " $obj" + func_arith $len + $func_len_result + len=$func_arith_result + if test "X$objlist" = X || + test "$len" -lt "$max_cmd_len"; then + objlist+=" $obj" + else + # The command $test_cmds is almost too long, add a + # command to the queue. + if test "$k" -eq 1 ; then + # The first file doesn't have a previous command to add. + reload_objs=$objlist + eval concat_cmds=\"$reload_cmds\" + else + # All subsequent reloadable object files will link in + # the last one created. + reload_objs="$objlist $last_robj" + eval concat_cmds=\"\$concat_cmds~$reload_cmds~\$RM $last_robj\" + fi + last_robj=$output_objdir/$output_la-${k}.$objext + func_arith $k + 1 + k=$func_arith_result + output=$output_objdir/$output_la-${k}.$objext + objlist=" $obj" + func_len " $last_robj" + func_arith $len0 + $func_len_result + len=$func_arith_result + fi + done + # Handle the remaining objects by creating one last + # reloadable object file. All subsequent reloadable object + # files will link in the last one created. + test -z "$concat_cmds" || concat_cmds=$concat_cmds~ + reload_objs="$objlist $last_robj" + eval concat_cmds=\"\${concat_cmds}$reload_cmds\" + if test -n "$last_robj"; then + eval concat_cmds=\"\${concat_cmds}~\$RM $last_robj\" + fi + delfiles+=" $output" + + else + output= + fi + + if ${skipped_export-false}; then + func_verbose "generating symbol list for \`$libname.la'" + export_symbols="$output_objdir/$libname.exp" + $opt_dry_run || $RM $export_symbols + libobjs=$output + # Append the command to create the export file. + test -z "$concat_cmds" || concat_cmds=$concat_cmds~ + eval concat_cmds=\"\$concat_cmds$export_symbols_cmds\" + if test -n "$last_robj"; then + eval concat_cmds=\"\$concat_cmds~\$RM $last_robj\" + fi + fi + + test -n "$save_libobjs" && + func_verbose "creating a temporary reloadable object file: $output" + + # Loop through the commands generated above and execute them. + save_ifs="$IFS"; IFS='~' + for cmd in $concat_cmds; do + IFS="$save_ifs" + $opt_silent || { + func_quote_for_expand "$cmd" + eval "func_echo $func_quote_for_expand_result" + } + $opt_dry_run || eval "$cmd" || { + lt_exit=$? + + # Restore the uninstalled library and exit + if test "$opt_mode" = relink; then + ( cd "$output_objdir" && \ + $RM "${realname}T" && \ + $MV "${realname}U" "$realname" ) + fi + + exit $lt_exit + } + done + IFS="$save_ifs" + + if test -n "$export_symbols_regex" && ${skipped_export-false}; then + func_show_eval '$EGREP -e "$export_symbols_regex" "$export_symbols" > "${export_symbols}T"' + func_show_eval '$MV "${export_symbols}T" "$export_symbols"' + fi + fi + + if ${skipped_export-false}; then + if test -n "$export_symbols" && test -n "$include_expsyms"; then + tmp_export_symbols="$export_symbols" + test -n "$orig_export_symbols" && tmp_export_symbols="$orig_export_symbols" + $opt_dry_run || eval '$ECHO "$include_expsyms" | $SP2NL >> "$tmp_export_symbols"' + fi + + if test -n "$orig_export_symbols"; then + # The given exports_symbols file has to be filtered, so filter it. + func_verbose "filter symbol list for \`$libname.la' to tag DATA exports" + # FIXME: $output_objdir/$libname.filter potentially contains lots of + # 's' commands which not all seds can handle. GNU sed should be fine + # though. Also, the filter scales superlinearly with the number of + # global variables. join(1) would be nice here, but unfortunately + # isn't a blessed tool. + $opt_dry_run || $SED -e '/[ ,]DATA/!d;s,\(.*\)\([ \,].*\),s|^\1$|\1\2|,' < $export_symbols > $output_objdir/$libname.filter + delfiles+=" $export_symbols $output_objdir/$libname.filter" + export_symbols=$output_objdir/$libname.def + $opt_dry_run || $SED -f $output_objdir/$libname.filter < $orig_export_symbols > $export_symbols + fi + fi + + libobjs=$output + # Restore the value of output. + output=$save_output + + if test -n "$convenience" && test -n "$whole_archive_flag_spec"; then + eval libobjs=\"\$libobjs $whole_archive_flag_spec\" + test "X$libobjs" = "X " && libobjs= + fi + # Expand the library linking commands again to reset the + # value of $libobjs for piecewise linking. + + # Do each of the archive commands. + if test "$module" = yes && test -n "$module_cmds" ; then + if test -n "$export_symbols" && test -n "$module_expsym_cmds"; then + cmds=$module_expsym_cmds + else + cmds=$module_cmds + fi + else + if test -n "$export_symbols" && test -n "$archive_expsym_cmds"; then + cmds=$archive_expsym_cmds + else + cmds=$archive_cmds + fi + fi + fi + + if test -n "$delfiles"; then + # Append the command to remove temporary files to $cmds. + eval cmds=\"\$cmds~\$RM $delfiles\" + fi + + # Add any objects from preloaded convenience libraries + if test -n "$dlprefiles"; then + gentop="$output_objdir/${outputname}x" + generated+=" $gentop" + + func_extract_archives $gentop $dlprefiles + libobjs+=" $func_extract_archives_result" + test "X$libobjs" = "X " && libobjs= + fi + + save_ifs="$IFS"; IFS='~' + for cmd in $cmds; do + IFS="$save_ifs" + eval cmd=\"$cmd\" + $opt_silent || { + func_quote_for_expand "$cmd" + eval "func_echo $func_quote_for_expand_result" + } + $opt_dry_run || eval "$cmd" || { + lt_exit=$? + + # Restore the uninstalled library and exit + if test "$opt_mode" = relink; then + ( cd "$output_objdir" && \ + $RM "${realname}T" && \ + $MV "${realname}U" "$realname" ) + fi + + exit $lt_exit + } + done + IFS="$save_ifs" + + # Restore the uninstalled library and exit + if test "$opt_mode" = relink; then + $opt_dry_run || eval '(cd $output_objdir && $RM ${realname}T && $MV $realname ${realname}T && $MV ${realname}U $realname)' || exit $? + + if test -n "$convenience"; then + if test -z "$whole_archive_flag_spec"; then + func_show_eval '${RM}r "$gentop"' + fi + fi + + exit $EXIT_SUCCESS + fi + + # Create links to the real library. + for linkname in $linknames; do + if test "$realname" != "$linkname"; then + func_show_eval '(cd "$output_objdir" && $RM "$linkname" && $LN_S "$realname" "$linkname")' 'exit $?' + fi + done + + # If -module or -export-dynamic was specified, set the dlname. + if test "$module" = yes || test "$export_dynamic" = yes; then + # On all known operating systems, these are identical. + dlname="$soname" + fi + fi + ;; + + obj) + if test -n "$dlfiles$dlprefiles" || test "$dlself" != no; then + func_warning "\`-dlopen' is ignored for objects" + fi + + case " $deplibs" in + *\ -l* | *\ -L*) + func_warning "\`-l' and \`-L' are ignored for objects" ;; + esac + + test -n "$rpath" && \ + func_warning "\`-rpath' is ignored for objects" + + test -n "$xrpath" && \ + func_warning "\`-R' is ignored for objects" + + test -n "$vinfo" && \ + func_warning "\`-version-info' is ignored for objects" + + test -n "$release" && \ + func_warning "\`-release' is ignored for objects" + + case $output in + *.lo) + test -n "$objs$old_deplibs" && \ + func_fatal_error "cannot build library object \`$output' from non-libtool objects" + + libobj=$output + func_lo2o "$libobj" + obj=$func_lo2o_result + ;; + *) + libobj= + obj="$output" + ;; + esac + + # Delete the old objects. + $opt_dry_run || $RM $obj $libobj + + # Objects from convenience libraries. This assumes + # single-version convenience libraries. Whenever we create + # different ones for PIC/non-PIC, this we'll have to duplicate + # the extraction. + reload_conv_objs= + gentop= + # reload_cmds runs $LD directly, so let us get rid of + # -Wl from whole_archive_flag_spec and hope we can get by with + # turning comma into space.. + wl= + + if test -n "$convenience"; then + if test -n "$whole_archive_flag_spec"; then + eval tmp_whole_archive_flags=\"$whole_archive_flag_spec\" + reload_conv_objs=$reload_objs\ `$ECHO "$tmp_whole_archive_flags" | $SED 's|,| |g'` + else + gentop="$output_objdir/${obj}x" + generated+=" $gentop" + + func_extract_archives $gentop $convenience + reload_conv_objs="$reload_objs $func_extract_archives_result" + fi + fi + + # If we're not building shared, we need to use non_pic_objs + test "$build_libtool_libs" != yes && libobjs="$non_pic_objects" + + # Create the old-style object. + reload_objs="$objs$old_deplibs "`$ECHO "$libobjs" | $SP2NL | $SED "/\.${libext}$/d; /\.lib$/d; $lo2o" | $NL2SP`" $reload_conv_objs" ### testsuite: skip nested quoting test + + output="$obj" + func_execute_cmds "$reload_cmds" 'exit $?' + + # Exit if we aren't doing a library object file. + if test -z "$libobj"; then + if test -n "$gentop"; then + func_show_eval '${RM}r "$gentop"' + fi + + exit $EXIT_SUCCESS + fi + + if test "$build_libtool_libs" != yes; then + if test -n "$gentop"; then + func_show_eval '${RM}r "$gentop"' + fi + + # Create an invalid libtool object if no PIC, so that we don't + # accidentally link it into a program. + # $show "echo timestamp > $libobj" + # $opt_dry_run || eval "echo timestamp > $libobj" || exit $? + exit $EXIT_SUCCESS + fi + + if test -n "$pic_flag" || test "$pic_mode" != default; then + # Only do commands if we really have different PIC objects. + reload_objs="$libobjs $reload_conv_objs" + output="$libobj" + func_execute_cmds "$reload_cmds" 'exit $?' + fi + + if test -n "$gentop"; then + func_show_eval '${RM}r "$gentop"' + fi + + exit $EXIT_SUCCESS + ;; + + prog) + case $host in + *cygwin*) func_stripname '' '.exe' "$output" + output=$func_stripname_result.exe;; + esac + test -n "$vinfo" && \ + func_warning "\`-version-info' is ignored for programs" + + test -n "$release" && \ + func_warning "\`-release' is ignored for programs" + + test "$preload" = yes \ + && test "$dlopen_support" = unknown \ + && test "$dlopen_self" = unknown \ + && test "$dlopen_self_static" = unknown && \ + func_warning "\`LT_INIT([dlopen])' not used. Assuming no dlopen support." + + case $host in + *-*-rhapsody* | *-*-darwin1.[012]) + # On Rhapsody replace the C library is the System framework + compile_deplibs=`$ECHO " $compile_deplibs" | $SED 's/ -lc / System.ltframework /'` + finalize_deplibs=`$ECHO " $finalize_deplibs" | $SED 's/ -lc / System.ltframework /'` + ;; + esac + + case $host in + *-*-darwin*) + # Don't allow lazy linking, it breaks C++ global constructors + # But is supposedly fixed on 10.4 or later (yay!). + if test "$tagname" = CXX ; then + case ${MACOSX_DEPLOYMENT_TARGET-10.0} in + 10.[0123]) + compile_command+=" ${wl}-bind_at_load" + finalize_command+=" ${wl}-bind_at_load" + ;; + esac + fi + # Time to change all our "foo.ltframework" stuff back to "-framework foo" + compile_deplibs=`$ECHO " $compile_deplibs" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + finalize_deplibs=`$ECHO " $finalize_deplibs" | $SED 's% \([^ $]*\).ltframework% -framework \1%g'` + ;; + esac + + + # move library search paths that coincide with paths to not yet + # installed libraries to the beginning of the library search list + new_libs= + for path in $notinst_path; do + case " $new_libs " in + *" -L$path/$objdir "*) ;; + *) + case " $compile_deplibs " in + *" -L$path/$objdir "*) + new_libs+=" -L$path/$objdir" ;; + esac + ;; + esac + done + for deplib in $compile_deplibs; do + case $deplib in + -L*) + case " $new_libs " in + *" $deplib "*) ;; + *) new_libs+=" $deplib" ;; + esac + ;; + *) new_libs+=" $deplib" ;; + esac + done + compile_deplibs="$new_libs" + + + compile_command+=" $compile_deplibs" + finalize_command+=" $finalize_deplibs" + + if test -n "$rpath$xrpath"; then + # If the user specified any rpath flags, then add them. + for libdir in $rpath $xrpath; do + # This is the magic to use -rpath. + case "$finalize_rpath " in + *" $libdir "*) ;; + *) finalize_rpath+=" $libdir" ;; + esac + done + fi + + # Now hardcode the library paths + rpath= + hardcode_libdirs= + for libdir in $compile_rpath $finalize_rpath; do + if test -n "$hardcode_libdir_flag_spec"; then + if test -n "$hardcode_libdir_separator"; then + if test -z "$hardcode_libdirs"; then + hardcode_libdirs="$libdir" + else + # Just accumulate the unique libdirs. + case $hardcode_libdir_separator$hardcode_libdirs$hardcode_libdir_separator in + *"$hardcode_libdir_separator$libdir$hardcode_libdir_separator"*) + ;; + *) + hardcode_libdirs+="$hardcode_libdir_separator$libdir" + ;; + esac + fi + else + eval flag=\"$hardcode_libdir_flag_spec\" + rpath+=" $flag" + fi + elif test -n "$runpath_var"; then + case "$perm_rpath " in + *" $libdir "*) ;; + *) perm_rpath+=" $libdir" ;; + esac + fi + case $host in + *-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-os2* | *-cegcc*) + testbindir=`${ECHO} "$libdir" | ${SED} -e 's*/lib$*/bin*'` + case :$dllsearchpath: in + *":$libdir:"*) ;; + ::) dllsearchpath=$libdir;; + *) dllsearchpath+=":$libdir";; + esac + case :$dllsearchpath: in + *":$testbindir:"*) ;; + ::) dllsearchpath=$testbindir;; + *) dllsearchpath+=":$testbindir";; + esac + ;; + esac + done + # Substitute the hardcoded libdirs into the rpath. + if test -n "$hardcode_libdir_separator" && + test -n "$hardcode_libdirs"; then + libdir="$hardcode_libdirs" + eval rpath=\" $hardcode_libdir_flag_spec\" + fi + compile_rpath="$rpath" + + rpath= + hardcode_libdirs= + for libdir in $finalize_rpath; do + if test -n "$hardcode_libdir_flag_spec"; then + if test -n "$hardcode_libdir_separator"; then + if test -z "$hardcode_libdirs"; then + hardcode_libdirs="$libdir" + else + # Just accumulate the unique libdirs. + case $hardcode_libdir_separator$hardcode_libdirs$hardcode_libdir_separator in + *"$hardcode_libdir_separator$libdir$hardcode_libdir_separator"*) + ;; + *) + hardcode_libdirs+="$hardcode_libdir_separator$libdir" + ;; + esac + fi + else + eval flag=\"$hardcode_libdir_flag_spec\" + rpath+=" $flag" + fi + elif test -n "$runpath_var"; then + case "$finalize_perm_rpath " in + *" $libdir "*) ;; + *) finalize_perm_rpath+=" $libdir" ;; + esac + fi + done + # Substitute the hardcoded libdirs into the rpath. + if test -n "$hardcode_libdir_separator" && + test -n "$hardcode_libdirs"; then + libdir="$hardcode_libdirs" + eval rpath=\" $hardcode_libdir_flag_spec\" + fi + finalize_rpath="$rpath" + + if test -n "$libobjs" && test "$build_old_libs" = yes; then + # Transform all the library objects into standard objects. + compile_command=`$ECHO "$compile_command" | $SP2NL | $SED "$lo2o" | $NL2SP` + finalize_command=`$ECHO "$finalize_command" | $SP2NL | $SED "$lo2o" | $NL2SP` + fi + + func_generate_dlsyms "$outputname" "@PROGRAM@" "no" + + # template prelinking step + if test -n "$prelink_cmds"; then + func_execute_cmds "$prelink_cmds" 'exit $?' + fi + + wrappers_required=yes + case $host in + *cegcc* | *mingw32ce*) + # Disable wrappers for cegcc and mingw32ce hosts, we are cross compiling anyway. + wrappers_required=no + ;; + *cygwin* | *mingw* ) + if test "$build_libtool_libs" != yes; then + wrappers_required=no + fi + ;; + *) + if test "$need_relink" = no || test "$build_libtool_libs" != yes; then + wrappers_required=no + fi + ;; + esac + if test "$wrappers_required" = no; then + # Replace the output file specification. + compile_command=`$ECHO "$compile_command" | $SED 's%@OUTPUT@%'"$output"'%g'` + link_command="$compile_command$compile_rpath" + + # We have no uninstalled library dependencies, so finalize right now. + exit_status=0 + func_show_eval "$link_command" 'exit_status=$?' + + if test -n "$postlink_cmds"; then + func_to_tool_file "$output" + postlink_cmds=`func_echo_all "$postlink_cmds" | $SED -e 's%@OUTPUT@%'"$output"'%g' -e 's%@TOOL_OUTPUT@%'"$func_to_tool_file_result"'%g'` + func_execute_cmds "$postlink_cmds" 'exit $?' + fi + + # Delete the generated files. + if test -f "$output_objdir/${outputname}S.${objext}"; then + func_show_eval '$RM "$output_objdir/${outputname}S.${objext}"' + fi + + exit $exit_status + fi + + if test -n "$compile_shlibpath$finalize_shlibpath"; then + compile_command="$shlibpath_var=\"$compile_shlibpath$finalize_shlibpath\$$shlibpath_var\" $compile_command" + fi + if test -n "$finalize_shlibpath"; then + finalize_command="$shlibpath_var=\"$finalize_shlibpath\$$shlibpath_var\" $finalize_command" + fi + + compile_var= + finalize_var= + if test -n "$runpath_var"; then + if test -n "$perm_rpath"; then + # We should set the runpath_var. + rpath= + for dir in $perm_rpath; do + rpath+="$dir:" + done + compile_var="$runpath_var=\"$rpath\$$runpath_var\" " + fi + if test -n "$finalize_perm_rpath"; then + # We should set the runpath_var. + rpath= + for dir in $finalize_perm_rpath; do + rpath+="$dir:" + done + finalize_var="$runpath_var=\"$rpath\$$runpath_var\" " + fi + fi + + if test "$no_install" = yes; then + # We don't need to create a wrapper script. + link_command="$compile_var$compile_command$compile_rpath" + # Replace the output file specification. + link_command=`$ECHO "$link_command" | $SED 's%@OUTPUT@%'"$output"'%g'` + # Delete the old output file. + $opt_dry_run || $RM $output + # Link the executable and exit + func_show_eval "$link_command" 'exit $?' + + if test -n "$postlink_cmds"; then + func_to_tool_file "$output" + postlink_cmds=`func_echo_all "$postlink_cmds" | $SED -e 's%@OUTPUT@%'"$output"'%g' -e 's%@TOOL_OUTPUT@%'"$func_to_tool_file_result"'%g'` + func_execute_cmds "$postlink_cmds" 'exit $?' + fi + + exit $EXIT_SUCCESS + fi + + if test "$hardcode_action" = relink; then + # Fast installation is not supported + link_command="$compile_var$compile_command$compile_rpath" + relink_command="$finalize_var$finalize_command$finalize_rpath" + + func_warning "this platform does not like uninstalled shared libraries" + func_warning "\`$output' will be relinked during installation" + else + if test "$fast_install" != no; then + link_command="$finalize_var$compile_command$finalize_rpath" + if test "$fast_install" = yes; then + relink_command=`$ECHO "$compile_var$compile_command$compile_rpath" | $SED 's%@OUTPUT@%\$progdir/\$file%g'` + else + # fast_install is set to needless + relink_command= + fi + else + link_command="$compile_var$compile_command$compile_rpath" + relink_command="$finalize_var$finalize_command$finalize_rpath" + fi + fi + + # Replace the output file specification. + link_command=`$ECHO "$link_command" | $SED 's%@OUTPUT@%'"$output_objdir/$outputname"'%g'` + + # Delete the old output files. + $opt_dry_run || $RM $output $output_objdir/$outputname $output_objdir/lt-$outputname + + func_show_eval "$link_command" 'exit $?' + + if test -n "$postlink_cmds"; then + func_to_tool_file "$output_objdir/$outputname" + postlink_cmds=`func_echo_all "$postlink_cmds" | $SED -e 's%@OUTPUT@%'"$output_objdir/$outputname"'%g' -e 's%@TOOL_OUTPUT@%'"$func_to_tool_file_result"'%g'` + func_execute_cmds "$postlink_cmds" 'exit $?' + fi + + # Now create the wrapper script. + func_verbose "creating $output" + + # Quote the relink command for shipping. + if test -n "$relink_command"; then + # Preserve any variables that may affect compiler behavior + for var in $variables_saved_for_relink; do + if eval test -z \"\${$var+set}\"; then + relink_command="{ test -z \"\${$var+set}\" || $lt_unset $var || { $var=; export $var; }; }; $relink_command" + elif eval var_value=\$$var; test -z "$var_value"; then + relink_command="$var=; export $var; $relink_command" + else + func_quote_for_eval "$var_value" + relink_command="$var=$func_quote_for_eval_result; export $var; $relink_command" + fi + done + relink_command="(cd `pwd`; $relink_command)" + relink_command=`$ECHO "$relink_command" | $SED "$sed_quote_subst"` + fi + + # Only actually do things if not in dry run mode. + $opt_dry_run || { + # win32 will think the script is a binary if it has + # a .exe suffix, so we strip it off here. + case $output in + *.exe) func_stripname '' '.exe' "$output" + output=$func_stripname_result ;; + esac + # test for cygwin because mv fails w/o .exe extensions + case $host in + *cygwin*) + exeext=.exe + func_stripname '' '.exe' "$outputname" + outputname=$func_stripname_result ;; + *) exeext= ;; + esac + case $host in + *cygwin* | *mingw* ) + func_dirname_and_basename "$output" "" "." + output_name=$func_basename_result + output_path=$func_dirname_result + cwrappersource="$output_path/$objdir/lt-$output_name.c" + cwrapper="$output_path/$output_name.exe" + $RM $cwrappersource $cwrapper + trap "$RM $cwrappersource $cwrapper; exit $EXIT_FAILURE" 1 2 15 + + func_emit_cwrapperexe_src > $cwrappersource + + # The wrapper executable is built using the $host compiler, + # because it contains $host paths and files. If cross- + # compiling, it, like the target executable, must be + # executed on the $host or under an emulation environment. + $opt_dry_run || { + $LTCC $LTCFLAGS -o $cwrapper $cwrappersource + $STRIP $cwrapper + } + + # Now, create the wrapper script for func_source use: + func_ltwrapper_scriptname $cwrapper + $RM $func_ltwrapper_scriptname_result + trap "$RM $func_ltwrapper_scriptname_result; exit $EXIT_FAILURE" 1 2 15 + $opt_dry_run || { + # note: this script will not be executed, so do not chmod. + if test "x$build" = "x$host" ; then + $cwrapper --lt-dump-script > $func_ltwrapper_scriptname_result + else + func_emit_wrapper no > $func_ltwrapper_scriptname_result + fi + } + ;; + * ) + $RM $output + trap "$RM $output; exit $EXIT_FAILURE" 1 2 15 + + func_emit_wrapper no > $output + chmod +x $output + ;; + esac + } + exit $EXIT_SUCCESS + ;; + esac + + # See if we need to build an old-fashioned archive. + for oldlib in $oldlibs; do + + if test "$build_libtool_libs" = convenience; then + oldobjs="$libobjs_save $symfileobj" + addlibs="$convenience" + build_libtool_libs=no + else + if test "$build_libtool_libs" = module; then + oldobjs="$libobjs_save" + build_libtool_libs=no + else + oldobjs="$old_deplibs $non_pic_objects" + if test "$preload" = yes && test -f "$symfileobj"; then + oldobjs+=" $symfileobj" + fi + fi + addlibs="$old_convenience" + fi + + if test -n "$addlibs"; then + gentop="$output_objdir/${outputname}x" + generated+=" $gentop" + + func_extract_archives $gentop $addlibs + oldobjs+=" $func_extract_archives_result" + fi + + # Do each command in the archive commands. + if test -n "$old_archive_from_new_cmds" && test "$build_libtool_libs" = yes; then + cmds=$old_archive_from_new_cmds + else + + # Add any objects from preloaded convenience libraries + if test -n "$dlprefiles"; then + gentop="$output_objdir/${outputname}x" + generated+=" $gentop" + + func_extract_archives $gentop $dlprefiles + oldobjs+=" $func_extract_archives_result" + fi + + # POSIX demands no paths to be encoded in archives. We have + # to avoid creating archives with duplicate basenames if we + # might have to extract them afterwards, e.g., when creating a + # static archive out of a convenience library, or when linking + # the entirety of a libtool archive into another (currently + # not supported by libtool). + if (for obj in $oldobjs + do + func_basename "$obj" + $ECHO "$func_basename_result" + done | sort | sort -uc >/dev/null 2>&1); then + : + else + echo "copying selected object files to avoid basename conflicts..." + gentop="$output_objdir/${outputname}x" + generated+=" $gentop" + func_mkdir_p "$gentop" + save_oldobjs=$oldobjs + oldobjs= + counter=1 + for obj in $save_oldobjs + do + func_basename "$obj" + objbase="$func_basename_result" + case " $oldobjs " in + " ") oldobjs=$obj ;; + *[\ /]"$objbase "*) + while :; do + # Make sure we don't pick an alternate name that also + # overlaps. + newobj=lt$counter-$objbase + func_arith $counter + 1 + counter=$func_arith_result + case " $oldobjs " in + *[\ /]"$newobj "*) ;; + *) if test ! -f "$gentop/$newobj"; then break; fi ;; + esac + done + func_show_eval "ln $obj $gentop/$newobj || cp $obj $gentop/$newobj" + oldobjs+=" $gentop/$newobj" + ;; + *) oldobjs+=" $obj" ;; + esac + done + fi + func_to_tool_file "$oldlib" func_convert_file_msys_to_w32 + tool_oldlib=$func_to_tool_file_result + eval cmds=\"$old_archive_cmds\" + + func_len " $cmds" + len=$func_len_result + if test "$len" -lt "$max_cmd_len" || test "$max_cmd_len" -le -1; then + cmds=$old_archive_cmds + elif test -n "$archiver_list_spec"; then + func_verbose "using command file archive linking..." + for obj in $oldobjs + do + func_to_tool_file "$obj" + $ECHO "$func_to_tool_file_result" + done > $output_objdir/$libname.libcmd + func_to_tool_file "$output_objdir/$libname.libcmd" + oldobjs=" $archiver_list_spec$func_to_tool_file_result" + cmds=$old_archive_cmds + else + # the command line is too long to link in one step, link in parts + func_verbose "using piecewise archive linking..." + save_RANLIB=$RANLIB + RANLIB=: + objlist= + concat_cmds= + save_oldobjs=$oldobjs + oldobjs= + # Is there a better way of finding the last object in the list? + for obj in $save_oldobjs + do + last_oldobj=$obj + done + eval test_cmds=\"$old_archive_cmds\" + func_len " $test_cmds" + len0=$func_len_result + len=$len0 + for obj in $save_oldobjs + do + func_len " $obj" + func_arith $len + $func_len_result + len=$func_arith_result + objlist+=" $obj" + if test "$len" -lt "$max_cmd_len"; then + : + else + # the above command should be used before it gets too long + oldobjs=$objlist + if test "$obj" = "$last_oldobj" ; then + RANLIB=$save_RANLIB + fi + test -z "$concat_cmds" || concat_cmds=$concat_cmds~ + eval concat_cmds=\"\${concat_cmds}$old_archive_cmds\" + objlist= + len=$len0 + fi + done + RANLIB=$save_RANLIB + oldobjs=$objlist + if test "X$oldobjs" = "X" ; then + eval cmds=\"\$concat_cmds\" + else + eval cmds=\"\$concat_cmds~\$old_archive_cmds\" + fi + fi + fi + func_execute_cmds "$cmds" 'exit $?' + done + + test -n "$generated" && \ + func_show_eval "${RM}r$generated" + + # Now create the libtool archive. + case $output in + *.la) + old_library= + test "$build_old_libs" = yes && old_library="$libname.$libext" + func_verbose "creating $output" + + # Preserve any variables that may affect compiler behavior + for var in $variables_saved_for_relink; do + if eval test -z \"\${$var+set}\"; then + relink_command="{ test -z \"\${$var+set}\" || $lt_unset $var || { $var=; export $var; }; }; $relink_command" + elif eval var_value=\$$var; test -z "$var_value"; then + relink_command="$var=; export $var; $relink_command" + else + func_quote_for_eval "$var_value" + relink_command="$var=$func_quote_for_eval_result; export $var; $relink_command" + fi + done + # Quote the link command for shipping. + relink_command="(cd `pwd`; $SHELL $progpath $preserve_args --mode=relink $libtool_args @inst_prefix_dir@)" + relink_command=`$ECHO "$relink_command" | $SED "$sed_quote_subst"` + if test "$hardcode_automatic" = yes ; then + relink_command= + fi + + # Only create the output if not a dry run. + $opt_dry_run || { + for installed in no yes; do + if test "$installed" = yes; then + if test -z "$install_libdir"; then + break + fi + output="$output_objdir/$outputname"i + # Replace all uninstalled libtool libraries with the installed ones + newdependency_libs= + for deplib in $dependency_libs; do + case $deplib in + *.la) + func_basename "$deplib" + name="$func_basename_result" + func_resolve_sysroot "$deplib" + eval libdir=`${SED} -n -e 's/^libdir=\(.*\)$/\1/p' $func_resolve_sysroot_result` + test -z "$libdir" && \ + func_fatal_error "\`$deplib' is not a valid libtool archive" + newdependency_libs+=" ${lt_sysroot:+=}$libdir/$name" + ;; + -L*) + func_stripname -L '' "$deplib" + func_replace_sysroot "$func_stripname_result" + newdependency_libs+=" -L$func_replace_sysroot_result" + ;; + -R*) + func_stripname -R '' "$deplib" + func_replace_sysroot "$func_stripname_result" + newdependency_libs+=" -R$func_replace_sysroot_result" + ;; + *) newdependency_libs+=" $deplib" ;; + esac + done + dependency_libs="$newdependency_libs" + newdlfiles= + + for lib in $dlfiles; do + case $lib in + *.la) + func_basename "$lib" + name="$func_basename_result" + eval libdir=`${SED} -n -e 's/^libdir=\(.*\)$/\1/p' $lib` + test -z "$libdir" && \ + func_fatal_error "\`$lib' is not a valid libtool archive" + newdlfiles+=" ${lt_sysroot:+=}$libdir/$name" + ;; + *) newdlfiles+=" $lib" ;; + esac + done + dlfiles="$newdlfiles" + newdlprefiles= + for lib in $dlprefiles; do + case $lib in + *.la) + # Only pass preopened files to the pseudo-archive (for + # eventual linking with the app. that links it) if we + # didn't already link the preopened objects directly into + # the library: + func_basename "$lib" + name="$func_basename_result" + eval libdir=`${SED} -n -e 's/^libdir=\(.*\)$/\1/p' $lib` + test -z "$libdir" && \ + func_fatal_error "\`$lib' is not a valid libtool archive" + newdlprefiles+=" ${lt_sysroot:+=}$libdir/$name" + ;; + esac + done + dlprefiles="$newdlprefiles" + else + newdlfiles= + for lib in $dlfiles; do + case $lib in + [\\/]* | [A-Za-z]:[\\/]*) abs="$lib" ;; + *) abs=`pwd`"/$lib" ;; + esac + newdlfiles+=" $abs" + done + dlfiles="$newdlfiles" + newdlprefiles= + for lib in $dlprefiles; do + case $lib in + [\\/]* | [A-Za-z]:[\\/]*) abs="$lib" ;; + *) abs=`pwd`"/$lib" ;; + esac + newdlprefiles+=" $abs" + done + dlprefiles="$newdlprefiles" + fi + $RM $output + # place dlname in correct position for cygwin + # In fact, it would be nice if we could use this code for all target + # systems that can't hard-code library paths into their executables + # and that have no shared library path variable independent of PATH, + # but it turns out we can't easily determine that from inspecting + # libtool variables, so we have to hard-code the OSs to which it + # applies here; at the moment, that means platforms that use the PE + # object format with DLL files. See the long comment at the top of + # tests/bindir.at for full details. + tdlname=$dlname + case $host,$output,$installed,$module,$dlname in + *cygwin*,*lai,yes,no,*.dll | *mingw*,*lai,yes,no,*.dll | *cegcc*,*lai,yes,no,*.dll) + # If a -bindir argument was supplied, place the dll there. + if test "x$bindir" != x ; + then + func_relative_path "$install_libdir" "$bindir" + tdlname=$func_relative_path_result$dlname + else + # Otherwise fall back on heuristic. + tdlname=../bin/$dlname + fi + ;; + esac + $ECHO > $output "\ +# $outputname - a libtool library file +# Generated by $PROGRAM (GNU $PACKAGE$TIMESTAMP) $VERSION +# +# Please DO NOT delete this file! +# It is necessary for linking the library. + +# The name that we can dlopen(3). +dlname='$tdlname' + +# Names of this library. +library_names='$library_names' + +# The name of the static archive. +old_library='$old_library' + +# Linker flags that can not go in dependency_libs. +inherited_linker_flags='$new_inherited_linker_flags' + +# Libraries that this one depends upon. +dependency_libs='$dependency_libs' + +# Names of additional weak libraries provided by this library +weak_library_names='$weak_libs' + +# Version information for $libname. +current=$current +age=$age +revision=$revision + +# Is this an already installed library? +installed=$installed + +# Should we warn about portability when linking against -modules? +shouldnotlink=$module + +# Files to dlopen/dlpreopen +dlopen='$dlfiles' +dlpreopen='$dlprefiles' + +# Directory that this library needs to be installed in: +libdir='$install_libdir'" + if test "$installed" = no && test "$need_relink" = yes; then + $ECHO >> $output "\ +relink_command=\"$relink_command\"" + fi + done + } + + # Do a symbolic link so that the libtool archive can be found in + # LD_LIBRARY_PATH before the program is installed. + func_show_eval '( cd "$output_objdir" && $RM "$outputname" && $LN_S "../$outputname" "$outputname" )' 'exit $?' + ;; + esac + exit $EXIT_SUCCESS +} + +{ test "$opt_mode" = link || test "$opt_mode" = relink; } && + func_mode_link ${1+"$@"} + + +# func_mode_uninstall arg... +func_mode_uninstall () +{ + $opt_debug + RM="$nonopt" + files= + rmforce= + exit_status=0 + + # This variable tells wrapper scripts just to set variables rather + # than running their programs. + libtool_install_magic="$magic" + + for arg + do + case $arg in + -f) RM+=" $arg"; rmforce=yes ;; + -*) RM+=" $arg" ;; + *) files+=" $arg" ;; + esac + done + + test -z "$RM" && \ + func_fatal_help "you must specify an RM program" + + rmdirs= + + for file in $files; do + func_dirname "$file" "" "." + dir="$func_dirname_result" + if test "X$dir" = X.; then + odir="$objdir" + else + odir="$dir/$objdir" + fi + func_basename "$file" + name="$func_basename_result" + test "$opt_mode" = uninstall && odir="$dir" + + # Remember odir for removal later, being careful to avoid duplicates + if test "$opt_mode" = clean; then + case " $rmdirs " in + *" $odir "*) ;; + *) rmdirs+=" $odir" ;; + esac + fi + + # Don't error if the file doesn't exist and rm -f was used. + if { test -L "$file"; } >/dev/null 2>&1 || + { test -h "$file"; } >/dev/null 2>&1 || + test -f "$file"; then + : + elif test -d "$file"; then + exit_status=1 + continue + elif test "$rmforce" = yes; then + continue + fi + + rmfiles="$file" + + case $name in + *.la) + # Possibly a libtool archive, so verify it. + if func_lalib_p "$file"; then + func_source $dir/$name + + # Delete the libtool libraries and symlinks. + for n in $library_names; do + rmfiles+=" $odir/$n" + done + test -n "$old_library" && rmfiles+=" $odir/$old_library" + + case "$opt_mode" in + clean) + case " $library_names " in + *" $dlname "*) ;; + *) test -n "$dlname" && rmfiles+=" $odir/$dlname" ;; + esac + test -n "$libdir" && rmfiles+=" $odir/$name $odir/${name}i" + ;; + uninstall) + if test -n "$library_names"; then + # Do each command in the postuninstall commands. + func_execute_cmds "$postuninstall_cmds" 'test "$rmforce" = yes || exit_status=1' + fi + + if test -n "$old_library"; then + # Do each command in the old_postuninstall commands. + func_execute_cmds "$old_postuninstall_cmds" 'test "$rmforce" = yes || exit_status=1' + fi + # FIXME: should reinstall the best remaining shared library. + ;; + esac + fi + ;; + + *.lo) + # Possibly a libtool object, so verify it. + if func_lalib_p "$file"; then + + # Read the .lo file + func_source $dir/$name + + # Add PIC object to the list of files to remove. + if test -n "$pic_object" && + test "$pic_object" != none; then + rmfiles+=" $dir/$pic_object" + fi + + # Add non-PIC object to the list of files to remove. + if test -n "$non_pic_object" && + test "$non_pic_object" != none; then + rmfiles+=" $dir/$non_pic_object" + fi + fi + ;; + + *) + if test "$opt_mode" = clean ; then + noexename=$name + case $file in + *.exe) + func_stripname '' '.exe' "$file" + file=$func_stripname_result + func_stripname '' '.exe' "$name" + noexename=$func_stripname_result + # $file with .exe has already been added to rmfiles, + # add $file without .exe + rmfiles+=" $file" + ;; + esac + # Do a test to see if this is a libtool program. + if func_ltwrapper_p "$file"; then + if func_ltwrapper_executable_p "$file"; then + func_ltwrapper_scriptname "$file" + relink_command= + func_source $func_ltwrapper_scriptname_result + rmfiles+=" $func_ltwrapper_scriptname_result" + else + relink_command= + func_source $dir/$noexename + fi + + # note $name still contains .exe if it was in $file originally + # as does the version of $file that was added into $rmfiles + rmfiles+=" $odir/$name $odir/${name}S.${objext}" + if test "$fast_install" = yes && test -n "$relink_command"; then + rmfiles+=" $odir/lt-$name" + fi + if test "X$noexename" != "X$name" ; then + rmfiles+=" $odir/lt-${noexename}.c" + fi + fi + fi + ;; + esac + func_show_eval "$RM $rmfiles" 'exit_status=1' + done + + # Try to remove the ${objdir}s in the directories where we deleted files + for dir in $rmdirs; do + if test -d "$dir"; then + func_show_eval "rmdir $dir >/dev/null 2>&1" + fi + done + + exit $exit_status +} + +{ test "$opt_mode" = uninstall || test "$opt_mode" = clean; } && + func_mode_uninstall ${1+"$@"} + +test -z "$opt_mode" && { + help="$generic_help" + func_fatal_help "you must specify a MODE" +} + +test -z "$exec_cmd" && \ + func_fatal_help "invalid operation mode \`$opt_mode'" + +if test -n "$exec_cmd"; then + eval exec "$exec_cmd" + exit $EXIT_FAILURE +fi + +exit $exit_status + + +# The TAGs below are defined such that we never get into a situation +# in which we disable both kinds of libraries. Given conflicting +# choices, we go for a static library, that is the most portable, +# since we can't tell whether shared libraries were disabled because +# the user asked for that or because the platform doesn't support +# them. This is particularly important on AIX, because we don't +# support having both static and shared libraries enabled at the same +# time on that platform, so we default to a shared-only configuration. +# If a disable-shared tag is given, we'll fallback to a static-only +# configuration. But we'll never go from static-only to shared-only. + +# ### BEGIN LIBTOOL TAG CONFIG: disable-shared +build_libtool_libs=no +build_old_libs=yes +# ### END LIBTOOL TAG CONFIG: disable-shared + +# ### BEGIN LIBTOOL TAG CONFIG: disable-static +build_old_libs=`case $build_libtool_libs in yes) echo no;; *) echo yes;; esac` +# ### END LIBTOOL TAG CONFIG: disable-static + +# Local Variables: +# mode:shell-script +# sh-indentation:2 +# End: +# vi:sw=2 + + +# ### BEGIN LIBTOOL TAG CONFIG: CXX + +# The linker used to build libraries. +LD="/usr/bin/ld -m elf_x86_64" + +# How to create reloadable object files. +reload_flag=" -r" +reload_cmds="\$LD\$reload_flag -o \$output\$reload_objs" + +# Commands used to build an old-style archive. +old_archive_cmds="\$AR \$AR_FLAGS \$oldlib\$oldobjs~\$RANLIB \$tool_oldlib" + +# A language specific compiler. +CC="g++" + +# Is the compiler the GNU compiler? +with_gcc=yes + +# Compiler flag to turn off builtin functions. +no_builtin_flag=" -fno-builtin" + +# Additional compiler flags for building library objects. +pic_flag=" -fPIC -DPIC" + +# How to pass a linker flag through the compiler. +wl="-Wl," + +# Compiler flag to prevent dynamic linking. +link_static_flag="" + +# Does compiler simultaneously support -c and -o options? +compiler_c_o="yes" + +# Whether or not to add -lc for building shared libraries. +build_libtool_need_lc=no + +# Whether or not to disallow shared libs when runtime libs are static. +allow_libtool_libs_with_static_runtimes=no + +# Compiler flag to allow reflexive dlopens. +export_dynamic_flag_spec="\${wl}--export-dynamic" + +# Compiler flag to generate shared objects directly from archives. +whole_archive_flag_spec="\${wl}--whole-archive\$convenience \${wl}--no-whole-archive" + +# Whether the compiler copes with passing no objects directly. +compiler_needs_object="no" + +# Create an old-style archive from a shared archive. +old_archive_from_new_cmds="" + +# Create a temporary old-style archive to link instead of a shared archive. +old_archive_from_expsyms_cmds="" + +# Commands used to build a shared archive. +archive_cmds="\$CC \$pic_flag -shared -nostdlib \$predep_objects \$libobjs \$deplibs \$postdep_objects \$compiler_flags \${wl}-soname \$wl\$soname -o \$lib" +archive_expsym_cmds="\$CC \$pic_flag -shared -nostdlib \$predep_objects \$libobjs \$deplibs \$postdep_objects \$compiler_flags \${wl}-soname \$wl\$soname \${wl}-retain-symbols-file \$wl\$export_symbols -o \$lib" + +# Commands used to build a loadable module if different from building +# a shared archive. +module_cmds="" +module_expsym_cmds="" + +# Whether we are building with GNU ld or not. +with_gnu_ld="yes" + +# Flag that allows shared libraries with undefined symbols to be built. +allow_undefined_flag="" + +# Flag that enforces no undefined symbols. +no_undefined_flag="" + +# Flag to hardcode $libdir into a binary during linking. +# This must work even if $libdir does not exist +hardcode_libdir_flag_spec="\${wl}-rpath \${wl}\$libdir" + +# Whether we need a single "-rpath" flag with a separated argument. +hardcode_libdir_separator="" + +# Set to "yes" if using DIR/libNAME${shared_ext} during linking hardcodes +# DIR into the resulting binary. +hardcode_direct=no + +# Set to "yes" if using DIR/libNAME${shared_ext} during linking hardcodes +# DIR into the resulting binary and the resulting library dependency is +# "absolute",i.e impossible to change by setting ${shlibpath_var} if the +# library is relocated. +hardcode_direct_absolute=no + +# Set to "yes" if using the -LDIR flag during linking hardcodes DIR +# into the resulting binary. +hardcode_minus_L=no + +# Set to "yes" if using SHLIBPATH_VAR=DIR during linking hardcodes DIR +# into the resulting binary. +hardcode_shlibpath_var=unsupported + +# Set to "yes" if building a shared library automatically hardcodes DIR +# into the library and all subsequent libraries and executables linked +# against it. +hardcode_automatic=no + +# Set to yes if linker adds runtime paths of dependent libraries +# to runtime path list. +inherit_rpath=no + +# Whether libtool must link a program against all its dependency libraries. +link_all_deplibs=unknown + +# Set to "yes" if exported symbols are required. +always_export_symbols=no + +# The commands to list exported symbols. +export_symbols_cmds="\$NM \$libobjs \$convenience | \$global_symbol_pipe | \$SED 's/.* //' | sort | uniq > \$export_symbols" + +# Symbols that should not be listed in the preloaded symbols. +exclude_expsyms="_GLOBAL_OFFSET_TABLE_|_GLOBAL__F[ID]_.*" + +# Symbols that must always be exported. +include_expsyms="" + +# Commands necessary for linking programs (against libraries) with templates. +prelink_cmds="" + +# Commands necessary for finishing linking programs. +postlink_cmds="" + +# Specify filename containing input files. +file_list_spec="" + +# How to hardcode a shared library path into an executable. +hardcode_action=immediate + +# The directories searched by this compiler when creating a shared library. +compiler_lib_search_dirs="/usr/lib/gcc/x86_64-redhat-linux/4.8.3 /usr/lib/gcc/x86_64-redhat-linux/4.8.3/../../../../lib64 /lib/../lib64 /usr/lib/../lib64 /usr/lib/gcc/x86_64-redhat-linux/4.8.3/../../.." + +# Dependencies to place before and after the objects being linked to +# create a shared library. +predep_objects="/usr/lib/gcc/x86_64-redhat-linux/4.8.3/../../../../lib64/crti.o /usr/lib/gcc/x86_64-redhat-linux/4.8.3/crtbeginS.o" +postdep_objects="/usr/lib/gcc/x86_64-redhat-linux/4.8.3/crtendS.o /usr/lib/gcc/x86_64-redhat-linux/4.8.3/../../../../lib64/crtn.o" +predeps="" +postdeps="-lstdc++ -lm -lgcc_s -lc -lgcc_s" + +# The library search path used internally by the compiler when linking +# a shared library. +compiler_lib_search_path="-L/usr/lib/gcc/x86_64-redhat-linux/4.8.3 -L/usr/lib/gcc/x86_64-redhat-linux/4.8.3/../../../../lib64 -L/lib/../lib64 -L/usr/lib/../lib64 -L/usr/lib/gcc/x86_64-redhat-linux/4.8.3/../../.." + +# ### END LIBTOOL TAG CONFIG: CXX diff --git a/libconfig-1.4.9/m4/libtool.m4 b/libconfig-1.4.9/m4/libtool.m4 new file mode 100644 index 0000000000000000000000000000000000000000..44e0ecff11e3a16ca7656be45268d0bd597afc51 --- /dev/null +++ b/libconfig-1.4.9/m4/libtool.m4 @@ -0,0 +1,7982 @@ +# libtool.m4 - Configure libtool for the host system. -*-Autoconf-*- +# +# Copyright (C) 1996, 1997, 1998, 1999, 2000, 2001, 2003, 2004, 2005, +# 2006, 2007, 2008, 2009, 2010, 2011 Free Software +# Foundation, Inc. +# Written by Gordon Matzigkeit, 1996 +# +# This file is free software; the Free Software Foundation gives +# unlimited permission to copy and/or distribute it, with or without +# modifications, as long as this notice is preserved. + +m4_define([_LT_COPYING], [dnl +# Copyright (C) 1996, 1997, 1998, 1999, 2000, 2001, 2003, 2004, 2005, +# 2006, 2007, 2008, 2009, 2010, 2011 Free Software +# Foundation, Inc. +# Written by Gordon Matzigkeit, 1996 +# +# This file is part of GNU Libtool. +# +# GNU Libtool is free software; you can redistribute it and/or +# modify it under the terms of the GNU General Public License as +# published by the Free Software Foundation; either version 2 of +# the License, or (at your option) any later version. +# +# As a special exception to the GNU General Public License, +# if you distribute this file as part of a program or library that +# is built using GNU Libtool, you may include this file under the +# same distribution terms that you use for the rest of that program. +# +# GNU Libtool is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY; without even the implied warranty of +# MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +# GNU General Public License for more details. +# +# You should have received a copy of the GNU General Public License +# along with GNU Libtool; see the file COPYING. If not, a copy +# can be downloaded from http://www.gnu.org/licenses/gpl.html, or +# obtained by writing to the Free Software Foundation, Inc., +# 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301, USA. +]) + +# serial 57 LT_INIT + + +# LT_PREREQ(VERSION) +# ------------------ +# Complain and exit if this libtool version is less that VERSION. +m4_defun([LT_PREREQ], +[m4_if(m4_version_compare(m4_defn([LT_PACKAGE_VERSION]), [$1]), -1, + [m4_default([$3], + [m4_fatal([Libtool version $1 or higher is required], + 63)])], + [$2])]) + + +# _LT_CHECK_BUILDDIR +# ------------------ +# Complain if the absolute build directory name contains unusual characters +m4_defun([_LT_CHECK_BUILDDIR], +[case `pwd` in + *\ * | *\ *) + AC_MSG_WARN([Libtool does not cope well with whitespace in `pwd`]) ;; +esac +]) + + +# LT_INIT([OPTIONS]) +# ------------------ +AC_DEFUN([LT_INIT], +[AC_PREREQ([2.58])dnl We use AC_INCLUDES_DEFAULT +AC_REQUIRE([AC_CONFIG_AUX_DIR_DEFAULT])dnl +AC_BEFORE([$0], [LT_LANG])dnl +AC_BEFORE([$0], [LT_OUTPUT])dnl +AC_BEFORE([$0], [LTDL_INIT])dnl +m4_require([_LT_CHECK_BUILDDIR])dnl + +dnl Autoconf doesn't catch unexpanded LT_ macros by default: +m4_pattern_forbid([^_?LT_[A-Z_]+$])dnl +m4_pattern_allow([^(_LT_EOF|LT_DLGLOBAL|LT_DLLAZY_OR_NOW|LT_MULTI_MODULE)$])dnl +dnl aclocal doesn't pull ltoptions.m4, ltsugar.m4, or ltversion.m4 +dnl unless we require an AC_DEFUNed macro: +AC_REQUIRE([LTOPTIONS_VERSION])dnl +AC_REQUIRE([LTSUGAR_VERSION])dnl +AC_REQUIRE([LTVERSION_VERSION])dnl +AC_REQUIRE([LTOBSOLETE_VERSION])dnl +m4_require([_LT_PROG_LTMAIN])dnl + +_LT_SHELL_INIT([SHELL=${CONFIG_SHELL-/bin/sh}]) + +dnl Parse OPTIONS +_LT_SET_OPTIONS([$0], [$1]) + +# This can be used to rebuild libtool when needed +LIBTOOL_DEPS="$ltmain" + +# Always use our own libtool. +LIBTOOL='$(SHELL) $(top_builddir)/libtool' +AC_SUBST(LIBTOOL)dnl + +_LT_SETUP + +# Only expand once: +m4_define([LT_INIT]) +])# LT_INIT + +# Old names: +AU_ALIAS([AC_PROG_LIBTOOL], [LT_INIT]) +AU_ALIAS([AM_PROG_LIBTOOL], [LT_INIT]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_PROG_LIBTOOL], []) +dnl AC_DEFUN([AM_PROG_LIBTOOL], []) + + +# _LT_CC_BASENAME(CC) +# ------------------- +# Calculate cc_basename. Skip known compiler wrappers and cross-prefix. +m4_defun([_LT_CC_BASENAME], +[for cc_temp in $1""; do + case $cc_temp in + compile | *[[\\/]]compile | ccache | *[[\\/]]ccache ) ;; + distcc | *[[\\/]]distcc | purify | *[[\\/]]purify ) ;; + \-*) ;; + *) break;; + esac +done +cc_basename=`$ECHO "$cc_temp" | $SED "s%.*/%%; s%^$host_alias-%%"` +]) + + +# _LT_FILEUTILS_DEFAULTS +# ---------------------- +# It is okay to use these file commands and assume they have been set +# sensibly after `m4_require([_LT_FILEUTILS_DEFAULTS])'. +m4_defun([_LT_FILEUTILS_DEFAULTS], +[: ${CP="cp -f"} +: ${MV="mv -f"} +: ${RM="rm -f"} +])# _LT_FILEUTILS_DEFAULTS + + +# _LT_SETUP +# --------- +m4_defun([_LT_SETUP], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +AC_REQUIRE([AC_CANONICAL_BUILD])dnl +AC_REQUIRE([_LT_PREPARE_SED_QUOTE_VARS])dnl +AC_REQUIRE([_LT_PROG_ECHO_BACKSLASH])dnl + +_LT_DECL([], [PATH_SEPARATOR], [1], [The PATH separator for the build system])dnl +dnl +_LT_DECL([], [host_alias], [0], [The host system])dnl +_LT_DECL([], [host], [0])dnl +_LT_DECL([], [host_os], [0])dnl +dnl +_LT_DECL([], [build_alias], [0], [The build system])dnl +_LT_DECL([], [build], [0])dnl +_LT_DECL([], [build_os], [0])dnl +dnl +AC_REQUIRE([AC_PROG_CC])dnl +AC_REQUIRE([LT_PATH_LD])dnl +AC_REQUIRE([LT_PATH_NM])dnl +dnl +AC_REQUIRE([AC_PROG_LN_S])dnl +test -z "$LN_S" && LN_S="ln -s" +_LT_DECL([], [LN_S], [1], [Whether we need soft or hard links])dnl +dnl +AC_REQUIRE([LT_CMD_MAX_LEN])dnl +_LT_DECL([objext], [ac_objext], [0], [Object file suffix (normally "o")])dnl +_LT_DECL([], [exeext], [0], [Executable file suffix (normally "")])dnl +dnl +m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_CHECK_SHELL_FEATURES])dnl +m4_require([_LT_PATH_CONVERSION_FUNCTIONS])dnl +m4_require([_LT_CMD_RELOAD])dnl +m4_require([_LT_CHECK_MAGIC_METHOD])dnl +m4_require([_LT_CHECK_SHAREDLIB_FROM_LINKLIB])dnl +m4_require([_LT_CMD_OLD_ARCHIVE])dnl +m4_require([_LT_CMD_GLOBAL_SYMBOLS])dnl +m4_require([_LT_WITH_SYSROOT])dnl + +_LT_CONFIG_LIBTOOL_INIT([ +# See if we are running on zsh, and set the options which allow our +# commands through without removal of \ escapes INIT. +if test -n "\${ZSH_VERSION+set}" ; then + setopt NO_GLOB_SUBST +fi +]) +if test -n "${ZSH_VERSION+set}" ; then + setopt NO_GLOB_SUBST +fi + +_LT_CHECK_OBJDIR + +m4_require([_LT_TAG_COMPILER])dnl + +case $host_os in +aix3*) + # AIX sometimes has problems with the GCC collect2 program. For some + # reason, if we set the COLLECT_NAMES environment variable, the problems + # vanish in a puff of smoke. + if test "X${COLLECT_NAMES+set}" != Xset; then + COLLECT_NAMES= + export COLLECT_NAMES + fi + ;; +esac + +# Global variables: +ofile=libtool +can_build_shared=yes + +# All known linkers require a `.a' archive for static linking (except MSVC, +# which needs '.lib'). +libext=a + +with_gnu_ld="$lt_cv_prog_gnu_ld" + +old_CC="$CC" +old_CFLAGS="$CFLAGS" + +# Set sane defaults for various variables +test -z "$CC" && CC=cc +test -z "$LTCC" && LTCC=$CC +test -z "$LTCFLAGS" && LTCFLAGS=$CFLAGS +test -z "$LD" && LD=ld +test -z "$ac_objext" && ac_objext=o + +_LT_CC_BASENAME([$compiler]) + +# Only perform the check for file, if the check method requires it +test -z "$MAGIC_CMD" && MAGIC_CMD=file +case $deplibs_check_method in +file_magic*) + if test "$file_magic_cmd" = '$MAGIC_CMD'; then + _LT_PATH_MAGIC + fi + ;; +esac + +# Use C for the default configuration in the libtool script +LT_SUPPORTED_TAG([CC]) +_LT_LANG_C_CONFIG +_LT_LANG_DEFAULT_CONFIG +_LT_CONFIG_COMMANDS +])# _LT_SETUP + + +# _LT_PREPARE_SED_QUOTE_VARS +# -------------------------- +# Define a few sed substitution that help us do robust quoting. +m4_defun([_LT_PREPARE_SED_QUOTE_VARS], +[# Backslashify metacharacters that are still active within +# double-quoted strings. +sed_quote_subst='s/\([["`$\\]]\)/\\\1/g' + +# Same as above, but do not quote variable references. +double_quote_subst='s/\([["`\\]]\)/\\\1/g' + +# Sed substitution to delay expansion of an escaped shell variable in a +# double_quote_subst'ed string. +delay_variable_subst='s/\\\\\\\\\\\$/\\\\\\$/g' + +# Sed substitution to delay expansion of an escaped single quote. +delay_single_quote_subst='s/'\''/'\'\\\\\\\'\''/g' + +# Sed substitution to avoid accidental globbing in evaled expressions +no_glob_subst='s/\*/\\\*/g' +]) + +# _LT_PROG_LTMAIN +# --------------- +# Note that this code is called both from `configure', and `config.status' +# now that we use AC_CONFIG_COMMANDS to generate libtool. Notably, +# `config.status' has no value for ac_aux_dir unless we are using Automake, +# so we pass a copy along to make sure it has a sensible value anyway. +m4_defun([_LT_PROG_LTMAIN], +[m4_ifdef([AC_REQUIRE_AUX_FILE], [AC_REQUIRE_AUX_FILE([ltmain.sh])])dnl +_LT_CONFIG_LIBTOOL_INIT([ac_aux_dir='$ac_aux_dir']) +ltmain="$ac_aux_dir/ltmain.sh" +])# _LT_PROG_LTMAIN + + +## ------------------------------------- ## +## Accumulate code for creating libtool. ## +## ------------------------------------- ## + +# So that we can recreate a full libtool script including additional +# tags, we accumulate the chunks of code to send to AC_CONFIG_COMMANDS +# in macros and then make a single call at the end using the `libtool' +# label. + + +# _LT_CONFIG_LIBTOOL_INIT([INIT-COMMANDS]) +# ---------------------------------------- +# Register INIT-COMMANDS to be passed to AC_CONFIG_COMMANDS later. +m4_define([_LT_CONFIG_LIBTOOL_INIT], +[m4_ifval([$1], + [m4_append([_LT_OUTPUT_LIBTOOL_INIT], + [$1 +])])]) + +# Initialize. +m4_define([_LT_OUTPUT_LIBTOOL_INIT]) + + +# _LT_CONFIG_LIBTOOL([COMMANDS]) +# ------------------------------ +# Register COMMANDS to be passed to AC_CONFIG_COMMANDS later. +m4_define([_LT_CONFIG_LIBTOOL], +[m4_ifval([$1], + [m4_append([_LT_OUTPUT_LIBTOOL_COMMANDS], + [$1 +])])]) + +# Initialize. +m4_define([_LT_OUTPUT_LIBTOOL_COMMANDS]) + + +# _LT_CONFIG_SAVE_COMMANDS([COMMANDS], [INIT_COMMANDS]) +# ----------------------------------------------------- +m4_defun([_LT_CONFIG_SAVE_COMMANDS], +[_LT_CONFIG_LIBTOOL([$1]) +_LT_CONFIG_LIBTOOL_INIT([$2]) +]) + + +# _LT_FORMAT_COMMENT([COMMENT]) +# ----------------------------- +# Add leading comment marks to the start of each line, and a trailing +# full-stop to the whole comment if one is not present already. +m4_define([_LT_FORMAT_COMMENT], +[m4_ifval([$1], [ +m4_bpatsubst([m4_bpatsubst([$1], [^ *], [# ])], + [['`$\]], [\\\&])]m4_bmatch([$1], [[!?.]$], [], [.]) +)]) + + + +## ------------------------ ## +## FIXME: Eliminate VARNAME ## +## ------------------------ ## + + +# _LT_DECL([CONFIGNAME], VARNAME, VALUE, [DESCRIPTION], [IS-TAGGED?]) +# ------------------------------------------------------------------- +# CONFIGNAME is the name given to the value in the libtool script. +# VARNAME is the (base) name used in the configure script. +# VALUE may be 0, 1 or 2 for a computed quote escaped value based on +# VARNAME. Any other value will be used directly. +m4_define([_LT_DECL], +[lt_if_append_uniq([lt_decl_varnames], [$2], [, ], + [lt_dict_add_subkey([lt_decl_dict], [$2], [libtool_name], + [m4_ifval([$1], [$1], [$2])]) + lt_dict_add_subkey([lt_decl_dict], [$2], [value], [$3]) + m4_ifval([$4], + [lt_dict_add_subkey([lt_decl_dict], [$2], [description], [$4])]) + lt_dict_add_subkey([lt_decl_dict], [$2], + [tagged?], [m4_ifval([$5], [yes], [no])])]) +]) + + +# _LT_TAGDECL([CONFIGNAME], VARNAME, VALUE, [DESCRIPTION]) +# -------------------------------------------------------- +m4_define([_LT_TAGDECL], [_LT_DECL([$1], [$2], [$3], [$4], [yes])]) + + +# lt_decl_tag_varnames([SEPARATOR], [VARNAME1...]) +# ------------------------------------------------ +m4_define([lt_decl_tag_varnames], +[_lt_decl_filter([tagged?], [yes], $@)]) + + +# _lt_decl_filter(SUBKEY, VALUE, [SEPARATOR], [VARNAME1..]) +# --------------------------------------------------------- +m4_define([_lt_decl_filter], +[m4_case([$#], + [0], [m4_fatal([$0: too few arguments: $#])], + [1], [m4_fatal([$0: too few arguments: $#: $1])], + [2], [lt_dict_filter([lt_decl_dict], [$1], [$2], [], lt_decl_varnames)], + [3], [lt_dict_filter([lt_decl_dict], [$1], [$2], [$3], lt_decl_varnames)], + [lt_dict_filter([lt_decl_dict], $@)])[]dnl +]) + + +# lt_decl_quote_varnames([SEPARATOR], [VARNAME1...]) +# -------------------------------------------------- +m4_define([lt_decl_quote_varnames], +[_lt_decl_filter([value], [1], $@)]) + + +# lt_decl_dquote_varnames([SEPARATOR], [VARNAME1...]) +# --------------------------------------------------- +m4_define([lt_decl_dquote_varnames], +[_lt_decl_filter([value], [2], $@)]) + + +# lt_decl_varnames_tagged([SEPARATOR], [VARNAME1...]) +# --------------------------------------------------- +m4_define([lt_decl_varnames_tagged], +[m4_assert([$# <= 2])dnl +_$0(m4_quote(m4_default([$1], [[, ]])), + m4_ifval([$2], [[$2]], [m4_dquote(lt_decl_tag_varnames)]), + m4_split(m4_normalize(m4_quote(_LT_TAGS)), [ ]))]) +m4_define([_lt_decl_varnames_tagged], +[m4_ifval([$3], [lt_combine([$1], [$2], [_], $3)])]) + + +# lt_decl_all_varnames([SEPARATOR], [VARNAME1...]) +# ------------------------------------------------ +m4_define([lt_decl_all_varnames], +[_$0(m4_quote(m4_default([$1], [[, ]])), + m4_if([$2], [], + m4_quote(lt_decl_varnames), + m4_quote(m4_shift($@))))[]dnl +]) +m4_define([_lt_decl_all_varnames], +[lt_join($@, lt_decl_varnames_tagged([$1], + lt_decl_tag_varnames([[, ]], m4_shift($@))))dnl +]) + + +# _LT_CONFIG_STATUS_DECLARE([VARNAME]) +# ------------------------------------ +# Quote a variable value, and forward it to `config.status' so that its +# declaration there will have the same value as in `configure'. VARNAME +# must have a single quote delimited value for this to work. +m4_define([_LT_CONFIG_STATUS_DECLARE], +[$1='`$ECHO "$][$1" | $SED "$delay_single_quote_subst"`']) + + +# _LT_CONFIG_STATUS_DECLARATIONS +# ------------------------------ +# We delimit libtool config variables with single quotes, so when +# we write them to config.status, we have to be sure to quote all +# embedded single quotes properly. In configure, this macro expands +# each variable declared with _LT_DECL (and _LT_TAGDECL) into: +# +# ='`$ECHO "$" | $SED "$delay_single_quote_subst"`' +m4_defun([_LT_CONFIG_STATUS_DECLARATIONS], +[m4_foreach([_lt_var], m4_quote(lt_decl_all_varnames), + [m4_n([_LT_CONFIG_STATUS_DECLARE(_lt_var)])])]) + + +# _LT_LIBTOOL_TAGS +# ---------------- +# Output comment and list of tags supported by the script +m4_defun([_LT_LIBTOOL_TAGS], +[_LT_FORMAT_COMMENT([The names of the tagged configurations supported by this script])dnl +available_tags="_LT_TAGS"dnl +]) + + +# _LT_LIBTOOL_DECLARE(VARNAME, [TAG]) +# ----------------------------------- +# Extract the dictionary values for VARNAME (optionally with TAG) and +# expand to a commented shell variable setting: +# +# # Some comment about what VAR is for. +# visible_name=$lt_internal_name +m4_define([_LT_LIBTOOL_DECLARE], +[_LT_FORMAT_COMMENT(m4_quote(lt_dict_fetch([lt_decl_dict], [$1], + [description])))[]dnl +m4_pushdef([_libtool_name], + m4_quote(lt_dict_fetch([lt_decl_dict], [$1], [libtool_name])))[]dnl +m4_case(m4_quote(lt_dict_fetch([lt_decl_dict], [$1], [value])), + [0], [_libtool_name=[$]$1], + [1], [_libtool_name=$lt_[]$1], + [2], [_libtool_name=$lt_[]$1], + [_libtool_name=lt_dict_fetch([lt_decl_dict], [$1], [value])])[]dnl +m4_ifval([$2], [_$2])[]m4_popdef([_libtool_name])[]dnl +]) + + +# _LT_LIBTOOL_CONFIG_VARS +# ----------------------- +# Produce commented declarations of non-tagged libtool config variables +# suitable for insertion in the LIBTOOL CONFIG section of the `libtool' +# script. Tagged libtool config variables (even for the LIBTOOL CONFIG +# section) are produced by _LT_LIBTOOL_TAG_VARS. +m4_defun([_LT_LIBTOOL_CONFIG_VARS], +[m4_foreach([_lt_var], + m4_quote(_lt_decl_filter([tagged?], [no], [], lt_decl_varnames)), + [m4_n([_LT_LIBTOOL_DECLARE(_lt_var)])])]) + + +# _LT_LIBTOOL_TAG_VARS(TAG) +# ------------------------- +m4_define([_LT_LIBTOOL_TAG_VARS], +[m4_foreach([_lt_var], m4_quote(lt_decl_tag_varnames), + [m4_n([_LT_LIBTOOL_DECLARE(_lt_var, [$1])])])]) + + +# _LT_TAGVAR(VARNAME, [TAGNAME]) +# ------------------------------ +m4_define([_LT_TAGVAR], [m4_ifval([$2], [$1_$2], [$1])]) + + +# _LT_CONFIG_COMMANDS +# ------------------- +# Send accumulated output to $CONFIG_STATUS. Thanks to the lists of +# variables for single and double quote escaping we saved from calls +# to _LT_DECL, we can put quote escaped variables declarations +# into `config.status', and then the shell code to quote escape them in +# for loops in `config.status'. Finally, any additional code accumulated +# from calls to _LT_CONFIG_LIBTOOL_INIT is expanded. +m4_defun([_LT_CONFIG_COMMANDS], +[AC_PROVIDE_IFELSE([LT_OUTPUT], + dnl If the libtool generation code has been placed in $CONFIG_LT, + dnl instead of duplicating it all over again into config.status, + dnl then we will have config.status run $CONFIG_LT later, so it + dnl needs to know what name is stored there: + [AC_CONFIG_COMMANDS([libtool], + [$SHELL $CONFIG_LT || AS_EXIT(1)], [CONFIG_LT='$CONFIG_LT'])], + dnl If the libtool generation code is destined for config.status, + dnl expand the accumulated commands and init code now: + [AC_CONFIG_COMMANDS([libtool], + [_LT_OUTPUT_LIBTOOL_COMMANDS], [_LT_OUTPUT_LIBTOOL_COMMANDS_INIT])]) +])#_LT_CONFIG_COMMANDS + + +# Initialize. +m4_define([_LT_OUTPUT_LIBTOOL_COMMANDS_INIT], +[ + +# The HP-UX ksh and POSIX shell print the target directory to stdout +# if CDPATH is set. +(unset CDPATH) >/dev/null 2>&1 && unset CDPATH + +sed_quote_subst='$sed_quote_subst' +double_quote_subst='$double_quote_subst' +delay_variable_subst='$delay_variable_subst' +_LT_CONFIG_STATUS_DECLARATIONS +LTCC='$LTCC' +LTCFLAGS='$LTCFLAGS' +compiler='$compiler_DEFAULT' + +# A function that is used when there is no print builtin or printf. +func_fallback_echo () +{ + eval 'cat <<_LTECHO_EOF +\$[]1 +_LTECHO_EOF' +} + +# Quote evaled strings. +for var in lt_decl_all_varnames([[ \ +]], lt_decl_quote_varnames); do + case \`eval \\\\\$ECHO \\\\""\\\\\$\$var"\\\\"\` in + *[[\\\\\\\`\\"\\\$]]*) + eval "lt_\$var=\\\\\\"\\\`\\\$ECHO \\"\\\$\$var\\" | \\\$SED \\"\\\$sed_quote_subst\\"\\\`\\\\\\"" + ;; + *) + eval "lt_\$var=\\\\\\"\\\$\$var\\\\\\"" + ;; + esac +done + +# Double-quote double-evaled strings. +for var in lt_decl_all_varnames([[ \ +]], lt_decl_dquote_varnames); do + case \`eval \\\\\$ECHO \\\\""\\\\\$\$var"\\\\"\` in + *[[\\\\\\\`\\"\\\$]]*) + eval "lt_\$var=\\\\\\"\\\`\\\$ECHO \\"\\\$\$var\\" | \\\$SED -e \\"\\\$double_quote_subst\\" -e \\"\\\$sed_quote_subst\\" -e \\"\\\$delay_variable_subst\\"\\\`\\\\\\"" + ;; + *) + eval "lt_\$var=\\\\\\"\\\$\$var\\\\\\"" + ;; + esac +done + +_LT_OUTPUT_LIBTOOL_INIT +]) + +# _LT_GENERATED_FILE_INIT(FILE, [COMMENT]) +# ------------------------------------ +# Generate a child script FILE with all initialization necessary to +# reuse the environment learned by the parent script, and make the +# file executable. If COMMENT is supplied, it is inserted after the +# `#!' sequence but before initialization text begins. After this +# macro, additional text can be appended to FILE to form the body of +# the child script. The macro ends with non-zero status if the +# file could not be fully written (such as if the disk is full). +m4_ifdef([AS_INIT_GENERATED], +[m4_defun([_LT_GENERATED_FILE_INIT],[AS_INIT_GENERATED($@)])], +[m4_defun([_LT_GENERATED_FILE_INIT], +[m4_require([AS_PREPARE])]dnl +[m4_pushdef([AS_MESSAGE_LOG_FD])]dnl +[lt_write_fail=0 +cat >$1 <<_ASEOF || lt_write_fail=1 +#! $SHELL +# Generated by $as_me. +$2 +SHELL=\${CONFIG_SHELL-$SHELL} +export SHELL +_ASEOF +cat >>$1 <<\_ASEOF || lt_write_fail=1 +AS_SHELL_SANITIZE +_AS_PREPARE +exec AS_MESSAGE_FD>&1 +_ASEOF +test $lt_write_fail = 0 && chmod +x $1[]dnl +m4_popdef([AS_MESSAGE_LOG_FD])])])# _LT_GENERATED_FILE_INIT + +# LT_OUTPUT +# --------- +# This macro allows early generation of the libtool script (before +# AC_OUTPUT is called), incase it is used in configure for compilation +# tests. +AC_DEFUN([LT_OUTPUT], +[: ${CONFIG_LT=./config.lt} +AC_MSG_NOTICE([creating $CONFIG_LT]) +_LT_GENERATED_FILE_INIT(["$CONFIG_LT"], +[# Run this file to recreate a libtool stub with the current configuration.]) + +cat >>"$CONFIG_LT" <<\_LTEOF +lt_cl_silent=false +exec AS_MESSAGE_LOG_FD>>config.log +{ + echo + AS_BOX([Running $as_me.]) +} >&AS_MESSAGE_LOG_FD + +lt_cl_help="\ +\`$as_me' creates a local libtool stub from the current configuration, +for use in further configure time tests before the real libtool is +generated. + +Usage: $[0] [[OPTIONS]] + + -h, --help print this help, then exit + -V, --version print version number, then exit + -q, --quiet do not print progress messages + -d, --debug don't remove temporary files + +Report bugs to ." + +lt_cl_version="\ +m4_ifset([AC_PACKAGE_NAME], [AC_PACKAGE_NAME ])config.lt[]dnl +m4_ifset([AC_PACKAGE_VERSION], [ AC_PACKAGE_VERSION]) +configured by $[0], generated by m4_PACKAGE_STRING. + +Copyright (C) 2011 Free Software Foundation, Inc. +This config.lt script is free software; the Free Software Foundation +gives unlimited permision to copy, distribute and modify it." + +while test $[#] != 0 +do + case $[1] in + --version | --v* | -V ) + echo "$lt_cl_version"; exit 0 ;; + --help | --h* | -h ) + echo "$lt_cl_help"; exit 0 ;; + --debug | --d* | -d ) + debug=: ;; + --quiet | --q* | --silent | --s* | -q ) + lt_cl_silent=: ;; + + -*) AC_MSG_ERROR([unrecognized option: $[1] +Try \`$[0] --help' for more information.]) ;; + + *) AC_MSG_ERROR([unrecognized argument: $[1] +Try \`$[0] --help' for more information.]) ;; + esac + shift +done + +if $lt_cl_silent; then + exec AS_MESSAGE_FD>/dev/null +fi +_LTEOF + +cat >>"$CONFIG_LT" <<_LTEOF +_LT_OUTPUT_LIBTOOL_COMMANDS_INIT +_LTEOF + +cat >>"$CONFIG_LT" <<\_LTEOF +AC_MSG_NOTICE([creating $ofile]) +_LT_OUTPUT_LIBTOOL_COMMANDS +AS_EXIT(0) +_LTEOF +chmod +x "$CONFIG_LT" + +# configure is writing to config.log, but config.lt does its own redirection, +# appending to config.log, which fails on DOS, as config.log is still kept +# open by configure. Here we exec the FD to /dev/null, effectively closing +# config.log, so it can be properly (re)opened and appended to by config.lt. +lt_cl_success=: +test "$silent" = yes && + lt_config_lt_args="$lt_config_lt_args --quiet" +exec AS_MESSAGE_LOG_FD>/dev/null +$SHELL "$CONFIG_LT" $lt_config_lt_args || lt_cl_success=false +exec AS_MESSAGE_LOG_FD>>config.log +$lt_cl_success || AS_EXIT(1) +])# LT_OUTPUT + + +# _LT_CONFIG(TAG) +# --------------- +# If TAG is the built-in tag, create an initial libtool script with a +# default configuration from the untagged config vars. Otherwise add code +# to config.status for appending the configuration named by TAG from the +# matching tagged config vars. +m4_defun([_LT_CONFIG], +[m4_require([_LT_FILEUTILS_DEFAULTS])dnl +_LT_CONFIG_SAVE_COMMANDS([ + m4_define([_LT_TAG], m4_if([$1], [], [C], [$1]))dnl + m4_if(_LT_TAG, [C], [ + # See if we are running on zsh, and set the options which allow our + # commands through without removal of \ escapes. + if test -n "${ZSH_VERSION+set}" ; then + setopt NO_GLOB_SUBST + fi + + cfgfile="${ofile}T" + trap "$RM \"$cfgfile\"; exit 1" 1 2 15 + $RM "$cfgfile" + + cat <<_LT_EOF >> "$cfgfile" +#! $SHELL + +# `$ECHO "$ofile" | sed 's%^.*/%%'` - Provide generalized library-building support services. +# Generated automatically by $as_me ($PACKAGE$TIMESTAMP) $VERSION +# Libtool was configured on host `(hostname || uname -n) 2>/dev/null | sed 1q`: +# NOTE: Changes made to this file will be lost: look at ltmain.sh. +# +_LT_COPYING +_LT_LIBTOOL_TAGS + +# ### BEGIN LIBTOOL CONFIG +_LT_LIBTOOL_CONFIG_VARS +_LT_LIBTOOL_TAG_VARS +# ### END LIBTOOL CONFIG + +_LT_EOF + + case $host_os in + aix3*) + cat <<\_LT_EOF >> "$cfgfile" +# AIX sometimes has problems with the GCC collect2 program. For some +# reason, if we set the COLLECT_NAMES environment variable, the problems +# vanish in a puff of smoke. +if test "X${COLLECT_NAMES+set}" != Xset; then + COLLECT_NAMES= + export COLLECT_NAMES +fi +_LT_EOF + ;; + esac + + _LT_PROG_LTMAIN + + # We use sed instead of cat because bash on DJGPP gets confused if + # if finds mixed CR/LF and LF-only lines. Since sed operates in + # text mode, it properly converts lines to CR/LF. This bash problem + # is reportedly fixed, but why not run on old versions too? + sed '$q' "$ltmain" >> "$cfgfile" \ + || (rm -f "$cfgfile"; exit 1) + + _LT_PROG_REPLACE_SHELLFNS + + mv -f "$cfgfile" "$ofile" || + (rm -f "$ofile" && cp "$cfgfile" "$ofile" && rm -f "$cfgfile") + chmod +x "$ofile" +], +[cat <<_LT_EOF >> "$ofile" + +dnl Unfortunately we have to use $1 here, since _LT_TAG is not expanded +dnl in a comment (ie after a #). +# ### BEGIN LIBTOOL TAG CONFIG: $1 +_LT_LIBTOOL_TAG_VARS(_LT_TAG) +# ### END LIBTOOL TAG CONFIG: $1 +_LT_EOF +])dnl /m4_if +], +[m4_if([$1], [], [ + PACKAGE='$PACKAGE' + VERSION='$VERSION' + TIMESTAMP='$TIMESTAMP' + RM='$RM' + ofile='$ofile'], []) +])dnl /_LT_CONFIG_SAVE_COMMANDS +])# _LT_CONFIG + + +# LT_SUPPORTED_TAG(TAG) +# --------------------- +# Trace this macro to discover what tags are supported by the libtool +# --tag option, using: +# autoconf --trace 'LT_SUPPORTED_TAG:$1' +AC_DEFUN([LT_SUPPORTED_TAG], []) + + +# C support is built-in for now +m4_define([_LT_LANG_C_enabled], []) +m4_define([_LT_TAGS], []) + + +# LT_LANG(LANG) +# ------------- +# Enable libtool support for the given language if not already enabled. +AC_DEFUN([LT_LANG], +[AC_BEFORE([$0], [LT_OUTPUT])dnl +m4_case([$1], + [C], [_LT_LANG(C)], + [C++], [_LT_LANG(CXX)], + [Go], [_LT_LANG(GO)], + [Java], [_LT_LANG(GCJ)], + [Fortran 77], [_LT_LANG(F77)], + [Fortran], [_LT_LANG(FC)], + [Windows Resource], [_LT_LANG(RC)], + [m4_ifdef([_LT_LANG_]$1[_CONFIG], + [_LT_LANG($1)], + [m4_fatal([$0: unsupported language: "$1"])])])dnl +])# LT_LANG + + +# _LT_LANG(LANGNAME) +# ------------------ +m4_defun([_LT_LANG], +[m4_ifdef([_LT_LANG_]$1[_enabled], [], + [LT_SUPPORTED_TAG([$1])dnl + m4_append([_LT_TAGS], [$1 ])dnl + m4_define([_LT_LANG_]$1[_enabled], [])dnl + _LT_LANG_$1_CONFIG($1)])dnl +])# _LT_LANG + + +m4_ifndef([AC_PROG_GO], [ +############################################################ +# NOTE: This macro has been submitted for inclusion into # +# GNU Autoconf as AC_PROG_GO. When it is available in # +# a released version of Autoconf we should remove this # +# macro and use it instead. # +############################################################ +m4_defun([AC_PROG_GO], +[AC_LANG_PUSH(Go)dnl +AC_ARG_VAR([GOC], [Go compiler command])dnl +AC_ARG_VAR([GOFLAGS], [Go compiler flags])dnl +_AC_ARG_VAR_LDFLAGS()dnl +AC_CHECK_TOOL(GOC, gccgo) +if test -z "$GOC"; then + if test -n "$ac_tool_prefix"; then + AC_CHECK_PROG(GOC, [${ac_tool_prefix}gccgo], [${ac_tool_prefix}gccgo]) + fi +fi +if test -z "$GOC"; then + AC_CHECK_PROG(GOC, gccgo, gccgo, false) +fi +])#m4_defun +])#m4_ifndef + + +# _LT_LANG_DEFAULT_CONFIG +# ----------------------- +m4_defun([_LT_LANG_DEFAULT_CONFIG], +[AC_PROVIDE_IFELSE([AC_PROG_CXX], + [LT_LANG(CXX)], + [m4_define([AC_PROG_CXX], defn([AC_PROG_CXX])[LT_LANG(CXX)])]) + +AC_PROVIDE_IFELSE([AC_PROG_F77], + [LT_LANG(F77)], + [m4_define([AC_PROG_F77], defn([AC_PROG_F77])[LT_LANG(F77)])]) + +AC_PROVIDE_IFELSE([AC_PROG_FC], + [LT_LANG(FC)], + [m4_define([AC_PROG_FC], defn([AC_PROG_FC])[LT_LANG(FC)])]) + +dnl The call to [A][M_PROG_GCJ] is quoted like that to stop aclocal +dnl pulling things in needlessly. +AC_PROVIDE_IFELSE([AC_PROG_GCJ], + [LT_LANG(GCJ)], + [AC_PROVIDE_IFELSE([A][M_PROG_GCJ], + [LT_LANG(GCJ)], + [AC_PROVIDE_IFELSE([LT_PROG_GCJ], + [LT_LANG(GCJ)], + [m4_ifdef([AC_PROG_GCJ], + [m4_define([AC_PROG_GCJ], defn([AC_PROG_GCJ])[LT_LANG(GCJ)])]) + m4_ifdef([A][M_PROG_GCJ], + [m4_define([A][M_PROG_GCJ], defn([A][M_PROG_GCJ])[LT_LANG(GCJ)])]) + m4_ifdef([LT_PROG_GCJ], + [m4_define([LT_PROG_GCJ], defn([LT_PROG_GCJ])[LT_LANG(GCJ)])])])])]) + +AC_PROVIDE_IFELSE([AC_PROG_GO], + [LT_LANG(GO)], + [m4_define([AC_PROG_GO], defn([AC_PROG_GO])[LT_LANG(GO)])]) + +AC_PROVIDE_IFELSE([LT_PROG_RC], + [LT_LANG(RC)], + [m4_define([LT_PROG_RC], defn([LT_PROG_RC])[LT_LANG(RC)])]) +])# _LT_LANG_DEFAULT_CONFIG + +# Obsolete macros: +AU_DEFUN([AC_LIBTOOL_CXX], [LT_LANG(C++)]) +AU_DEFUN([AC_LIBTOOL_F77], [LT_LANG(Fortran 77)]) +AU_DEFUN([AC_LIBTOOL_FC], [LT_LANG(Fortran)]) +AU_DEFUN([AC_LIBTOOL_GCJ], [LT_LANG(Java)]) +AU_DEFUN([AC_LIBTOOL_RC], [LT_LANG(Windows Resource)]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_CXX], []) +dnl AC_DEFUN([AC_LIBTOOL_F77], []) +dnl AC_DEFUN([AC_LIBTOOL_FC], []) +dnl AC_DEFUN([AC_LIBTOOL_GCJ], []) +dnl AC_DEFUN([AC_LIBTOOL_RC], []) + + +# _LT_TAG_COMPILER +# ---------------- +m4_defun([_LT_TAG_COMPILER], +[AC_REQUIRE([AC_PROG_CC])dnl + +_LT_DECL([LTCC], [CC], [1], [A C compiler])dnl +_LT_DECL([LTCFLAGS], [CFLAGS], [1], [LTCC compiler flags])dnl +_LT_TAGDECL([CC], [compiler], [1], [A language specific compiler])dnl +_LT_TAGDECL([with_gcc], [GCC], [0], [Is the compiler the GNU compiler?])dnl + +# If no C compiler was specified, use CC. +LTCC=${LTCC-"$CC"} + +# If no C compiler flags were specified, use CFLAGS. +LTCFLAGS=${LTCFLAGS-"$CFLAGS"} + +# Allow CC to be a program name with arguments. +compiler=$CC +])# _LT_TAG_COMPILER + + +# _LT_COMPILER_BOILERPLATE +# ------------------------ +# Check for compiler boilerplate output or warnings with +# the simple compiler test code. +m4_defun([_LT_COMPILER_BOILERPLATE], +[m4_require([_LT_DECL_SED])dnl +ac_outfile=conftest.$ac_objext +echo "$lt_simple_compile_test_code" >conftest.$ac_ext +eval "$ac_compile" 2>&1 >/dev/null | $SED '/^$/d; /^ *+/d' >conftest.err +_lt_compiler_boilerplate=`cat conftest.err` +$RM conftest* +])# _LT_COMPILER_BOILERPLATE + + +# _LT_LINKER_BOILERPLATE +# ---------------------- +# Check for linker boilerplate output or warnings with +# the simple link test code. +m4_defun([_LT_LINKER_BOILERPLATE], +[m4_require([_LT_DECL_SED])dnl +ac_outfile=conftest.$ac_objext +echo "$lt_simple_link_test_code" >conftest.$ac_ext +eval "$ac_link" 2>&1 >/dev/null | $SED '/^$/d; /^ *+/d' >conftest.err +_lt_linker_boilerplate=`cat conftest.err` +$RM -r conftest* +])# _LT_LINKER_BOILERPLATE + +# _LT_REQUIRED_DARWIN_CHECKS +# ------------------------- +m4_defun_once([_LT_REQUIRED_DARWIN_CHECKS],[ + case $host_os in + rhapsody* | darwin*) + AC_CHECK_TOOL([DSYMUTIL], [dsymutil], [:]) + AC_CHECK_TOOL([NMEDIT], [nmedit], [:]) + AC_CHECK_TOOL([LIPO], [lipo], [:]) + AC_CHECK_TOOL([OTOOL], [otool], [:]) + AC_CHECK_TOOL([OTOOL64], [otool64], [:]) + _LT_DECL([], [DSYMUTIL], [1], + [Tool to manipulate archived DWARF debug symbol files on Mac OS X]) + _LT_DECL([], [NMEDIT], [1], + [Tool to change global to local symbols on Mac OS X]) + _LT_DECL([], [LIPO], [1], + [Tool to manipulate fat objects and archives on Mac OS X]) + _LT_DECL([], [OTOOL], [1], + [ldd/readelf like tool for Mach-O binaries on Mac OS X]) + _LT_DECL([], [OTOOL64], [1], + [ldd/readelf like tool for 64 bit Mach-O binaries on Mac OS X 10.4]) + + AC_CACHE_CHECK([for -single_module linker flag],[lt_cv_apple_cc_single_mod], + [lt_cv_apple_cc_single_mod=no + if test -z "${LT_MULTI_MODULE}"; then + # By default we will add the -single_module flag. You can override + # by either setting the environment variable LT_MULTI_MODULE + # non-empty at configure time, or by adding -multi_module to the + # link flags. + rm -rf libconftest.dylib* + echo "int foo(void){return 1;}" > conftest.c + echo "$LTCC $LTCFLAGS $LDFLAGS -o libconftest.dylib \ +-dynamiclib -Wl,-single_module conftest.c" >&AS_MESSAGE_LOG_FD + $LTCC $LTCFLAGS $LDFLAGS -o libconftest.dylib \ + -dynamiclib -Wl,-single_module conftest.c 2>conftest.err + _lt_result=$? + # If there is a non-empty error log, and "single_module" + # appears in it, assume the flag caused a linker warning + if test -s conftest.err && $GREP single_module conftest.err; then + cat conftest.err >&AS_MESSAGE_LOG_FD + # Otherwise, if the output was created with a 0 exit code from + # the compiler, it worked. + elif test -f libconftest.dylib && test $_lt_result -eq 0; then + lt_cv_apple_cc_single_mod=yes + else + cat conftest.err >&AS_MESSAGE_LOG_FD + fi + rm -rf libconftest.dylib* + rm -f conftest.* + fi]) + + AC_CACHE_CHECK([for -exported_symbols_list linker flag], + [lt_cv_ld_exported_symbols_list], + [lt_cv_ld_exported_symbols_list=no + save_LDFLAGS=$LDFLAGS + echo "_main" > conftest.sym + LDFLAGS="$LDFLAGS -Wl,-exported_symbols_list,conftest.sym" + AC_LINK_IFELSE([AC_LANG_PROGRAM([],[])], + [lt_cv_ld_exported_symbols_list=yes], + [lt_cv_ld_exported_symbols_list=no]) + LDFLAGS="$save_LDFLAGS" + ]) + + AC_CACHE_CHECK([for -force_load linker flag],[lt_cv_ld_force_load], + [lt_cv_ld_force_load=no + cat > conftest.c << _LT_EOF +int forced_loaded() { return 2;} +_LT_EOF + echo "$LTCC $LTCFLAGS -c -o conftest.o conftest.c" >&AS_MESSAGE_LOG_FD + $LTCC $LTCFLAGS -c -o conftest.o conftest.c 2>&AS_MESSAGE_LOG_FD + echo "$AR cru libconftest.a conftest.o" >&AS_MESSAGE_LOG_FD + $AR cru libconftest.a conftest.o 2>&AS_MESSAGE_LOG_FD + echo "$RANLIB libconftest.a" >&AS_MESSAGE_LOG_FD + $RANLIB libconftest.a 2>&AS_MESSAGE_LOG_FD + cat > conftest.c << _LT_EOF +int main() { return 0;} +_LT_EOF + echo "$LTCC $LTCFLAGS $LDFLAGS -o conftest conftest.c -Wl,-force_load,./libconftest.a" >&AS_MESSAGE_LOG_FD + $LTCC $LTCFLAGS $LDFLAGS -o conftest conftest.c -Wl,-force_load,./libconftest.a 2>conftest.err + _lt_result=$? + if test -s conftest.err && $GREP force_load conftest.err; then + cat conftest.err >&AS_MESSAGE_LOG_FD + elif test -f conftest && test $_lt_result -eq 0 && $GREP forced_load conftest >/dev/null 2>&1 ; then + lt_cv_ld_force_load=yes + else + cat conftest.err >&AS_MESSAGE_LOG_FD + fi + rm -f conftest.err libconftest.a conftest conftest.c + rm -rf conftest.dSYM + ]) + case $host_os in + rhapsody* | darwin1.[[012]]) + _lt_dar_allow_undefined='${wl}-undefined ${wl}suppress' ;; + darwin1.*) + _lt_dar_allow_undefined='${wl}-flat_namespace ${wl}-undefined ${wl}suppress' ;; + darwin*) # darwin 5.x on + # if running on 10.5 or later, the deployment target defaults + # to the OS version, if on x86, and 10.4, the deployment + # target defaults to 10.4. Don't you love it? + case ${MACOSX_DEPLOYMENT_TARGET-10.0},$host in + 10.0,*86*-darwin8*|10.0,*-darwin[[91]]*) + _lt_dar_allow_undefined='${wl}-undefined ${wl}dynamic_lookup' ;; + 10.[[012]]*) + _lt_dar_allow_undefined='${wl}-flat_namespace ${wl}-undefined ${wl}suppress' ;; + 10.*) + _lt_dar_allow_undefined='${wl}-undefined ${wl}dynamic_lookup' ;; + esac + ;; + esac + if test "$lt_cv_apple_cc_single_mod" = "yes"; then + _lt_dar_single_mod='$single_module' + fi + if test "$lt_cv_ld_exported_symbols_list" = "yes"; then + _lt_dar_export_syms=' ${wl}-exported_symbols_list,$output_objdir/${libname}-symbols.expsym' + else + _lt_dar_export_syms='~$NMEDIT -s $output_objdir/${libname}-symbols.expsym ${lib}' + fi + if test "$DSYMUTIL" != ":" && test "$lt_cv_ld_force_load" = "no"; then + _lt_dsymutil='~$DSYMUTIL $lib || :' + else + _lt_dsymutil= + fi + ;; + esac +]) + + +# _LT_DARWIN_LINKER_FEATURES([TAG]) +# --------------------------------- +# Checks for linker and compiler features on darwin +m4_defun([_LT_DARWIN_LINKER_FEATURES], +[ + m4_require([_LT_REQUIRED_DARWIN_CHECKS]) + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + _LT_TAGVAR(hardcode_direct, $1)=no + _LT_TAGVAR(hardcode_automatic, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=unsupported + if test "$lt_cv_ld_force_load" = "yes"; then + _LT_TAGVAR(whole_archive_flag_spec, $1)='`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience ${wl}-force_load,$conv\"; done; func_echo_all \"$new_convenience\"`' + m4_case([$1], [F77], [_LT_TAGVAR(compiler_needs_object, $1)=yes], + [FC], [_LT_TAGVAR(compiler_needs_object, $1)=yes]) + else + _LT_TAGVAR(whole_archive_flag_spec, $1)='' + fi + _LT_TAGVAR(link_all_deplibs, $1)=yes + _LT_TAGVAR(allow_undefined_flag, $1)="$_lt_dar_allow_undefined" + case $cc_basename in + ifort*) _lt_dar_can_shared=yes ;; + *) _lt_dar_can_shared=$GCC ;; + esac + if test "$_lt_dar_can_shared" = "yes"; then + output_verbose_link_cmd=func_echo_all + _LT_TAGVAR(archive_cmds, $1)="\$CC -dynamiclib \$allow_undefined_flag -o \$lib \$libobjs \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring $_lt_dar_single_mod${_lt_dsymutil}" + _LT_TAGVAR(module_cmds, $1)="\$CC \$allow_undefined_flag -o \$lib -bundle \$libobjs \$deplibs \$compiler_flags${_lt_dsymutil}" + _LT_TAGVAR(archive_expsym_cmds, $1)="sed 's,^,_,' < \$export_symbols > \$output_objdir/\${libname}-symbols.expsym~\$CC -dynamiclib \$allow_undefined_flag -o \$lib \$libobjs \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring ${_lt_dar_single_mod}${_lt_dar_export_syms}${_lt_dsymutil}" + _LT_TAGVAR(module_expsym_cmds, $1)="sed -e 's,^,_,' < \$export_symbols > \$output_objdir/\${libname}-symbols.expsym~\$CC \$allow_undefined_flag -o \$lib -bundle \$libobjs \$deplibs \$compiler_flags${_lt_dar_export_syms}${_lt_dsymutil}" + m4_if([$1], [CXX], +[ if test "$lt_cv_apple_cc_single_mod" != "yes"; then + _LT_TAGVAR(archive_cmds, $1)="\$CC -r -keep_private_externs -nostdlib -o \${lib}-master.o \$libobjs~\$CC -dynamiclib \$allow_undefined_flag -o \$lib \${lib}-master.o \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring${_lt_dsymutil}" + _LT_TAGVAR(archive_expsym_cmds, $1)="sed 's,^,_,' < \$export_symbols > \$output_objdir/\${libname}-symbols.expsym~\$CC -r -keep_private_externs -nostdlib -o \${lib}-master.o \$libobjs~\$CC -dynamiclib \$allow_undefined_flag -o \$lib \${lib}-master.o \$deplibs \$compiler_flags -install_name \$rpath/\$soname \$verstring${_lt_dar_export_syms}${_lt_dsymutil}" + fi +],[]) + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi +]) + +# _LT_SYS_MODULE_PATH_AIX([TAGNAME]) +# ---------------------------------- +# Links a minimal program and checks the executable +# for the system default hardcoded library path. In most cases, +# this is /usr/lib:/lib, but when the MPI compilers are used +# the location of the communication and MPI libs are included too. +# If we don't find anything, use the default library path according +# to the aix ld manual. +# Store the results from the different compilers for each TAGNAME. +# Allow to override them for all tags through lt_cv_aix_libpath. +m4_defun([_LT_SYS_MODULE_PATH_AIX], +[m4_require([_LT_DECL_SED])dnl +if test "${lt_cv_aix_libpath+set}" = set; then + aix_libpath=$lt_cv_aix_libpath +else + AC_CACHE_VAL([_LT_TAGVAR([lt_cv_aix_libpath_], [$1])], + [AC_LINK_IFELSE([AC_LANG_PROGRAM],[ + lt_aix_libpath_sed='[ + /Import File Strings/,/^$/ { + /^0/ { + s/^0 *\([^ ]*\) *$/\1/ + p + } + }]' + _LT_TAGVAR([lt_cv_aix_libpath_], [$1])=`dump -H conftest$ac_exeext 2>/dev/null | $SED -n -e "$lt_aix_libpath_sed"` + # Check for a 64-bit object if we didn't find anything. + if test -z "$_LT_TAGVAR([lt_cv_aix_libpath_], [$1])"; then + _LT_TAGVAR([lt_cv_aix_libpath_], [$1])=`dump -HX64 conftest$ac_exeext 2>/dev/null | $SED -n -e "$lt_aix_libpath_sed"` + fi],[]) + if test -z "$_LT_TAGVAR([lt_cv_aix_libpath_], [$1])"; then + _LT_TAGVAR([lt_cv_aix_libpath_], [$1])="/usr/lib:/lib" + fi + ]) + aix_libpath=$_LT_TAGVAR([lt_cv_aix_libpath_], [$1]) +fi +])# _LT_SYS_MODULE_PATH_AIX + + +# _LT_SHELL_INIT(ARG) +# ------------------- +m4_define([_LT_SHELL_INIT], +[m4_divert_text([M4SH-INIT], [$1 +])])# _LT_SHELL_INIT + + + +# _LT_PROG_ECHO_BACKSLASH +# ----------------------- +# Find how we can fake an echo command that does not interpret backslash. +# In particular, with Autoconf 2.60 or later we add some code to the start +# of the generated configure script which will find a shell with a builtin +# printf (which we can use as an echo command). +m4_defun([_LT_PROG_ECHO_BACKSLASH], +[ECHO='\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\' +ECHO=$ECHO$ECHO$ECHO$ECHO$ECHO +ECHO=$ECHO$ECHO$ECHO$ECHO$ECHO$ECHO + +AC_MSG_CHECKING([how to print strings]) +# Test print first, because it will be a builtin if present. +if test "X`( print -r -- -n ) 2>/dev/null`" = X-n && \ + test "X`print -r -- $ECHO 2>/dev/null`" = "X$ECHO"; then + ECHO='print -r --' +elif test "X`printf %s $ECHO 2>/dev/null`" = "X$ECHO"; then + ECHO='printf %s\n' +else + # Use this function as a fallback that always works. + func_fallback_echo () + { + eval 'cat <<_LTECHO_EOF +$[]1 +_LTECHO_EOF' + } + ECHO='func_fallback_echo' +fi + +# func_echo_all arg... +# Invoke $ECHO with all args, space-separated. +func_echo_all () +{ + $ECHO "$*" +} + +case "$ECHO" in + printf*) AC_MSG_RESULT([printf]) ;; + print*) AC_MSG_RESULT([print -r]) ;; + *) AC_MSG_RESULT([cat]) ;; +esac + +m4_ifdef([_AS_DETECT_SUGGESTED], +[_AS_DETECT_SUGGESTED([ + test -n "${ZSH_VERSION+set}${BASH_VERSION+set}" || ( + ECHO='\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\\' + ECHO=$ECHO$ECHO$ECHO$ECHO$ECHO + ECHO=$ECHO$ECHO$ECHO$ECHO$ECHO$ECHO + PATH=/empty FPATH=/empty; export PATH FPATH + test "X`printf %s $ECHO`" = "X$ECHO" \ + || test "X`print -r -- $ECHO`" = "X$ECHO" )])]) + +_LT_DECL([], [SHELL], [1], [Shell to use when invoking shell scripts]) +_LT_DECL([], [ECHO], [1], [An echo program that protects backslashes]) +])# _LT_PROG_ECHO_BACKSLASH + + +# _LT_WITH_SYSROOT +# ---------------- +AC_DEFUN([_LT_WITH_SYSROOT], +[AC_MSG_CHECKING([for sysroot]) +AC_ARG_WITH([sysroot], +[ --with-sysroot[=DIR] Search for dependent libraries within DIR + (or the compiler's sysroot if not specified).], +[], [with_sysroot=no]) + +dnl lt_sysroot will always be passed unquoted. We quote it here +dnl in case the user passed a directory name. +lt_sysroot= +case ${with_sysroot} in #( + yes) + if test "$GCC" = yes; then + lt_sysroot=`$CC --print-sysroot 2>/dev/null` + fi + ;; #( + /*) + lt_sysroot=`echo "$with_sysroot" | sed -e "$sed_quote_subst"` + ;; #( + no|'') + ;; #( + *) + AC_MSG_RESULT([${with_sysroot}]) + AC_MSG_ERROR([The sysroot must be an absolute path.]) + ;; +esac + + AC_MSG_RESULT([${lt_sysroot:-no}]) +_LT_DECL([], [lt_sysroot], [0], [The root where to search for ]dnl +[dependent libraries, and in which our libraries should be installed.])]) + +# _LT_ENABLE_LOCK +# --------------- +m4_defun([_LT_ENABLE_LOCK], +[AC_ARG_ENABLE([libtool-lock], + [AS_HELP_STRING([--disable-libtool-lock], + [avoid locking (might break parallel builds)])]) +test "x$enable_libtool_lock" != xno && enable_libtool_lock=yes + +# Some flags need to be propagated to the compiler or linker for good +# libtool support. +case $host in +ia64-*-hpux*) + # Find out which ABI we are using. + echo 'int i;' > conftest.$ac_ext + if AC_TRY_EVAL(ac_compile); then + case `/usr/bin/file conftest.$ac_objext` in + *ELF-32*) + HPUX_IA64_MODE="32" + ;; + *ELF-64*) + HPUX_IA64_MODE="64" + ;; + esac + fi + rm -rf conftest* + ;; +*-*-irix6*) + # Find out which ABI we are using. + echo '[#]line '$LINENO' "configure"' > conftest.$ac_ext + if AC_TRY_EVAL(ac_compile); then + if test "$lt_cv_prog_gnu_ld" = yes; then + case `/usr/bin/file conftest.$ac_objext` in + *32-bit*) + LD="${LD-ld} -melf32bsmip" + ;; + *N32*) + LD="${LD-ld} -melf32bmipn32" + ;; + *64-bit*) + LD="${LD-ld} -melf64bmip" + ;; + esac + else + case `/usr/bin/file conftest.$ac_objext` in + *32-bit*) + LD="${LD-ld} -32" + ;; + *N32*) + LD="${LD-ld} -n32" + ;; + *64-bit*) + LD="${LD-ld} -64" + ;; + esac + fi + fi + rm -rf conftest* + ;; + +x86_64-*kfreebsd*-gnu|x86_64-*linux*|ppc*-*linux*|powerpc*-*linux*| \ +s390*-*linux*|s390*-*tpf*|sparc*-*linux*) + # Find out which ABI we are using. + echo 'int i;' > conftest.$ac_ext + if AC_TRY_EVAL(ac_compile); then + case `/usr/bin/file conftest.o` in + *32-bit*) + case $host in + x86_64-*kfreebsd*-gnu) + LD="${LD-ld} -m elf_i386_fbsd" + ;; + x86_64-*linux*) + LD="${LD-ld} -m elf_i386" + ;; + ppc64-*linux*|powerpc64-*linux*) + LD="${LD-ld} -m elf32ppclinux" + ;; + s390x-*linux*) + LD="${LD-ld} -m elf_s390" + ;; + sparc64-*linux*) + LD="${LD-ld} -m elf32_sparc" + ;; + esac + ;; + *64-bit*) + case $host in + x86_64-*kfreebsd*-gnu) + LD="${LD-ld} -m elf_x86_64_fbsd" + ;; + x86_64-*linux*) + LD="${LD-ld} -m elf_x86_64" + ;; + ppc*-*linux*|powerpc*-*linux*) + LD="${LD-ld} -m elf64ppc" + ;; + s390*-*linux*|s390*-*tpf*) + LD="${LD-ld} -m elf64_s390" + ;; + sparc*-*linux*) + LD="${LD-ld} -m elf64_sparc" + ;; + esac + ;; + esac + fi + rm -rf conftest* + ;; + +*-*-sco3.2v5*) + # On SCO OpenServer 5, we need -belf to get full-featured binaries. + SAVE_CFLAGS="$CFLAGS" + CFLAGS="$CFLAGS -belf" + AC_CACHE_CHECK([whether the C compiler needs -belf], lt_cv_cc_needs_belf, + [AC_LANG_PUSH(C) + AC_LINK_IFELSE([AC_LANG_PROGRAM([[]],[[]])],[lt_cv_cc_needs_belf=yes],[lt_cv_cc_needs_belf=no]) + AC_LANG_POP]) + if test x"$lt_cv_cc_needs_belf" != x"yes"; then + # this is probably gcc 2.8.0, egcs 1.0 or newer; no need for -belf + CFLAGS="$SAVE_CFLAGS" + fi + ;; +*-*solaris*) + # Find out which ABI we are using. + echo 'int i;' > conftest.$ac_ext + if AC_TRY_EVAL(ac_compile); then + case `/usr/bin/file conftest.o` in + *64-bit*) + case $lt_cv_prog_gnu_ld in + yes*) + case $host in + i?86-*-solaris*) + LD="${LD-ld} -m elf_x86_64" + ;; + sparc*-*-solaris*) + LD="${LD-ld} -m elf64_sparc" + ;; + esac + # GNU ld 2.21 introduced _sol2 emulations. Use them if available. + if ${LD-ld} -V | grep _sol2 >/dev/null 2>&1; then + LD="${LD-ld}_sol2" + fi + ;; + *) + if ${LD-ld} -64 -r -o conftest2.o conftest.o >/dev/null 2>&1; then + LD="${LD-ld} -64" + fi + ;; + esac + ;; + esac + fi + rm -rf conftest* + ;; +esac + +need_locks="$enable_libtool_lock" +])# _LT_ENABLE_LOCK + + +# _LT_PROG_AR +# ----------- +m4_defun([_LT_PROG_AR], +[AC_CHECK_TOOLS(AR, [ar], false) +: ${AR=ar} +: ${AR_FLAGS=cru} +_LT_DECL([], [AR], [1], [The archiver]) +_LT_DECL([], [AR_FLAGS], [1], [Flags to create an archive]) + +AC_CACHE_CHECK([for archiver @FILE support], [lt_cv_ar_at_file], + [lt_cv_ar_at_file=no + AC_COMPILE_IFELSE([AC_LANG_PROGRAM], + [echo conftest.$ac_objext > conftest.lst + lt_ar_try='$AR $AR_FLAGS libconftest.a @conftest.lst >&AS_MESSAGE_LOG_FD' + AC_TRY_EVAL([lt_ar_try]) + if test "$ac_status" -eq 0; then + # Ensure the archiver fails upon bogus file names. + rm -f conftest.$ac_objext libconftest.a + AC_TRY_EVAL([lt_ar_try]) + if test "$ac_status" -ne 0; then + lt_cv_ar_at_file=@ + fi + fi + rm -f conftest.* libconftest.a + ]) + ]) + +if test "x$lt_cv_ar_at_file" = xno; then + archiver_list_spec= +else + archiver_list_spec=$lt_cv_ar_at_file +fi +_LT_DECL([], [archiver_list_spec], [1], + [How to feed a file listing to the archiver]) +])# _LT_PROG_AR + + +# _LT_CMD_OLD_ARCHIVE +# ------------------- +m4_defun([_LT_CMD_OLD_ARCHIVE], +[_LT_PROG_AR + +AC_CHECK_TOOL(STRIP, strip, :) +test -z "$STRIP" && STRIP=: +_LT_DECL([], [STRIP], [1], [A symbol stripping program]) + +AC_CHECK_TOOL(RANLIB, ranlib, :) +test -z "$RANLIB" && RANLIB=: +_LT_DECL([], [RANLIB], [1], + [Commands used to install an old-style archive]) + +# Determine commands to create old-style static archives. +old_archive_cmds='$AR $AR_FLAGS $oldlib$oldobjs' +old_postinstall_cmds='chmod 644 $oldlib' +old_postuninstall_cmds= + +if test -n "$RANLIB"; then + case $host_os in + openbsd*) + old_postinstall_cmds="$old_postinstall_cmds~\$RANLIB -t \$tool_oldlib" + ;; + *) + old_postinstall_cmds="$old_postinstall_cmds~\$RANLIB \$tool_oldlib" + ;; + esac + old_archive_cmds="$old_archive_cmds~\$RANLIB \$tool_oldlib" +fi + +case $host_os in + darwin*) + lock_old_archive_extraction=yes ;; + *) + lock_old_archive_extraction=no ;; +esac +_LT_DECL([], [old_postinstall_cmds], [2]) +_LT_DECL([], [old_postuninstall_cmds], [2]) +_LT_TAGDECL([], [old_archive_cmds], [2], + [Commands used to build an old-style archive]) +_LT_DECL([], [lock_old_archive_extraction], [0], + [Whether to use a lock for old archive extraction]) +])# _LT_CMD_OLD_ARCHIVE + + +# _LT_COMPILER_OPTION(MESSAGE, VARIABLE-NAME, FLAGS, +# [OUTPUT-FILE], [ACTION-SUCCESS], [ACTION-FAILURE]) +# ---------------------------------------------------------------- +# Check whether the given compiler option works +AC_DEFUN([_LT_COMPILER_OPTION], +[m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_DECL_SED])dnl +AC_CACHE_CHECK([$1], [$2], + [$2=no + m4_if([$4], , [ac_outfile=conftest.$ac_objext], [ac_outfile=$4]) + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + lt_compiler_flag="$3" + # Insert the option either (1) after the last *FLAGS variable, or + # (2) before a word containing "conftest.", or (3) at the end. + # Note that $ac_compile itself does not contain backslashes and begins + # with a dollar sign (not a hyphen), so the echo should work correctly. + # The option is referenced via a variable to avoid confusing sed. + lt_compile=`echo "$ac_compile" | $SED \ + -e 's:.*FLAGS}\{0,1\} :&$lt_compiler_flag :; t' \ + -e 's: [[^ ]]*conftest\.: $lt_compiler_flag&:; t' \ + -e 's:$: $lt_compiler_flag:'` + (eval echo "\"\$as_me:$LINENO: $lt_compile\"" >&AS_MESSAGE_LOG_FD) + (eval "$lt_compile" 2>conftest.err) + ac_status=$? + cat conftest.err >&AS_MESSAGE_LOG_FD + echo "$as_me:$LINENO: \$? = $ac_status" >&AS_MESSAGE_LOG_FD + if (exit $ac_status) && test -s "$ac_outfile"; then + # The compiler can only warn and ignore the option if not recognized + # So say no if there are warnings other than the usual output. + $ECHO "$_lt_compiler_boilerplate" | $SED '/^$/d' >conftest.exp + $SED '/^$/d; /^ *+/d' conftest.err >conftest.er2 + if test ! -s conftest.er2 || diff conftest.exp conftest.er2 >/dev/null; then + $2=yes + fi + fi + $RM conftest* +]) + +if test x"[$]$2" = xyes; then + m4_if([$5], , :, [$5]) +else + m4_if([$6], , :, [$6]) +fi +])# _LT_COMPILER_OPTION + +# Old name: +AU_ALIAS([AC_LIBTOOL_COMPILER_OPTION], [_LT_COMPILER_OPTION]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_COMPILER_OPTION], []) + + +# _LT_LINKER_OPTION(MESSAGE, VARIABLE-NAME, FLAGS, +# [ACTION-SUCCESS], [ACTION-FAILURE]) +# ---------------------------------------------------- +# Check whether the given linker option works +AC_DEFUN([_LT_LINKER_OPTION], +[m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_DECL_SED])dnl +AC_CACHE_CHECK([$1], [$2], + [$2=no + save_LDFLAGS="$LDFLAGS" + LDFLAGS="$LDFLAGS $3" + echo "$lt_simple_link_test_code" > conftest.$ac_ext + if (eval $ac_link 2>conftest.err) && test -s conftest$ac_exeext; then + # The linker can only warn and ignore the option if not recognized + # So say no if there are warnings + if test -s conftest.err; then + # Append any errors to the config.log. + cat conftest.err 1>&AS_MESSAGE_LOG_FD + $ECHO "$_lt_linker_boilerplate" | $SED '/^$/d' > conftest.exp + $SED '/^$/d; /^ *+/d' conftest.err >conftest.er2 + if diff conftest.exp conftest.er2 >/dev/null; then + $2=yes + fi + else + $2=yes + fi + fi + $RM -r conftest* + LDFLAGS="$save_LDFLAGS" +]) + +if test x"[$]$2" = xyes; then + m4_if([$4], , :, [$4]) +else + m4_if([$5], , :, [$5]) +fi +])# _LT_LINKER_OPTION + +# Old name: +AU_ALIAS([AC_LIBTOOL_LINKER_OPTION], [_LT_LINKER_OPTION]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_LINKER_OPTION], []) + + +# LT_CMD_MAX_LEN +#--------------- +AC_DEFUN([LT_CMD_MAX_LEN], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +# find the maximum length of command line arguments +AC_MSG_CHECKING([the maximum length of command line arguments]) +AC_CACHE_VAL([lt_cv_sys_max_cmd_len], [dnl + i=0 + teststring="ABCD" + + case $build_os in + msdosdjgpp*) + # On DJGPP, this test can blow up pretty badly due to problems in libc + # (any single argument exceeding 2000 bytes causes a buffer overrun + # during glob expansion). Even if it were fixed, the result of this + # check would be larger than it should be. + lt_cv_sys_max_cmd_len=12288; # 12K is about right + ;; + + gnu*) + # Under GNU Hurd, this test is not required because there is + # no limit to the length of command line arguments. + # Libtool will interpret -1 as no limit whatsoever + lt_cv_sys_max_cmd_len=-1; + ;; + + cygwin* | mingw* | cegcc*) + # On Win9x/ME, this test blows up -- it succeeds, but takes + # about 5 minutes as the teststring grows exponentially. + # Worse, since 9x/ME are not pre-emptively multitasking, + # you end up with a "frozen" computer, even though with patience + # the test eventually succeeds (with a max line length of 256k). + # Instead, let's just punt: use the minimum linelength reported by + # all of the supported platforms: 8192 (on NT/2K/XP). + lt_cv_sys_max_cmd_len=8192; + ;; + + mint*) + # On MiNT this can take a long time and run out of memory. + lt_cv_sys_max_cmd_len=8192; + ;; + + amigaos*) + # On AmigaOS with pdksh, this test takes hours, literally. + # So we just punt and use a minimum line length of 8192. + lt_cv_sys_max_cmd_len=8192; + ;; + + netbsd* | freebsd* | openbsd* | darwin* | dragonfly*) + # This has been around since 386BSD, at least. Likely further. + if test -x /sbin/sysctl; then + lt_cv_sys_max_cmd_len=`/sbin/sysctl -n kern.argmax` + elif test -x /usr/sbin/sysctl; then + lt_cv_sys_max_cmd_len=`/usr/sbin/sysctl -n kern.argmax` + else + lt_cv_sys_max_cmd_len=65536 # usable default for all BSDs + fi + # And add a safety zone + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \/ 4` + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \* 3` + ;; + + interix*) + # We know the value 262144 and hardcode it with a safety zone (like BSD) + lt_cv_sys_max_cmd_len=196608 + ;; + + os2*) + # The test takes a long time on OS/2. + lt_cv_sys_max_cmd_len=8192 + ;; + + osf*) + # Dr. Hans Ekkehard Plesser reports seeing a kernel panic running configure + # due to this test when exec_disable_arg_limit is 1 on Tru64. It is not + # nice to cause kernel panics so lets avoid the loop below. + # First set a reasonable default. + lt_cv_sys_max_cmd_len=16384 + # + if test -x /sbin/sysconfig; then + case `/sbin/sysconfig -q proc exec_disable_arg_limit` in + *1*) lt_cv_sys_max_cmd_len=-1 ;; + esac + fi + ;; + sco3.2v5*) + lt_cv_sys_max_cmd_len=102400 + ;; + sysv5* | sco5v6* | sysv4.2uw2*) + kargmax=`grep ARG_MAX /etc/conf/cf.d/stune 2>/dev/null` + if test -n "$kargmax"; then + lt_cv_sys_max_cmd_len=`echo $kargmax | sed 's/.*[[ ]]//'` + else + lt_cv_sys_max_cmd_len=32768 + fi + ;; + *) + lt_cv_sys_max_cmd_len=`(getconf ARG_MAX) 2> /dev/null` + if test -n "$lt_cv_sys_max_cmd_len"; then + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \/ 4` + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \* 3` + else + # Make teststring a little bigger before we do anything with it. + # a 1K string should be a reasonable start. + for i in 1 2 3 4 5 6 7 8 ; do + teststring=$teststring$teststring + done + SHELL=${SHELL-${CONFIG_SHELL-/bin/sh}} + # If test is not a shell built-in, we'll probably end up computing a + # maximum length that is only half of the actual maximum length, but + # we can't tell. + while { test "X"`env echo "$teststring$teststring" 2>/dev/null` \ + = "X$teststring$teststring"; } >/dev/null 2>&1 && + test $i != 17 # 1/2 MB should be enough + do + i=`expr $i + 1` + teststring=$teststring$teststring + done + # Only check the string length outside the loop. + lt_cv_sys_max_cmd_len=`expr "X$teststring" : ".*" 2>&1` + teststring= + # Add a significant safety factor because C++ compilers can tack on + # massive amounts of additional arguments before passing them to the + # linker. It appears as though 1/2 is a usable value. + lt_cv_sys_max_cmd_len=`expr $lt_cv_sys_max_cmd_len \/ 2` + fi + ;; + esac +]) +if test -n $lt_cv_sys_max_cmd_len ; then + AC_MSG_RESULT($lt_cv_sys_max_cmd_len) +else + AC_MSG_RESULT(none) +fi +max_cmd_len=$lt_cv_sys_max_cmd_len +_LT_DECL([], [max_cmd_len], [0], + [What is the maximum length of a command?]) +])# LT_CMD_MAX_LEN + +# Old name: +AU_ALIAS([AC_LIBTOOL_SYS_MAX_CMD_LEN], [LT_CMD_MAX_LEN]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_SYS_MAX_CMD_LEN], []) + + +# _LT_HEADER_DLFCN +# ---------------- +m4_defun([_LT_HEADER_DLFCN], +[AC_CHECK_HEADERS([dlfcn.h], [], [], [AC_INCLUDES_DEFAULT])dnl +])# _LT_HEADER_DLFCN + + +# _LT_TRY_DLOPEN_SELF (ACTION-IF-TRUE, ACTION-IF-TRUE-W-USCORE, +# ACTION-IF-FALSE, ACTION-IF-CROSS-COMPILING) +# ---------------------------------------------------------------- +m4_defun([_LT_TRY_DLOPEN_SELF], +[m4_require([_LT_HEADER_DLFCN])dnl +if test "$cross_compiling" = yes; then : + [$4] +else + lt_dlunknown=0; lt_dlno_uscore=1; lt_dlneed_uscore=2 + lt_status=$lt_dlunknown + cat > conftest.$ac_ext <<_LT_EOF +[#line $LINENO "configure" +#include "confdefs.h" + +#if HAVE_DLFCN_H +#include +#endif + +#include + +#ifdef RTLD_GLOBAL +# define LT_DLGLOBAL RTLD_GLOBAL +#else +# ifdef DL_GLOBAL +# define LT_DLGLOBAL DL_GLOBAL +# else +# define LT_DLGLOBAL 0 +# endif +#endif + +/* We may have to define LT_DLLAZY_OR_NOW in the command line if we + find out it does not work in some platform. */ +#ifndef LT_DLLAZY_OR_NOW +# ifdef RTLD_LAZY +# define LT_DLLAZY_OR_NOW RTLD_LAZY +# else +# ifdef DL_LAZY +# define LT_DLLAZY_OR_NOW DL_LAZY +# else +# ifdef RTLD_NOW +# define LT_DLLAZY_OR_NOW RTLD_NOW +# else +# ifdef DL_NOW +# define LT_DLLAZY_OR_NOW DL_NOW +# else +# define LT_DLLAZY_OR_NOW 0 +# endif +# endif +# endif +# endif +#endif + +/* When -fvisbility=hidden is used, assume the code has been annotated + correspondingly for the symbols needed. */ +#if defined(__GNUC__) && (((__GNUC__ == 3) && (__GNUC_MINOR__ >= 3)) || (__GNUC__ > 3)) +int fnord () __attribute__((visibility("default"))); +#endif + +int fnord () { return 42; } +int main () +{ + void *self = dlopen (0, LT_DLGLOBAL|LT_DLLAZY_OR_NOW); + int status = $lt_dlunknown; + + if (self) + { + if (dlsym (self,"fnord")) status = $lt_dlno_uscore; + else + { + if (dlsym( self,"_fnord")) status = $lt_dlneed_uscore; + else puts (dlerror ()); + } + /* dlclose (self); */ + } + else + puts (dlerror ()); + + return status; +}] +_LT_EOF + if AC_TRY_EVAL(ac_link) && test -s conftest${ac_exeext} 2>/dev/null; then + (./conftest; exit; ) >&AS_MESSAGE_LOG_FD 2>/dev/null + lt_status=$? + case x$lt_status in + x$lt_dlno_uscore) $1 ;; + x$lt_dlneed_uscore) $2 ;; + x$lt_dlunknown|x*) $3 ;; + esac + else : + # compilation failed + $3 + fi +fi +rm -fr conftest* +])# _LT_TRY_DLOPEN_SELF + + +# LT_SYS_DLOPEN_SELF +# ------------------ +AC_DEFUN([LT_SYS_DLOPEN_SELF], +[m4_require([_LT_HEADER_DLFCN])dnl +if test "x$enable_dlopen" != xyes; then + enable_dlopen=unknown + enable_dlopen_self=unknown + enable_dlopen_self_static=unknown +else + lt_cv_dlopen=no + lt_cv_dlopen_libs= + + case $host_os in + beos*) + lt_cv_dlopen="load_add_on" + lt_cv_dlopen_libs= + lt_cv_dlopen_self=yes + ;; + + mingw* | pw32* | cegcc*) + lt_cv_dlopen="LoadLibrary" + lt_cv_dlopen_libs= + ;; + + cygwin*) + lt_cv_dlopen="dlopen" + lt_cv_dlopen_libs= + ;; + + darwin*) + # if libdl is installed we need to link against it + AC_CHECK_LIB([dl], [dlopen], + [lt_cv_dlopen="dlopen" lt_cv_dlopen_libs="-ldl"],[ + lt_cv_dlopen="dyld" + lt_cv_dlopen_libs= + lt_cv_dlopen_self=yes + ]) + ;; + + *) + AC_CHECK_FUNC([shl_load], + [lt_cv_dlopen="shl_load"], + [AC_CHECK_LIB([dld], [shl_load], + [lt_cv_dlopen="shl_load" lt_cv_dlopen_libs="-ldld"], + [AC_CHECK_FUNC([dlopen], + [lt_cv_dlopen="dlopen"], + [AC_CHECK_LIB([dl], [dlopen], + [lt_cv_dlopen="dlopen" lt_cv_dlopen_libs="-ldl"], + [AC_CHECK_LIB([svld], [dlopen], + [lt_cv_dlopen="dlopen" lt_cv_dlopen_libs="-lsvld"], + [AC_CHECK_LIB([dld], [dld_link], + [lt_cv_dlopen="dld_link" lt_cv_dlopen_libs="-ldld"]) + ]) + ]) + ]) + ]) + ]) + ;; + esac + + if test "x$lt_cv_dlopen" != xno; then + enable_dlopen=yes + else + enable_dlopen=no + fi + + case $lt_cv_dlopen in + dlopen) + save_CPPFLAGS="$CPPFLAGS" + test "x$ac_cv_header_dlfcn_h" = xyes && CPPFLAGS="$CPPFLAGS -DHAVE_DLFCN_H" + + save_LDFLAGS="$LDFLAGS" + wl=$lt_prog_compiler_wl eval LDFLAGS=\"\$LDFLAGS $export_dynamic_flag_spec\" + + save_LIBS="$LIBS" + LIBS="$lt_cv_dlopen_libs $LIBS" + + AC_CACHE_CHECK([whether a program can dlopen itself], + lt_cv_dlopen_self, [dnl + _LT_TRY_DLOPEN_SELF( + lt_cv_dlopen_self=yes, lt_cv_dlopen_self=yes, + lt_cv_dlopen_self=no, lt_cv_dlopen_self=cross) + ]) + + if test "x$lt_cv_dlopen_self" = xyes; then + wl=$lt_prog_compiler_wl eval LDFLAGS=\"\$LDFLAGS $lt_prog_compiler_static\" + AC_CACHE_CHECK([whether a statically linked program can dlopen itself], + lt_cv_dlopen_self_static, [dnl + _LT_TRY_DLOPEN_SELF( + lt_cv_dlopen_self_static=yes, lt_cv_dlopen_self_static=yes, + lt_cv_dlopen_self_static=no, lt_cv_dlopen_self_static=cross) + ]) + fi + + CPPFLAGS="$save_CPPFLAGS" + LDFLAGS="$save_LDFLAGS" + LIBS="$save_LIBS" + ;; + esac + + case $lt_cv_dlopen_self in + yes|no) enable_dlopen_self=$lt_cv_dlopen_self ;; + *) enable_dlopen_self=unknown ;; + esac + + case $lt_cv_dlopen_self_static in + yes|no) enable_dlopen_self_static=$lt_cv_dlopen_self_static ;; + *) enable_dlopen_self_static=unknown ;; + esac +fi +_LT_DECL([dlopen_support], [enable_dlopen], [0], + [Whether dlopen is supported]) +_LT_DECL([dlopen_self], [enable_dlopen_self], [0], + [Whether dlopen of programs is supported]) +_LT_DECL([dlopen_self_static], [enable_dlopen_self_static], [0], + [Whether dlopen of statically linked programs is supported]) +])# LT_SYS_DLOPEN_SELF + +# Old name: +AU_ALIAS([AC_LIBTOOL_DLOPEN_SELF], [LT_SYS_DLOPEN_SELF]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_DLOPEN_SELF], []) + + +# _LT_COMPILER_C_O([TAGNAME]) +# --------------------------- +# Check to see if options -c and -o are simultaneously supported by compiler. +# This macro does not hard code the compiler like AC_PROG_CC_C_O. +m4_defun([_LT_COMPILER_C_O], +[m4_require([_LT_DECL_SED])dnl +m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_TAG_COMPILER])dnl +AC_CACHE_CHECK([if $compiler supports -c -o file.$ac_objext], + [_LT_TAGVAR(lt_cv_prog_compiler_c_o, $1)], + [_LT_TAGVAR(lt_cv_prog_compiler_c_o, $1)=no + $RM -r conftest 2>/dev/null + mkdir conftest + cd conftest + mkdir out + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + + lt_compiler_flag="-o out/conftest2.$ac_objext" + # Insert the option either (1) after the last *FLAGS variable, or + # (2) before a word containing "conftest.", or (3) at the end. + # Note that $ac_compile itself does not contain backslashes and begins + # with a dollar sign (not a hyphen), so the echo should work correctly. + lt_compile=`echo "$ac_compile" | $SED \ + -e 's:.*FLAGS}\{0,1\} :&$lt_compiler_flag :; t' \ + -e 's: [[^ ]]*conftest\.: $lt_compiler_flag&:; t' \ + -e 's:$: $lt_compiler_flag:'` + (eval echo "\"\$as_me:$LINENO: $lt_compile\"" >&AS_MESSAGE_LOG_FD) + (eval "$lt_compile" 2>out/conftest.err) + ac_status=$? + cat out/conftest.err >&AS_MESSAGE_LOG_FD + echo "$as_me:$LINENO: \$? = $ac_status" >&AS_MESSAGE_LOG_FD + if (exit $ac_status) && test -s out/conftest2.$ac_objext + then + # The compiler can only warn and ignore the option if not recognized + # So say no if there are warnings + $ECHO "$_lt_compiler_boilerplate" | $SED '/^$/d' > out/conftest.exp + $SED '/^$/d; /^ *+/d' out/conftest.err >out/conftest.er2 + if test ! -s out/conftest.er2 || diff out/conftest.exp out/conftest.er2 >/dev/null; then + _LT_TAGVAR(lt_cv_prog_compiler_c_o, $1)=yes + fi + fi + chmod u+w . 2>&AS_MESSAGE_LOG_FD + $RM conftest* + # SGI C++ compiler will create directory out/ii_files/ for + # template instantiation + test -d out/ii_files && $RM out/ii_files/* && rmdir out/ii_files + $RM out/* && rmdir out + cd .. + $RM -r conftest + $RM conftest* +]) +_LT_TAGDECL([compiler_c_o], [lt_cv_prog_compiler_c_o], [1], + [Does compiler simultaneously support -c and -o options?]) +])# _LT_COMPILER_C_O + + +# _LT_COMPILER_FILE_LOCKS([TAGNAME]) +# ---------------------------------- +# Check to see if we can do hard links to lock some files if needed +m4_defun([_LT_COMPILER_FILE_LOCKS], +[m4_require([_LT_ENABLE_LOCK])dnl +m4_require([_LT_FILEUTILS_DEFAULTS])dnl +_LT_COMPILER_C_O([$1]) + +hard_links="nottested" +if test "$_LT_TAGVAR(lt_cv_prog_compiler_c_o, $1)" = no && test "$need_locks" != no; then + # do not overwrite the value of need_locks provided by the user + AC_MSG_CHECKING([if we can lock with hard links]) + hard_links=yes + $RM conftest* + ln conftest.a conftest.b 2>/dev/null && hard_links=no + touch conftest.a + ln conftest.a conftest.b 2>&5 || hard_links=no + ln conftest.a conftest.b 2>/dev/null && hard_links=no + AC_MSG_RESULT([$hard_links]) + if test "$hard_links" = no; then + AC_MSG_WARN([`$CC' does not support `-c -o', so `make -j' may be unsafe]) + need_locks=warn + fi +else + need_locks=no +fi +_LT_DECL([], [need_locks], [1], [Must we lock files when doing compilation?]) +])# _LT_COMPILER_FILE_LOCKS + + +# _LT_CHECK_OBJDIR +# ---------------- +m4_defun([_LT_CHECK_OBJDIR], +[AC_CACHE_CHECK([for objdir], [lt_cv_objdir], +[rm -f .libs 2>/dev/null +mkdir .libs 2>/dev/null +if test -d .libs; then + lt_cv_objdir=.libs +else + # MS-DOS does not allow filenames that begin with a dot. + lt_cv_objdir=_libs +fi +rmdir .libs 2>/dev/null]) +objdir=$lt_cv_objdir +_LT_DECL([], [objdir], [0], + [The name of the directory that contains temporary libtool files])dnl +m4_pattern_allow([LT_OBJDIR])dnl +AC_DEFINE_UNQUOTED(LT_OBJDIR, "$lt_cv_objdir/", + [Define to the sub-directory in which libtool stores uninstalled libraries.]) +])# _LT_CHECK_OBJDIR + + +# _LT_LINKER_HARDCODE_LIBPATH([TAGNAME]) +# -------------------------------------- +# Check hardcoding attributes. +m4_defun([_LT_LINKER_HARDCODE_LIBPATH], +[AC_MSG_CHECKING([how to hardcode library paths into programs]) +_LT_TAGVAR(hardcode_action, $1)= +if test -n "$_LT_TAGVAR(hardcode_libdir_flag_spec, $1)" || + test -n "$_LT_TAGVAR(runpath_var, $1)" || + test "X$_LT_TAGVAR(hardcode_automatic, $1)" = "Xyes" ; then + + # We can hardcode non-existent directories. + if test "$_LT_TAGVAR(hardcode_direct, $1)" != no && + # If the only mechanism to avoid hardcoding is shlibpath_var, we + # have to relink, otherwise we might link with an installed library + # when we should be linking with a yet-to-be-installed one + ## test "$_LT_TAGVAR(hardcode_shlibpath_var, $1)" != no && + test "$_LT_TAGVAR(hardcode_minus_L, $1)" != no; then + # Linking always hardcodes the temporary library directory. + _LT_TAGVAR(hardcode_action, $1)=relink + else + # We can link without hardcoding, and we can hardcode nonexisting dirs. + _LT_TAGVAR(hardcode_action, $1)=immediate + fi +else + # We cannot hardcode anything, or else we can only hardcode existing + # directories. + _LT_TAGVAR(hardcode_action, $1)=unsupported +fi +AC_MSG_RESULT([$_LT_TAGVAR(hardcode_action, $1)]) + +if test "$_LT_TAGVAR(hardcode_action, $1)" = relink || + test "$_LT_TAGVAR(inherit_rpath, $1)" = yes; then + # Fast installation is not supported + enable_fast_install=no +elif test "$shlibpath_overrides_runpath" = yes || + test "$enable_shared" = no; then + # Fast installation is not necessary + enable_fast_install=needless +fi +_LT_TAGDECL([], [hardcode_action], [0], + [How to hardcode a shared library path into an executable]) +])# _LT_LINKER_HARDCODE_LIBPATH + + +# _LT_CMD_STRIPLIB +# ---------------- +m4_defun([_LT_CMD_STRIPLIB], +[m4_require([_LT_DECL_EGREP]) +striplib= +old_striplib= +AC_MSG_CHECKING([whether stripping libraries is possible]) +if test -n "$STRIP" && $STRIP -V 2>&1 | $GREP "GNU strip" >/dev/null; then + test -z "$old_striplib" && old_striplib="$STRIP --strip-debug" + test -z "$striplib" && striplib="$STRIP --strip-unneeded" + AC_MSG_RESULT([yes]) +else +# FIXME - insert some real tests, host_os isn't really good enough + case $host_os in + darwin*) + if test -n "$STRIP" ; then + striplib="$STRIP -x" + old_striplib="$STRIP -S" + AC_MSG_RESULT([yes]) + else + AC_MSG_RESULT([no]) + fi + ;; + *) + AC_MSG_RESULT([no]) + ;; + esac +fi +_LT_DECL([], [old_striplib], [1], [Commands to strip libraries]) +_LT_DECL([], [striplib], [1]) +])# _LT_CMD_STRIPLIB + + +# _LT_SYS_DYNAMIC_LINKER([TAG]) +# ----------------------------- +# PORTME Fill in your ld.so characteristics +m4_defun([_LT_SYS_DYNAMIC_LINKER], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +m4_require([_LT_DECL_EGREP])dnl +m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_DECL_OBJDUMP])dnl +m4_require([_LT_DECL_SED])dnl +m4_require([_LT_CHECK_SHELL_FEATURES])dnl +AC_MSG_CHECKING([dynamic linker characteristics]) +m4_if([$1], + [], [ +if test "$GCC" = yes; then + case $host_os in + darwin*) lt_awk_arg="/^libraries:/,/LR/" ;; + *) lt_awk_arg="/^libraries:/" ;; + esac + case $host_os in + mingw* | cegcc*) lt_sed_strip_eq="s,=\([[A-Za-z]]:\),\1,g" ;; + *) lt_sed_strip_eq="s,=/,/,g" ;; + esac + lt_search_path_spec=`$CC -print-search-dirs | awk $lt_awk_arg | $SED -e "s/^libraries://" -e $lt_sed_strip_eq` + case $lt_search_path_spec in + *\;*) + # if the path contains ";" then we assume it to be the separator + # otherwise default to the standard path separator (i.e. ":") - it is + # assumed that no part of a normal pathname contains ";" but that should + # okay in the real world where ";" in dirpaths is itself problematic. + lt_search_path_spec=`$ECHO "$lt_search_path_spec" | $SED 's/;/ /g'` + ;; + *) + lt_search_path_spec=`$ECHO "$lt_search_path_spec" | $SED "s/$PATH_SEPARATOR/ /g"` + ;; + esac + # Ok, now we have the path, separated by spaces, we can step through it + # and add multilib dir if necessary. + lt_tmp_lt_search_path_spec= + lt_multi_os_dir=`$CC $CPPFLAGS $CFLAGS $LDFLAGS -print-multi-os-directory 2>/dev/null` + for lt_sys_path in $lt_search_path_spec; do + if test -d "$lt_sys_path/$lt_multi_os_dir"; then + lt_tmp_lt_search_path_spec="$lt_tmp_lt_search_path_spec $lt_sys_path/$lt_multi_os_dir" + else + test -d "$lt_sys_path" && \ + lt_tmp_lt_search_path_spec="$lt_tmp_lt_search_path_spec $lt_sys_path" + fi + done + lt_search_path_spec=`$ECHO "$lt_tmp_lt_search_path_spec" | awk ' +BEGIN {RS=" "; FS="/|\n";} { + lt_foo=""; + lt_count=0; + for (lt_i = NF; lt_i > 0; lt_i--) { + if ($lt_i != "" && $lt_i != ".") { + if ($lt_i == "..") { + lt_count++; + } else { + if (lt_count == 0) { + lt_foo="/" $lt_i lt_foo; + } else { + lt_count--; + } + } + } + } + if (lt_foo != "") { lt_freq[[lt_foo]]++; } + if (lt_freq[[lt_foo]] == 1) { print lt_foo; } +}'` + # AWK program above erroneously prepends '/' to C:/dos/paths + # for these hosts. + case $host_os in + mingw* | cegcc*) lt_search_path_spec=`$ECHO "$lt_search_path_spec" |\ + $SED 's,/\([[A-Za-z]]:\),\1,g'` ;; + esac + sys_lib_search_path_spec=`$ECHO "$lt_search_path_spec" | $lt_NL2SP` +else + sys_lib_search_path_spec="/lib /usr/lib /usr/local/lib" +fi]) +library_names_spec= +libname_spec='lib$name' +soname_spec= +shrext_cmds=".so" +postinstall_cmds= +postuninstall_cmds= +finish_cmds= +finish_eval= +shlibpath_var= +shlibpath_overrides_runpath=unknown +version_type=none +dynamic_linker="$host_os ld.so" +sys_lib_dlsearch_path_spec="/lib /usr/lib" +need_lib_prefix=unknown +hardcode_into_libs=no + +# when you set need_version to no, make sure it does not cause -set_version +# flags to be left without arguments +need_version=unknown + +case $host_os in +aix3*) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix $libname.a' + shlibpath_var=LIBPATH + + # AIX 3 has no versioning support, so we append a major version to the name. + soname_spec='${libname}${release}${shared_ext}$major' + ;; + +aix[[4-9]]*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + hardcode_into_libs=yes + if test "$host_cpu" = ia64; then + # AIX 5 supports IA64 + library_names_spec='${libname}${release}${shared_ext}$major ${libname}${release}${shared_ext}$versuffix $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + else + # With GCC up to 2.95.x, collect2 would create an import file + # for dependence libraries. The import file would start with + # the line `#! .'. This would cause the generated library to + # depend on `.', always an invalid library. This was fixed in + # development snapshots of GCC prior to 3.0. + case $host_os in + aix4 | aix4.[[01]] | aix4.[[01]].*) + if { echo '#if __GNUC__ > 2 || (__GNUC__ == 2 && __GNUC_MINOR__ >= 97)' + echo ' yes ' + echo '#endif'; } | ${CC} -E - | $GREP yes > /dev/null; then + : + else + can_build_shared=no + fi + ;; + esac + # AIX (on Power*) has no versioning support, so currently we can not hardcode correct + # soname into executable. Probably we can add versioning support to + # collect2, so additional links can be useful in future. + if test "$aix_use_runtimelinking" = yes; then + # If using run time linking (on AIX 4.2 or later) use lib.so + # instead of lib.a to let people know that these are not + # typical AIX shared libraries. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + else + # We preserve .a as extension for shared libraries through AIX4.2 + # and later when we are not doing run time linking. + library_names_spec='${libname}${release}.a $libname.a' + soname_spec='${libname}${release}${shared_ext}$major' + fi + shlibpath_var=LIBPATH + fi + ;; + +amigaos*) + case $host_cpu in + powerpc) + # Since July 2007 AmigaOS4 officially supports .so libraries. + # When compiling the executable, add -use-dynld -Lsobjs: to the compileline. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + ;; + m68k) + library_names_spec='$libname.ixlibrary $libname.a' + # Create ${libname}_ixlibrary.a entries in /sys/libs. + finish_eval='for lib in `ls $libdir/*.ixlibrary 2>/dev/null`; do libname=`func_echo_all "$lib" | $SED '\''s%^.*/\([[^/]]*\)\.ixlibrary$%\1%'\''`; test $RM /sys/libs/${libname}_ixlibrary.a; $show "cd /sys/libs && $LN_S $lib ${libname}_ixlibrary.a"; cd /sys/libs && $LN_S $lib ${libname}_ixlibrary.a || exit 1; done' + ;; + esac + ;; + +beos*) + library_names_spec='${libname}${shared_ext}' + dynamic_linker="$host_os ld.so" + shlibpath_var=LIBRARY_PATH + ;; + +bsdi[[45]]*) + version_type=linux # correct to gnu/linux during the next big refactor + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + finish_cmds='PATH="\$PATH:/sbin" ldconfig $libdir' + shlibpath_var=LD_LIBRARY_PATH + sys_lib_search_path_spec="/shlib /usr/lib /usr/X11/lib /usr/contrib/lib /lib /usr/local/lib" + sys_lib_dlsearch_path_spec="/shlib /usr/lib /usr/local/lib" + # the default ld.so.conf also contains /usr/contrib/lib and + # /usr/X11R6/lib (/usr/X11 is a link to /usr/X11R6), but let us allow + # libtool to hard-code these into programs + ;; + +cygwin* | mingw* | pw32* | cegcc*) + version_type=windows + shrext_cmds=".dll" + need_version=no + need_lib_prefix=no + + case $GCC,$cc_basename in + yes,*) + # gcc + library_names_spec='$libname.dll.a' + # DLL is installed to $(libdir)/../bin by postinstall_cmds + postinstall_cmds='base_file=`basename \${file}`~ + dlpath=`$SHELL 2>&1 -c '\''. $dir/'\''\${base_file}'\''i; echo \$dlname'\''`~ + dldir=$destdir/`dirname \$dlpath`~ + test -d \$dldir || mkdir -p \$dldir~ + $install_prog $dir/$dlname \$dldir/$dlname~ + chmod a+x \$dldir/$dlname~ + if test -n '\''$stripme'\'' && test -n '\''$striplib'\''; then + eval '\''$striplib \$dldir/$dlname'\'' || exit \$?; + fi' + postuninstall_cmds='dldll=`$SHELL 2>&1 -c '\''. $file; echo \$dlname'\''`~ + dlpath=$dir/\$dldll~ + $RM \$dlpath' + shlibpath_overrides_runpath=yes + + case $host_os in + cygwin*) + # Cygwin DLLs use 'cyg' prefix rather than 'lib' + soname_spec='`echo ${libname} | sed -e 's/^lib/cyg/'``echo ${release} | $SED -e 's/[[.]]/-/g'`${versuffix}${shared_ext}' +m4_if([$1], [],[ + sys_lib_search_path_spec="$sys_lib_search_path_spec /usr/lib/w32api"]) + ;; + mingw* | cegcc*) + # MinGW DLLs use traditional 'lib' prefix + soname_spec='${libname}`echo ${release} | $SED -e 's/[[.]]/-/g'`${versuffix}${shared_ext}' + ;; + pw32*) + # pw32 DLLs use 'pw' prefix rather than 'lib' + library_names_spec='`echo ${libname} | sed -e 's/^lib/pw/'``echo ${release} | $SED -e 's/[[.]]/-/g'`${versuffix}${shared_ext}' + ;; + esac + dynamic_linker='Win32 ld.exe' + ;; + + *,cl*) + # Native MSVC + libname_spec='$name' + soname_spec='${libname}`echo ${release} | $SED -e 's/[[.]]/-/g'`${versuffix}${shared_ext}' + library_names_spec='${libname}.dll.lib' + + case $build_os in + mingw*) + sys_lib_search_path_spec= + lt_save_ifs=$IFS + IFS=';' + for lt_path in $LIB + do + IFS=$lt_save_ifs + # Let DOS variable expansion print the short 8.3 style file name. + lt_path=`cd "$lt_path" 2>/dev/null && cmd //C "for %i in (".") do @echo %~si"` + sys_lib_search_path_spec="$sys_lib_search_path_spec $lt_path" + done + IFS=$lt_save_ifs + # Convert to MSYS style. + sys_lib_search_path_spec=`$ECHO "$sys_lib_search_path_spec" | sed -e 's|\\\\|/|g' -e 's| \\([[a-zA-Z]]\\):| /\\1|g' -e 's|^ ||'` + ;; + cygwin*) + # Convert to unix form, then to dos form, then back to unix form + # but this time dos style (no spaces!) so that the unix form looks + # like /cygdrive/c/PROGRA~1:/cygdr... + sys_lib_search_path_spec=`cygpath --path --unix "$LIB"` + sys_lib_search_path_spec=`cygpath --path --dos "$sys_lib_search_path_spec" 2>/dev/null` + sys_lib_search_path_spec=`cygpath --path --unix "$sys_lib_search_path_spec" | $SED -e "s/$PATH_SEPARATOR/ /g"` + ;; + *) + sys_lib_search_path_spec="$LIB" + if $ECHO "$sys_lib_search_path_spec" | [$GREP ';[c-zC-Z]:/' >/dev/null]; then + # It is most probably a Windows format PATH. + sys_lib_search_path_spec=`$ECHO "$sys_lib_search_path_spec" | $SED -e 's/;/ /g'` + else + sys_lib_search_path_spec=`$ECHO "$sys_lib_search_path_spec" | $SED -e "s/$PATH_SEPARATOR/ /g"` + fi + # FIXME: find the short name or the path components, as spaces are + # common. (e.g. "Program Files" -> "PROGRA~1") + ;; + esac + + # DLL is installed to $(libdir)/../bin by postinstall_cmds + postinstall_cmds='base_file=`basename \${file}`~ + dlpath=`$SHELL 2>&1 -c '\''. $dir/'\''\${base_file}'\''i; echo \$dlname'\''`~ + dldir=$destdir/`dirname \$dlpath`~ + test -d \$dldir || mkdir -p \$dldir~ + $install_prog $dir/$dlname \$dldir/$dlname' + postuninstall_cmds='dldll=`$SHELL 2>&1 -c '\''. $file; echo \$dlname'\''`~ + dlpath=$dir/\$dldll~ + $RM \$dlpath' + shlibpath_overrides_runpath=yes + dynamic_linker='Win32 link.exe' + ;; + + *) + # Assume MSVC wrapper + library_names_spec='${libname}`echo ${release} | $SED -e 's/[[.]]/-/g'`${versuffix}${shared_ext} $libname.lib' + dynamic_linker='Win32 ld.exe' + ;; + esac + # FIXME: first we should search . and the directory the executable is in + shlibpath_var=PATH + ;; + +darwin* | rhapsody*) + dynamic_linker="$host_os dyld" + version_type=darwin + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${major}$shared_ext ${libname}$shared_ext' + soname_spec='${libname}${release}${major}$shared_ext' + shlibpath_overrides_runpath=yes + shlibpath_var=DYLD_LIBRARY_PATH + shrext_cmds='`test .$module = .yes && echo .so || echo .dylib`' +m4_if([$1], [],[ + sys_lib_search_path_spec="$sys_lib_search_path_spec /usr/local/lib"]) + sys_lib_dlsearch_path_spec='/usr/local/lib /lib /usr/lib' + ;; + +dgux*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname$shared_ext' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + ;; + +freebsd* | dragonfly*) + # DragonFly does not have aout. When/if they implement a new + # versioning mechanism, adjust this. + if test -x /usr/bin/objformat; then + objformat=`/usr/bin/objformat` + else + case $host_os in + freebsd[[23]].*) objformat=aout ;; + *) objformat=elf ;; + esac + fi + version_type=freebsd-$objformat + case $version_type in + freebsd-elf*) + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext} $libname${shared_ext}' + need_version=no + need_lib_prefix=no + ;; + freebsd-*) + library_names_spec='${libname}${release}${shared_ext}$versuffix $libname${shared_ext}$versuffix' + need_version=yes + ;; + esac + shlibpath_var=LD_LIBRARY_PATH + case $host_os in + freebsd2.*) + shlibpath_overrides_runpath=yes + ;; + freebsd3.[[01]]* | freebsdelf3.[[01]]*) + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + ;; + freebsd3.[[2-9]]* | freebsdelf3.[[2-9]]* | \ + freebsd4.[[0-5]] | freebsdelf4.[[0-5]] | freebsd4.1.1 | freebsdelf4.1.1) + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + *) # from 4.6 on, and DragonFly + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + ;; + esac + ;; + +gnu*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}${major} ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + +haiku*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + dynamic_linker="$host_os runtime_loader" + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}${major} ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LIBRARY_PATH + shlibpath_overrides_runpath=yes + sys_lib_dlsearch_path_spec='/boot/home/config/lib /boot/common/lib /boot/system/lib' + hardcode_into_libs=yes + ;; + +hpux9* | hpux10* | hpux11*) + # Give a soname corresponding to the major version so that dld.sl refuses to + # link against other versions. + version_type=sunos + need_lib_prefix=no + need_version=no + case $host_cpu in + ia64*) + shrext_cmds='.so' + hardcode_into_libs=yes + dynamic_linker="$host_os dld.so" + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes # Unless +noenvvar is specified. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + if test "X$HPUX_IA64_MODE" = X32; then + sys_lib_search_path_spec="/usr/lib/hpux32 /usr/local/lib/hpux32 /usr/local/lib" + else + sys_lib_search_path_spec="/usr/lib/hpux64 /usr/local/lib/hpux64" + fi + sys_lib_dlsearch_path_spec=$sys_lib_search_path_spec + ;; + hppa*64*) + shrext_cmds='.sl' + hardcode_into_libs=yes + dynamic_linker="$host_os dld.sl" + shlibpath_var=LD_LIBRARY_PATH # How should we handle SHLIB_PATH + shlibpath_overrides_runpath=yes # Unless +noenvvar is specified. + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + sys_lib_search_path_spec="/usr/lib/pa20_64 /usr/ccs/lib/pa20_64" + sys_lib_dlsearch_path_spec=$sys_lib_search_path_spec + ;; + *) + shrext_cmds='.sl' + dynamic_linker="$host_os dld.sl" + shlibpath_var=SHLIB_PATH + shlibpath_overrides_runpath=no # +s is required to enable SHLIB_PATH + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + ;; + esac + # HP-UX runs *really* slowly unless shared libraries are mode 555, ... + postinstall_cmds='chmod 555 $lib' + # or fails outright, so override atomically: + install_override_mode=555 + ;; + +interix[[3-9]]*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + dynamic_linker='Interix 3.x ld.so.1 (PE, like ELF)' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + +irix5* | irix6* | nonstopux*) + case $host_os in + nonstopux*) version_type=nonstopux ;; + *) + if test "$lt_cv_prog_gnu_ld" = yes; then + version_type=linux # correct to gnu/linux during the next big refactor + else + version_type=irix + fi ;; + esac + need_lib_prefix=no + need_version=no + soname_spec='${libname}${release}${shared_ext}$major' + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major ${libname}${release}${shared_ext} $libname${shared_ext}' + case $host_os in + irix5* | nonstopux*) + libsuff= shlibsuff= + ;; + *) + case $LD in # libtool.m4 will add one of these switches to LD + *-32|*"-32 "|*-melf32bsmip|*"-melf32bsmip ") + libsuff= shlibsuff= libmagic=32-bit;; + *-n32|*"-n32 "|*-melf32bmipn32|*"-melf32bmipn32 ") + libsuff=32 shlibsuff=N32 libmagic=N32;; + *-64|*"-64 "|*-melf64bmip|*"-melf64bmip ") + libsuff=64 shlibsuff=64 libmagic=64-bit;; + *) libsuff= shlibsuff= libmagic=never-match;; + esac + ;; + esac + shlibpath_var=LD_LIBRARY${shlibsuff}_PATH + shlibpath_overrides_runpath=no + sys_lib_search_path_spec="/usr/lib${libsuff} /lib${libsuff} /usr/local/lib${libsuff}" + sys_lib_dlsearch_path_spec="/usr/lib${libsuff} /lib${libsuff}" + hardcode_into_libs=yes + ;; + +# No shared lib support for Linux oldld, aout, or coff. +linux*oldld* | linux*aout* | linux*coff*) + dynamic_linker=no + ;; + +# This must be glibc/ELF. +linux* | k*bsd*-gnu | kopensolaris*-gnu) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + finish_cmds='PATH="\$PATH:/sbin" ldconfig -n $libdir' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + + # Some binutils ld are patched to set DT_RUNPATH + AC_CACHE_VAL([lt_cv_shlibpath_overrides_runpath], + [lt_cv_shlibpath_overrides_runpath=no + save_LDFLAGS=$LDFLAGS + save_libdir=$libdir + eval "libdir=/foo; wl=\"$_LT_TAGVAR(lt_prog_compiler_wl, $1)\"; \ + LDFLAGS=\"\$LDFLAGS $_LT_TAGVAR(hardcode_libdir_flag_spec, $1)\"" + AC_LINK_IFELSE([AC_LANG_PROGRAM([],[])], + [AS_IF([ ($OBJDUMP -p conftest$ac_exeext) 2>/dev/null | grep "RUNPATH.*$libdir" >/dev/null], + [lt_cv_shlibpath_overrides_runpath=yes])]) + LDFLAGS=$save_LDFLAGS + libdir=$save_libdir + ]) + shlibpath_overrides_runpath=$lt_cv_shlibpath_overrides_runpath + + # This implies no fast_install, which is unacceptable. + # Some rework will be needed to allow for fast_install + # before this can be enabled. + hardcode_into_libs=yes + + # Append ld.so.conf contents to the search path + if test -f /etc/ld.so.conf; then + lt_ld_extra=`awk '/^include / { system(sprintf("cd /etc; cat %s 2>/dev/null", \[$]2)); skip = 1; } { if (!skip) print \[$]0; skip = 0; }' < /etc/ld.so.conf | $SED -e 's/#.*//;/^[ ]*hwcap[ ]/d;s/[:, ]/ /g;s/=[^=]*$//;s/=[^= ]* / /g;s/"//g;/^$/d' | tr '\n' ' '` + sys_lib_dlsearch_path_spec="/lib /usr/lib $lt_ld_extra" + fi + + # We used to test for /lib/ld.so.1 and disable shared libraries on + # powerpc, because MkLinux only supported shared libraries with the + # GNU dynamic linker. Since this was broken with cross compilers, + # most powerpc-linux boxes support dynamic linking these days and + # people can always --disable-shared, the test was removed, and we + # assume the GNU/Linux dynamic linker is in use. + dynamic_linker='GNU/Linux ld.so' + ;; + +netbsd*) + version_type=sunos + need_lib_prefix=no + need_version=no + if echo __ELF__ | $CC -E - | $GREP __ELF__ >/dev/null; then + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${shared_ext}$versuffix' + finish_cmds='PATH="\$PATH:/sbin" ldconfig -m $libdir' + dynamic_linker='NetBSD (a.out) ld.so' + else + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major ${libname}${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + dynamic_linker='NetBSD ld.elf_so' + fi + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + ;; + +newsos6) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + ;; + +*nto* | *qnx*) + version_type=qnx + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + dynamic_linker='ldqnx.so' + ;; + +openbsd*) + version_type=sunos + sys_lib_dlsearch_path_spec="/usr/lib" + need_lib_prefix=no + # Some older versions of OpenBSD (3.3 at least) *do* need versioned libs. + case $host_os in + openbsd3.3 | openbsd3.3.*) need_version=yes ;; + *) need_version=no ;; + esac + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${shared_ext}$versuffix' + finish_cmds='PATH="\$PATH:/sbin" ldconfig -m $libdir' + shlibpath_var=LD_LIBRARY_PATH + if test -z "`echo __ELF__ | $CC -E - | $GREP __ELF__`" || test "$host_os-$host_cpu" = "openbsd2.8-powerpc"; then + case $host_os in + openbsd2.[[89]] | openbsd2.[[89]].*) + shlibpath_overrides_runpath=no + ;; + *) + shlibpath_overrides_runpath=yes + ;; + esac + else + shlibpath_overrides_runpath=yes + fi + ;; + +os2*) + libname_spec='$name' + shrext_cmds=".dll" + need_lib_prefix=no + library_names_spec='$libname${shared_ext} $libname.a' + dynamic_linker='OS/2 ld.exe' + shlibpath_var=LIBPATH + ;; + +osf3* | osf4* | osf5*) + version_type=osf + need_lib_prefix=no + need_version=no + soname_spec='${libname}${release}${shared_ext}$major' + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + sys_lib_search_path_spec="/usr/shlib /usr/ccs/lib /usr/lib/cmplrs/cc /usr/lib /usr/local/lib /var/shlib" + sys_lib_dlsearch_path_spec="$sys_lib_search_path_spec" + ;; + +rdos*) + dynamic_linker=no + ;; + +solaris*) + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + # ldd complains unless libraries are executable + postinstall_cmds='chmod +x $lib' + ;; + +sunos4*) + version_type=sunos + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${shared_ext}$versuffix' + finish_cmds='PATH="\$PATH:/usr/etc" ldconfig $libdir' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + if test "$with_gnu_ld" = yes; then + need_lib_prefix=no + fi + need_version=yes + ;; + +sysv4 | sysv4.3*) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + case $host_vendor in + sni) + shlibpath_overrides_runpath=no + need_lib_prefix=no + runpath_var=LD_RUN_PATH + ;; + siemens) + need_lib_prefix=no + ;; + motorola) + need_lib_prefix=no + need_version=no + shlibpath_overrides_runpath=no + sys_lib_search_path_spec='/lib /usr/lib /usr/ccs/lib' + ;; + esac + ;; + +sysv4*MP*) + if test -d /usr/nec ;then + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='$libname${shared_ext}.$versuffix $libname${shared_ext}.$major $libname${shared_ext}' + soname_spec='$libname${shared_ext}.$major' + shlibpath_var=LD_LIBRARY_PATH + fi + ;; + +sysv5* | sco3.2v5* | sco5v6* | unixware* | OpenUNIX* | sysv4*uw2*) + version_type=freebsd-elf + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext} $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=yes + hardcode_into_libs=yes + if test "$with_gnu_ld" = yes; then + sys_lib_search_path_spec='/usr/local/lib /usr/gnu/lib /usr/ccs/lib /usr/lib /lib' + else + sys_lib_search_path_spec='/usr/ccs/lib /usr/lib' + case $host_os in + sco3.2v5*) + sys_lib_search_path_spec="$sys_lib_search_path_spec /lib" + ;; + esac + fi + sys_lib_dlsearch_path_spec='/usr/lib' + ;; + +tpf*) + # TPF is a cross-target only. Preferred cross-host = GNU/Linux. + version_type=linux # correct to gnu/linux during the next big refactor + need_lib_prefix=no + need_version=no + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + shlibpath_var=LD_LIBRARY_PATH + shlibpath_overrides_runpath=no + hardcode_into_libs=yes + ;; + +uts4*) + version_type=linux # correct to gnu/linux during the next big refactor + library_names_spec='${libname}${release}${shared_ext}$versuffix ${libname}${release}${shared_ext}$major $libname${shared_ext}' + soname_spec='${libname}${release}${shared_ext}$major' + shlibpath_var=LD_LIBRARY_PATH + ;; + +*) + dynamic_linker=no + ;; +esac +AC_MSG_RESULT([$dynamic_linker]) +test "$dynamic_linker" = no && can_build_shared=no + +variables_saved_for_relink="PATH $shlibpath_var $runpath_var" +if test "$GCC" = yes; then + variables_saved_for_relink="$variables_saved_for_relink GCC_EXEC_PREFIX COMPILER_PATH LIBRARY_PATH" +fi + +if test "${lt_cv_sys_lib_search_path_spec+set}" = set; then + sys_lib_search_path_spec="$lt_cv_sys_lib_search_path_spec" +fi +if test "${lt_cv_sys_lib_dlsearch_path_spec+set}" = set; then + sys_lib_dlsearch_path_spec="$lt_cv_sys_lib_dlsearch_path_spec" +fi + +_LT_DECL([], [variables_saved_for_relink], [1], + [Variables whose values should be saved in libtool wrapper scripts and + restored at link time]) +_LT_DECL([], [need_lib_prefix], [0], + [Do we need the "lib" prefix for modules?]) +_LT_DECL([], [need_version], [0], [Do we need a version for libraries?]) +_LT_DECL([], [version_type], [0], [Library versioning type]) +_LT_DECL([], [runpath_var], [0], [Shared library runtime path variable]) +_LT_DECL([], [shlibpath_var], [0],[Shared library path variable]) +_LT_DECL([], [shlibpath_overrides_runpath], [0], + [Is shlibpath searched before the hard-coded library search path?]) +_LT_DECL([], [libname_spec], [1], [Format of library name prefix]) +_LT_DECL([], [library_names_spec], [1], + [[List of archive names. First name is the real one, the rest are links. + The last name is the one that the linker finds with -lNAME]]) +_LT_DECL([], [soname_spec], [1], + [[The coded name of the library, if different from the real name]]) +_LT_DECL([], [install_override_mode], [1], + [Permission mode override for installation of shared libraries]) +_LT_DECL([], [postinstall_cmds], [2], + [Command to use after installation of a shared archive]) +_LT_DECL([], [postuninstall_cmds], [2], + [Command to use after uninstallation of a shared archive]) +_LT_DECL([], [finish_cmds], [2], + [Commands used to finish a libtool library installation in a directory]) +_LT_DECL([], [finish_eval], [1], + [[As "finish_cmds", except a single script fragment to be evaled but + not shown]]) +_LT_DECL([], [hardcode_into_libs], [0], + [Whether we should hardcode library paths into libraries]) +_LT_DECL([], [sys_lib_search_path_spec], [2], + [Compile-time system search path for libraries]) +_LT_DECL([], [sys_lib_dlsearch_path_spec], [2], + [Run-time system search path for libraries]) +])# _LT_SYS_DYNAMIC_LINKER + + +# _LT_PATH_TOOL_PREFIX(TOOL) +# -------------------------- +# find a file program which can recognize shared library +AC_DEFUN([_LT_PATH_TOOL_PREFIX], +[m4_require([_LT_DECL_EGREP])dnl +AC_MSG_CHECKING([for $1]) +AC_CACHE_VAL(lt_cv_path_MAGIC_CMD, +[case $MAGIC_CMD in +[[\\/*] | ?:[\\/]*]) + lt_cv_path_MAGIC_CMD="$MAGIC_CMD" # Let the user override the test with a path. + ;; +*) + lt_save_MAGIC_CMD="$MAGIC_CMD" + lt_save_ifs="$IFS"; IFS=$PATH_SEPARATOR +dnl $ac_dummy forces splitting on constant user-supplied paths. +dnl POSIX.2 word splitting is done only on the output of word expansions, +dnl not every word. This closes a longstanding sh security hole. + ac_dummy="m4_if([$2], , $PATH, [$2])" + for ac_dir in $ac_dummy; do + IFS="$lt_save_ifs" + test -z "$ac_dir" && ac_dir=. + if test -f $ac_dir/$1; then + lt_cv_path_MAGIC_CMD="$ac_dir/$1" + if test -n "$file_magic_test_file"; then + case $deplibs_check_method in + "file_magic "*) + file_magic_regex=`expr "$deplibs_check_method" : "file_magic \(.*\)"` + MAGIC_CMD="$lt_cv_path_MAGIC_CMD" + if eval $file_magic_cmd \$file_magic_test_file 2> /dev/null | + $EGREP "$file_magic_regex" > /dev/null; then + : + else + cat <<_LT_EOF 1>&2 + +*** Warning: the command libtool uses to detect shared libraries, +*** $file_magic_cmd, produces output that libtool cannot recognize. +*** The result is that libtool may fail to recognize shared libraries +*** as such. This will affect the creation of libtool libraries that +*** depend on shared libraries, but programs linked with such libtool +*** libraries will work regardless of this problem. Nevertheless, you +*** may want to report the problem to your system manager and/or to +*** bug-libtool@gnu.org + +_LT_EOF + fi ;; + esac + fi + break + fi + done + IFS="$lt_save_ifs" + MAGIC_CMD="$lt_save_MAGIC_CMD" + ;; +esac]) +MAGIC_CMD="$lt_cv_path_MAGIC_CMD" +if test -n "$MAGIC_CMD"; then + AC_MSG_RESULT($MAGIC_CMD) +else + AC_MSG_RESULT(no) +fi +_LT_DECL([], [MAGIC_CMD], [0], + [Used to examine libraries when file_magic_cmd begins with "file"])dnl +])# _LT_PATH_TOOL_PREFIX + +# Old name: +AU_ALIAS([AC_PATH_TOOL_PREFIX], [_LT_PATH_TOOL_PREFIX]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_PATH_TOOL_PREFIX], []) + + +# _LT_PATH_MAGIC +# -------------- +# find a file program which can recognize a shared library +m4_defun([_LT_PATH_MAGIC], +[_LT_PATH_TOOL_PREFIX(${ac_tool_prefix}file, /usr/bin$PATH_SEPARATOR$PATH) +if test -z "$lt_cv_path_MAGIC_CMD"; then + if test -n "$ac_tool_prefix"; then + _LT_PATH_TOOL_PREFIX(file, /usr/bin$PATH_SEPARATOR$PATH) + else + MAGIC_CMD=: + fi +fi +])# _LT_PATH_MAGIC + + +# LT_PATH_LD +# ---------- +# find the pathname to the GNU or non-GNU linker +AC_DEFUN([LT_PATH_LD], +[AC_REQUIRE([AC_PROG_CC])dnl +AC_REQUIRE([AC_CANONICAL_HOST])dnl +AC_REQUIRE([AC_CANONICAL_BUILD])dnl +m4_require([_LT_DECL_SED])dnl +m4_require([_LT_DECL_EGREP])dnl +m4_require([_LT_PROG_ECHO_BACKSLASH])dnl + +AC_ARG_WITH([gnu-ld], + [AS_HELP_STRING([--with-gnu-ld], + [assume the C compiler uses GNU ld @<:@default=no@:>@])], + [test "$withval" = no || with_gnu_ld=yes], + [with_gnu_ld=no])dnl + +ac_prog=ld +if test "$GCC" = yes; then + # Check if gcc -print-prog-name=ld gives a path. + AC_MSG_CHECKING([for ld used by $CC]) + case $host in + *-*-mingw*) + # gcc leaves a trailing carriage return which upsets mingw + ac_prog=`($CC -print-prog-name=ld) 2>&5 | tr -d '\015'` ;; + *) + ac_prog=`($CC -print-prog-name=ld) 2>&5` ;; + esac + case $ac_prog in + # Accept absolute paths. + [[\\/]]* | ?:[[\\/]]*) + re_direlt='/[[^/]][[^/]]*/\.\./' + # Canonicalize the pathname of ld + ac_prog=`$ECHO "$ac_prog"| $SED 's%\\\\%/%g'` + while $ECHO "$ac_prog" | $GREP "$re_direlt" > /dev/null 2>&1; do + ac_prog=`$ECHO $ac_prog| $SED "s%$re_direlt%/%"` + done + test -z "$LD" && LD="$ac_prog" + ;; + "") + # If it fails, then pretend we aren't using GCC. + ac_prog=ld + ;; + *) + # If it is relative, then search for the first ld in PATH. + with_gnu_ld=unknown + ;; + esac +elif test "$with_gnu_ld" = yes; then + AC_MSG_CHECKING([for GNU ld]) +else + AC_MSG_CHECKING([for non-GNU ld]) +fi +AC_CACHE_VAL(lt_cv_path_LD, +[if test -z "$LD"; then + lt_save_ifs="$IFS"; IFS=$PATH_SEPARATOR + for ac_dir in $PATH; do + IFS="$lt_save_ifs" + test -z "$ac_dir" && ac_dir=. + if test -f "$ac_dir/$ac_prog" || test -f "$ac_dir/$ac_prog$ac_exeext"; then + lt_cv_path_LD="$ac_dir/$ac_prog" + # Check to see if the program is GNU ld. I'd rather use --version, + # but apparently some variants of GNU ld only accept -v. + # Break only if it was the GNU/non-GNU ld that we prefer. + case `"$lt_cv_path_LD" -v 2>&1 &1 /dev/null 2>&1; then + lt_cv_deplibs_check_method='file_magic ^x86 archive import|^x86 DLL' + lt_cv_file_magic_cmd='func_win32_libid' + else + # Keep this pattern in sync with the one in func_win32_libid. + lt_cv_deplibs_check_method='file_magic file format (pei*-i386(.*architecture: i386)?|pe-arm-wince|pe-x86-64)' + lt_cv_file_magic_cmd='$OBJDUMP -f' + fi + ;; + +cegcc*) + # use the weaker test based on 'objdump'. See mingw*. + lt_cv_deplibs_check_method='file_magic file format pe-arm-.*little(.*architecture: arm)?' + lt_cv_file_magic_cmd='$OBJDUMP -f' + ;; + +darwin* | rhapsody*) + lt_cv_deplibs_check_method=pass_all + ;; + +freebsd* | dragonfly*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ > /dev/null; then + case $host_cpu in + i*86 ) + # Not sure whether the presence of OpenBSD here was a mistake. + # Let's accept both of them until this is cleared up. + lt_cv_deplibs_check_method='file_magic (FreeBSD|OpenBSD|DragonFly)/i[[3-9]]86 (compact )?demand paged shared library' + lt_cv_file_magic_cmd=/usr/bin/file + lt_cv_file_magic_test_file=`echo /usr/lib/libc.so.*` + ;; + esac + else + lt_cv_deplibs_check_method=pass_all + fi + ;; + +gnu*) + lt_cv_deplibs_check_method=pass_all + ;; + +haiku*) + lt_cv_deplibs_check_method=pass_all + ;; + +hpux10.20* | hpux11*) + lt_cv_file_magic_cmd=/usr/bin/file + case $host_cpu in + ia64*) + lt_cv_deplibs_check_method='file_magic (s[[0-9]][[0-9]][[0-9]]|ELF-[[0-9]][[0-9]]) shared object file - IA64' + lt_cv_file_magic_test_file=/usr/lib/hpux32/libc.so + ;; + hppa*64*) + [lt_cv_deplibs_check_method='file_magic (s[0-9][0-9][0-9]|ELF[ -][0-9][0-9])(-bit)?( [LM]SB)? shared object( file)?[, -]* PA-RISC [0-9]\.[0-9]'] + lt_cv_file_magic_test_file=/usr/lib/pa20_64/libc.sl + ;; + *) + lt_cv_deplibs_check_method='file_magic (s[[0-9]][[0-9]][[0-9]]|PA-RISC[[0-9]]\.[[0-9]]) shared library' + lt_cv_file_magic_test_file=/usr/lib/libc.sl + ;; + esac + ;; + +interix[[3-9]]*) + # PIC code is broken on Interix 3.x, that's why |\.a not |_pic\.a here + lt_cv_deplibs_check_method='match_pattern /lib[[^/]]+(\.so|\.a)$' + ;; + +irix5* | irix6* | nonstopux*) + case $LD in + *-32|*"-32 ") libmagic=32-bit;; + *-n32|*"-n32 ") libmagic=N32;; + *-64|*"-64 ") libmagic=64-bit;; + *) libmagic=never-match;; + esac + lt_cv_deplibs_check_method=pass_all + ;; + +# This must be glibc/ELF. +linux* | k*bsd*-gnu | kopensolaris*-gnu) + lt_cv_deplibs_check_method=pass_all + ;; + +netbsd*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ > /dev/null; then + lt_cv_deplibs_check_method='match_pattern /lib[[^/]]+(\.so\.[[0-9]]+\.[[0-9]]+|_pic\.a)$' + else + lt_cv_deplibs_check_method='match_pattern /lib[[^/]]+(\.so|_pic\.a)$' + fi + ;; + +newos6*) + lt_cv_deplibs_check_method='file_magic ELF [[0-9]][[0-9]]*-bit [[ML]]SB (executable|dynamic lib)' + lt_cv_file_magic_cmd=/usr/bin/file + lt_cv_file_magic_test_file=/usr/lib/libnls.so + ;; + +*nto* | *qnx*) + lt_cv_deplibs_check_method=pass_all + ;; + +openbsd*) + if test -z "`echo __ELF__ | $CC -E - | $GREP __ELF__`" || test "$host_os-$host_cpu" = "openbsd2.8-powerpc"; then + lt_cv_deplibs_check_method='match_pattern /lib[[^/]]+(\.so\.[[0-9]]+\.[[0-9]]+|\.so|_pic\.a)$' + else + lt_cv_deplibs_check_method='match_pattern /lib[[^/]]+(\.so\.[[0-9]]+\.[[0-9]]+|_pic\.a)$' + fi + ;; + +osf3* | osf4* | osf5*) + lt_cv_deplibs_check_method=pass_all + ;; + +rdos*) + lt_cv_deplibs_check_method=pass_all + ;; + +solaris*) + lt_cv_deplibs_check_method=pass_all + ;; + +sysv5* | sco3.2v5* | sco5v6* | unixware* | OpenUNIX* | sysv4*uw2*) + lt_cv_deplibs_check_method=pass_all + ;; + +sysv4 | sysv4.3*) + case $host_vendor in + motorola) + lt_cv_deplibs_check_method='file_magic ELF [[0-9]][[0-9]]*-bit [[ML]]SB (shared object|dynamic lib) M[[0-9]][[0-9]]* Version [[0-9]]' + lt_cv_file_magic_test_file=`echo /usr/lib/libc.so*` + ;; + ncr) + lt_cv_deplibs_check_method=pass_all + ;; + sequent) + lt_cv_file_magic_cmd='/bin/file' + lt_cv_deplibs_check_method='file_magic ELF [[0-9]][[0-9]]*-bit [[LM]]SB (shared object|dynamic lib )' + ;; + sni) + lt_cv_file_magic_cmd='/bin/file' + lt_cv_deplibs_check_method="file_magic ELF [[0-9]][[0-9]]*-bit [[LM]]SB dynamic lib" + lt_cv_file_magic_test_file=/lib/libc.so + ;; + siemens) + lt_cv_deplibs_check_method=pass_all + ;; + pc) + lt_cv_deplibs_check_method=pass_all + ;; + esac + ;; + +tpf*) + lt_cv_deplibs_check_method=pass_all + ;; +esac +]) + +file_magic_glob= +want_nocaseglob=no +if test "$build" = "$host"; then + case $host_os in + mingw* | pw32*) + if ( shopt | grep nocaseglob ) >/dev/null 2>&1; then + want_nocaseglob=yes + else + file_magic_glob=`echo aAbBcCdDeEfFgGhHiIjJkKlLmMnNoOpPqQrRsStTuUvVwWxXyYzZ | $SED -e "s/\(..\)/s\/[[\1]]\/[[\1]]\/g;/g"` + fi + ;; + esac +fi + +file_magic_cmd=$lt_cv_file_magic_cmd +deplibs_check_method=$lt_cv_deplibs_check_method +test -z "$deplibs_check_method" && deplibs_check_method=unknown + +_LT_DECL([], [deplibs_check_method], [1], + [Method to check whether dependent libraries are shared objects]) +_LT_DECL([], [file_magic_cmd], [1], + [Command to use when deplibs_check_method = "file_magic"]) +_LT_DECL([], [file_magic_glob], [1], + [How to find potential files when deplibs_check_method = "file_magic"]) +_LT_DECL([], [want_nocaseglob], [1], + [Find potential files using nocaseglob when deplibs_check_method = "file_magic"]) +])# _LT_CHECK_MAGIC_METHOD + + +# LT_PATH_NM +# ---------- +# find the pathname to a BSD- or MS-compatible name lister +AC_DEFUN([LT_PATH_NM], +[AC_REQUIRE([AC_PROG_CC])dnl +AC_CACHE_CHECK([for BSD- or MS-compatible name lister (nm)], lt_cv_path_NM, +[if test -n "$NM"; then + # Let the user override the test. + lt_cv_path_NM="$NM" +else + lt_nm_to_check="${ac_tool_prefix}nm" + if test -n "$ac_tool_prefix" && test "$build" = "$host"; then + lt_nm_to_check="$lt_nm_to_check nm" + fi + for lt_tmp_nm in $lt_nm_to_check; do + lt_save_ifs="$IFS"; IFS=$PATH_SEPARATOR + for ac_dir in $PATH /usr/ccs/bin/elf /usr/ccs/bin /usr/ucb /bin; do + IFS="$lt_save_ifs" + test -z "$ac_dir" && ac_dir=. + tmp_nm="$ac_dir/$lt_tmp_nm" + if test -f "$tmp_nm" || test -f "$tmp_nm$ac_exeext" ; then + # Check to see if the nm accepts a BSD-compat flag. + # Adding the `sed 1q' prevents false positives on HP-UX, which says: + # nm: unknown option "B" ignored + # Tru64's nm complains that /dev/null is an invalid object file + case `"$tmp_nm" -B /dev/null 2>&1 | sed '1q'` in + */dev/null* | *'Invalid file or object type'*) + lt_cv_path_NM="$tmp_nm -B" + break + ;; + *) + case `"$tmp_nm" -p /dev/null 2>&1 | sed '1q'` in + */dev/null*) + lt_cv_path_NM="$tmp_nm -p" + break + ;; + *) + lt_cv_path_NM=${lt_cv_path_NM="$tmp_nm"} # keep the first match, but + continue # so that we can try to find one that supports BSD flags + ;; + esac + ;; + esac + fi + done + IFS="$lt_save_ifs" + done + : ${lt_cv_path_NM=no} +fi]) +if test "$lt_cv_path_NM" != "no"; then + NM="$lt_cv_path_NM" +else + # Didn't find any BSD compatible name lister, look for dumpbin. + if test -n "$DUMPBIN"; then : + # Let the user override the test. + else + AC_CHECK_TOOLS(DUMPBIN, [dumpbin "link -dump"], :) + case `$DUMPBIN -symbols /dev/null 2>&1 | sed '1q'` in + *COFF*) + DUMPBIN="$DUMPBIN -symbols" + ;; + *) + DUMPBIN=: + ;; + esac + fi + AC_SUBST([DUMPBIN]) + if test "$DUMPBIN" != ":"; then + NM="$DUMPBIN" + fi +fi +test -z "$NM" && NM=nm +AC_SUBST([NM]) +_LT_DECL([], [NM], [1], [A BSD- or MS-compatible name lister])dnl + +AC_CACHE_CHECK([the name lister ($NM) interface], [lt_cv_nm_interface], + [lt_cv_nm_interface="BSD nm" + echo "int some_variable = 0;" > conftest.$ac_ext + (eval echo "\"\$as_me:$LINENO: $ac_compile\"" >&AS_MESSAGE_LOG_FD) + (eval "$ac_compile" 2>conftest.err) + cat conftest.err >&AS_MESSAGE_LOG_FD + (eval echo "\"\$as_me:$LINENO: $NM \\\"conftest.$ac_objext\\\"\"" >&AS_MESSAGE_LOG_FD) + (eval "$NM \"conftest.$ac_objext\"" 2>conftest.err > conftest.out) + cat conftest.err >&AS_MESSAGE_LOG_FD + (eval echo "\"\$as_me:$LINENO: output\"" >&AS_MESSAGE_LOG_FD) + cat conftest.out >&AS_MESSAGE_LOG_FD + if $GREP 'External.*some_variable' conftest.out > /dev/null; then + lt_cv_nm_interface="MS dumpbin" + fi + rm -f conftest*]) +])# LT_PATH_NM + +# Old names: +AU_ALIAS([AM_PROG_NM], [LT_PATH_NM]) +AU_ALIAS([AC_PROG_NM], [LT_PATH_NM]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AM_PROG_NM], []) +dnl AC_DEFUN([AC_PROG_NM], []) + +# _LT_CHECK_SHAREDLIB_FROM_LINKLIB +# -------------------------------- +# how to determine the name of the shared library +# associated with a specific link library. +# -- PORTME fill in with the dynamic library characteristics +m4_defun([_LT_CHECK_SHAREDLIB_FROM_LINKLIB], +[m4_require([_LT_DECL_EGREP]) +m4_require([_LT_DECL_OBJDUMP]) +m4_require([_LT_DECL_DLLTOOL]) +AC_CACHE_CHECK([how to associate runtime and link libraries], +lt_cv_sharedlib_from_linklib_cmd, +[lt_cv_sharedlib_from_linklib_cmd='unknown' + +case $host_os in +cygwin* | mingw* | pw32* | cegcc*) + # two different shell functions defined in ltmain.sh + # decide which to use based on capabilities of $DLLTOOL + case `$DLLTOOL --help 2>&1` in + *--identify-strict*) + lt_cv_sharedlib_from_linklib_cmd=func_cygming_dll_for_implib + ;; + *) + lt_cv_sharedlib_from_linklib_cmd=func_cygming_dll_for_implib_fallback + ;; + esac + ;; +*) + # fallback: assume linklib IS sharedlib + lt_cv_sharedlib_from_linklib_cmd="$ECHO" + ;; +esac +]) +sharedlib_from_linklib_cmd=$lt_cv_sharedlib_from_linklib_cmd +test -z "$sharedlib_from_linklib_cmd" && sharedlib_from_linklib_cmd=$ECHO + +_LT_DECL([], [sharedlib_from_linklib_cmd], [1], + [Command to associate shared and link libraries]) +])# _LT_CHECK_SHAREDLIB_FROM_LINKLIB + + +# _LT_PATH_MANIFEST_TOOL +# ---------------------- +# locate the manifest tool +m4_defun([_LT_PATH_MANIFEST_TOOL], +[AC_CHECK_TOOL(MANIFEST_TOOL, mt, :) +test -z "$MANIFEST_TOOL" && MANIFEST_TOOL=mt +AC_CACHE_CHECK([if $MANIFEST_TOOL is a manifest tool], [lt_cv_path_mainfest_tool], + [lt_cv_path_mainfest_tool=no + echo "$as_me:$LINENO: $MANIFEST_TOOL '-?'" >&AS_MESSAGE_LOG_FD + $MANIFEST_TOOL '-?' 2>conftest.err > conftest.out + cat conftest.err >&AS_MESSAGE_LOG_FD + if $GREP 'Manifest Tool' conftest.out > /dev/null; then + lt_cv_path_mainfest_tool=yes + fi + rm -f conftest*]) +if test "x$lt_cv_path_mainfest_tool" != xyes; then + MANIFEST_TOOL=: +fi +_LT_DECL([], [MANIFEST_TOOL], [1], [Manifest tool])dnl +])# _LT_PATH_MANIFEST_TOOL + + +# LT_LIB_M +# -------- +# check for math library +AC_DEFUN([LT_LIB_M], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +LIBM= +case $host in +*-*-beos* | *-*-cegcc* | *-*-cygwin* | *-*-haiku* | *-*-pw32* | *-*-darwin*) + # These system don't have libm, or don't need it + ;; +*-ncr-sysv4.3*) + AC_CHECK_LIB(mw, _mwvalidcheckl, LIBM="-lmw") + AC_CHECK_LIB(m, cos, LIBM="$LIBM -lm") + ;; +*) + AC_CHECK_LIB(m, cos, LIBM="-lm") + ;; +esac +AC_SUBST([LIBM]) +])# LT_LIB_M + +# Old name: +AU_ALIAS([AC_CHECK_LIBM], [LT_LIB_M]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_CHECK_LIBM], []) + + +# _LT_COMPILER_NO_RTTI([TAGNAME]) +# ------------------------------- +m4_defun([_LT_COMPILER_NO_RTTI], +[m4_require([_LT_TAG_COMPILER])dnl + +_LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)= + +if test "$GCC" = yes; then + case $cc_basename in + nvcc*) + _LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)=' -Xcompiler -fno-builtin' ;; + *) + _LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)=' -fno-builtin' ;; + esac + + _LT_COMPILER_OPTION([if $compiler supports -fno-rtti -fno-exceptions], + lt_cv_prog_compiler_rtti_exceptions, + [-fno-rtti -fno-exceptions], [], + [_LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)="$_LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1) -fno-rtti -fno-exceptions"]) +fi +_LT_TAGDECL([no_builtin_flag], [lt_prog_compiler_no_builtin_flag], [1], + [Compiler flag to turn off builtin functions]) +])# _LT_COMPILER_NO_RTTI + + +# _LT_CMD_GLOBAL_SYMBOLS +# ---------------------- +m4_defun([_LT_CMD_GLOBAL_SYMBOLS], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +AC_REQUIRE([AC_PROG_CC])dnl +AC_REQUIRE([AC_PROG_AWK])dnl +AC_REQUIRE([LT_PATH_NM])dnl +AC_REQUIRE([LT_PATH_LD])dnl +m4_require([_LT_DECL_SED])dnl +m4_require([_LT_DECL_EGREP])dnl +m4_require([_LT_TAG_COMPILER])dnl + +# Check for command to grab the raw symbol name followed by C symbol from nm. +AC_MSG_CHECKING([command to parse $NM output from $compiler object]) +AC_CACHE_VAL([lt_cv_sys_global_symbol_pipe], +[ +# These are sane defaults that work on at least a few old systems. +# [They come from Ultrix. What could be older than Ultrix?!! ;)] + +# Character class describing NM global symbol codes. +symcode='[[BCDEGRST]]' + +# Regexp to match symbols that can be accessed directly from C. +sympat='\([[_A-Za-z]][[_A-Za-z0-9]]*\)' + +# Define system-specific variables. +case $host_os in +aix*) + symcode='[[BCDT]]' + ;; +cygwin* | mingw* | pw32* | cegcc*) + symcode='[[ABCDGISTW]]' + ;; +hpux*) + if test "$host_cpu" = ia64; then + symcode='[[ABCDEGRST]]' + fi + ;; +irix* | nonstopux*) + symcode='[[BCDEGRST]]' + ;; +osf*) + symcode='[[BCDEGQRST]]' + ;; +solaris*) + symcode='[[BDRT]]' + ;; +sco3.2v5*) + symcode='[[DT]]' + ;; +sysv4.2uw2*) + symcode='[[DT]]' + ;; +sysv5* | sco5v6* | unixware* | OpenUNIX*) + symcode='[[ABDT]]' + ;; +sysv4) + symcode='[[DFNSTU]]' + ;; +esac + +# If we're using GNU nm, then use its standard symbol codes. +case `$NM -V 2>&1` in +*GNU* | *'with BFD'*) + symcode='[[ABCDGIRSTW]]' ;; +esac + +# Transform an extracted symbol line into a proper C declaration. +# Some systems (esp. on ia64) link data and code symbols differently, +# so use this general approach. +lt_cv_sys_global_symbol_to_cdecl="sed -n -e 's/^T .* \(.*\)$/extern int \1();/p' -e 's/^$symcode* .* \(.*\)$/extern char \1;/p'" + +# Transform an extracted symbol line into symbol name and symbol address +lt_cv_sys_global_symbol_to_c_name_address="sed -n -e 's/^: \([[^ ]]*\)[[ ]]*$/ {\\\"\1\\\", (void *) 0},/p' -e 's/^$symcode* \([[^ ]]*\) \([[^ ]]*\)$/ {\"\2\", (void *) \&\2},/p'" +lt_cv_sys_global_symbol_to_c_name_address_lib_prefix="sed -n -e 's/^: \([[^ ]]*\)[[ ]]*$/ {\\\"\1\\\", (void *) 0},/p' -e 's/^$symcode* \([[^ ]]*\) \(lib[[^ ]]*\)$/ {\"\2\", (void *) \&\2},/p' -e 's/^$symcode* \([[^ ]]*\) \([[^ ]]*\)$/ {\"lib\2\", (void *) \&\2},/p'" + +# Handle CRLF in mingw tool chain +opt_cr= +case $build_os in +mingw*) + opt_cr=`$ECHO 'x\{0,1\}' | tr x '\015'` # option cr in regexp + ;; +esac + +# Try without a prefix underscore, then with it. +for ac_symprfx in "" "_"; do + + # Transform symcode, sympat, and symprfx into a raw symbol and a C symbol. + symxfrm="\\1 $ac_symprfx\\2 \\2" + + # Write the raw and C identifiers. + if test "$lt_cv_nm_interface" = "MS dumpbin"; then + # Fake it for dumpbin and say T for any non-static function + # and D for any global variable. + # Also find C++ and __fastcall symbols from MSVC++, + # which start with @ or ?. + lt_cv_sys_global_symbol_pipe="$AWK ['"\ +" {last_section=section; section=\$ 3};"\ +" /^COFF SYMBOL TABLE/{for(i in hide) delete hide[i]};"\ +" /Section length .*#relocs.*(pick any)/{hide[last_section]=1};"\ +" \$ 0!~/External *\|/{next};"\ +" / 0+ UNDEF /{next}; / UNDEF \([^|]\)*()/{next};"\ +" {if(hide[section]) next};"\ +" {f=0}; \$ 0~/\(\).*\|/{f=1}; {printf f ? \"T \" : \"D \"};"\ +" {split(\$ 0, a, /\||\r/); split(a[2], s)};"\ +" s[1]~/^[@?]/{print s[1], s[1]; next};"\ +" s[1]~prfx {split(s[1],t,\"@\"); print t[1], substr(t[1],length(prfx))}"\ +" ' prfx=^$ac_symprfx]" + else + lt_cv_sys_global_symbol_pipe="sed -n -e 's/^.*[[ ]]\($symcode$symcode*\)[[ ]][[ ]]*$ac_symprfx$sympat$opt_cr$/$symxfrm/p'" + fi + lt_cv_sys_global_symbol_pipe="$lt_cv_sys_global_symbol_pipe | sed '/ __gnu_lto/d'" + + # Check to see that the pipe works correctly. + pipe_works=no + + rm -f conftest* + cat > conftest.$ac_ext <<_LT_EOF +#ifdef __cplusplus +extern "C" { +#endif +char nm_test_var; +void nm_test_func(void); +void nm_test_func(void){} +#ifdef __cplusplus +} +#endif +int main(){nm_test_var='a';nm_test_func();return(0);} +_LT_EOF + + if AC_TRY_EVAL(ac_compile); then + # Now try to grab the symbols. + nlist=conftest.nm + if AC_TRY_EVAL(NM conftest.$ac_objext \| "$lt_cv_sys_global_symbol_pipe" \> $nlist) && test -s "$nlist"; then + # Try sorting and uniquifying the output. + if sort "$nlist" | uniq > "$nlist"T; then + mv -f "$nlist"T "$nlist" + else + rm -f "$nlist"T + fi + + # Make sure that we snagged all the symbols we need. + if $GREP ' nm_test_var$' "$nlist" >/dev/null; then + if $GREP ' nm_test_func$' "$nlist" >/dev/null; then + cat <<_LT_EOF > conftest.$ac_ext +/* Keep this code in sync between libtool.m4, ltmain, lt_system.h, and tests. */ +#if defined(_WIN32) || defined(__CYGWIN__) || defined(_WIN32_WCE) +/* DATA imports from DLLs on WIN32 con't be const, because runtime + relocations are performed -- see ld's documentation on pseudo-relocs. */ +# define LT@&t@_DLSYM_CONST +#elif defined(__osf__) +/* This system does not cope well with relocations in const data. */ +# define LT@&t@_DLSYM_CONST +#else +# define LT@&t@_DLSYM_CONST const +#endif + +#ifdef __cplusplus +extern "C" { +#endif + +_LT_EOF + # Now generate the symbol file. + eval "$lt_cv_sys_global_symbol_to_cdecl"' < "$nlist" | $GREP -v main >> conftest.$ac_ext' + + cat <<_LT_EOF >> conftest.$ac_ext + +/* The mapping between symbol names and symbols. */ +LT@&t@_DLSYM_CONST struct { + const char *name; + void *address; +} +lt__PROGRAM__LTX_preloaded_symbols[[]] = +{ + { "@PROGRAM@", (void *) 0 }, +_LT_EOF + $SED "s/^$symcode$symcode* \(.*\) \(.*\)$/ {\"\2\", (void *) \&\2},/" < "$nlist" | $GREP -v main >> conftest.$ac_ext + cat <<\_LT_EOF >> conftest.$ac_ext + {0, (void *) 0} +}; + +/* This works around a problem in FreeBSD linker */ +#ifdef FREEBSD_WORKAROUND +static const void *lt_preloaded_setup() { + return lt__PROGRAM__LTX_preloaded_symbols; +} +#endif + +#ifdef __cplusplus +} +#endif +_LT_EOF + # Now try linking the two files. + mv conftest.$ac_objext conftstm.$ac_objext + lt_globsym_save_LIBS=$LIBS + lt_globsym_save_CFLAGS=$CFLAGS + LIBS="conftstm.$ac_objext" + CFLAGS="$CFLAGS$_LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)" + if AC_TRY_EVAL(ac_link) && test -s conftest${ac_exeext}; then + pipe_works=yes + fi + LIBS=$lt_globsym_save_LIBS + CFLAGS=$lt_globsym_save_CFLAGS + else + echo "cannot find nm_test_func in $nlist" >&AS_MESSAGE_LOG_FD + fi + else + echo "cannot find nm_test_var in $nlist" >&AS_MESSAGE_LOG_FD + fi + else + echo "cannot run $lt_cv_sys_global_symbol_pipe" >&AS_MESSAGE_LOG_FD + fi + else + echo "$progname: failed program was:" >&AS_MESSAGE_LOG_FD + cat conftest.$ac_ext >&5 + fi + rm -rf conftest* conftst* + + # Do not use the global_symbol_pipe unless it works. + if test "$pipe_works" = yes; then + break + else + lt_cv_sys_global_symbol_pipe= + fi +done +]) +if test -z "$lt_cv_sys_global_symbol_pipe"; then + lt_cv_sys_global_symbol_to_cdecl= +fi +if test -z "$lt_cv_sys_global_symbol_pipe$lt_cv_sys_global_symbol_to_cdecl"; then + AC_MSG_RESULT(failed) +else + AC_MSG_RESULT(ok) +fi + +# Response file support. +if test "$lt_cv_nm_interface" = "MS dumpbin"; then + nm_file_list_spec='@' +elif $NM --help 2>/dev/null | grep '[[@]]FILE' >/dev/null; then + nm_file_list_spec='@' +fi + +_LT_DECL([global_symbol_pipe], [lt_cv_sys_global_symbol_pipe], [1], + [Take the output of nm and produce a listing of raw symbols and C names]) +_LT_DECL([global_symbol_to_cdecl], [lt_cv_sys_global_symbol_to_cdecl], [1], + [Transform the output of nm in a proper C declaration]) +_LT_DECL([global_symbol_to_c_name_address], + [lt_cv_sys_global_symbol_to_c_name_address], [1], + [Transform the output of nm in a C name address pair]) +_LT_DECL([global_symbol_to_c_name_address_lib_prefix], + [lt_cv_sys_global_symbol_to_c_name_address_lib_prefix], [1], + [Transform the output of nm in a C name address pair when lib prefix is needed]) +_LT_DECL([], [nm_file_list_spec], [1], + [Specify filename containing input files for $NM]) +]) # _LT_CMD_GLOBAL_SYMBOLS + + +# _LT_COMPILER_PIC([TAGNAME]) +# --------------------------- +m4_defun([_LT_COMPILER_PIC], +[m4_require([_LT_TAG_COMPILER])dnl +_LT_TAGVAR(lt_prog_compiler_wl, $1)= +_LT_TAGVAR(lt_prog_compiler_pic, $1)= +_LT_TAGVAR(lt_prog_compiler_static, $1)= + +m4_if([$1], [CXX], [ + # C++ specific cases for pic, static, wl, etc. + if test "$GXX" = yes; then + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + + case $host_os in + aix*) + # All AIX code is PIC. + if test "$host_cpu" = ia64; then + # AIX 5 now supports IA64 processor + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + fi + ;; + + amigaos*) + case $host_cpu in + powerpc) + # see comment about AmigaOS4 .so support + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + m68k) + # FIXME: we need at least 68020 code to build shared libraries, but + # adding the `-m68020' flag to GCC prevents building anything better, + # like `-m68040'. + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-m68020 -resident32 -malways-restore-a4' + ;; + esac + ;; + + beos* | irix5* | irix6* | nonstopux* | osf3* | osf4* | osf5*) + # PIC is the default for these OSes. + ;; + mingw* | cygwin* | os2* | pw32* | cegcc*) + # This hack is so that the source file can tell whether it is being + # built for inclusion in a dll (and should export symbols for example). + # Although the cygwin gcc ignores -fPIC, still need this for old-style + # (--disable-auto-import) libraries + m4_if([$1], [GCJ], [], + [_LT_TAGVAR(lt_prog_compiler_pic, $1)='-DDLL_EXPORT']) + ;; + darwin* | rhapsody*) + # PIC is the default on this platform + # Common symbols not allowed in MH_DYLIB files + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fno-common' + ;; + *djgpp*) + # DJGPP does not support shared libraries at all + _LT_TAGVAR(lt_prog_compiler_pic, $1)= + ;; + haiku*) + # PIC is the default for Haiku. + # The "-static" flag exists, but is broken. + _LT_TAGVAR(lt_prog_compiler_static, $1)= + ;; + interix[[3-9]]*) + # Interix 3.x gcc -fpic/-fPIC options generate broken code. + # Instead, we relocate shared libraries at runtime. + ;; + sysv4*MP*) + if test -d /usr/nec; then + _LT_TAGVAR(lt_prog_compiler_pic, $1)=-Kconform_pic + fi + ;; + hpux*) + # PIC is the default for 64-bit PA HP-UX, but not for 32-bit + # PA HP-UX. On IA64 HP-UX, PIC is the default but the pic flag + # sets the default TLS model and affects inlining. + case $host_cpu in + hppa*64*) + ;; + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + esac + ;; + *qnx* | *nto*) + # QNX uses GNU C++, but need to define -shared option too, otherwise + # it will coredump. + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC -shared' + ;; + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + esac + else + case $host_os in + aix[[4-9]]*) + # All AIX code is PIC. + if test "$host_cpu" = ia64; then + # AIX 5 now supports IA64 processor + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + else + _LT_TAGVAR(lt_prog_compiler_static, $1)='-bnso -bI:/lib/syscalls.exp' + fi + ;; + chorus*) + case $cc_basename in + cxch68*) + # Green Hills C++ Compiler + # _LT_TAGVAR(lt_prog_compiler_static, $1)="--no_auto_instantiation -u __main -u __premain -u _abort -r $COOL_DIR/lib/libOrb.a $MVME_DIR/lib/CC/libC.a $MVME_DIR/lib/classix/libcx.s.a" + ;; + esac + ;; + mingw* | cygwin* | os2* | pw32* | cegcc*) + # This hack is so that the source file can tell whether it is being + # built for inclusion in a dll (and should export symbols for example). + m4_if([$1], [GCJ], [], + [_LT_TAGVAR(lt_prog_compiler_pic, $1)='-DDLL_EXPORT']) + ;; + dgux*) + case $cc_basename in + ec++*) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + ;; + ghcx*) + # Green Hills C++ Compiler + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-pic' + ;; + *) + ;; + esac + ;; + freebsd* | dragonfly*) + # FreeBSD uses GNU C++ + ;; + hpux9* | hpux10* | hpux11*) + case $cc_basename in + CC*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_static, $1)='${wl}-a ${wl}archive' + if test "$host_cpu" != ia64; then + _LT_TAGVAR(lt_prog_compiler_pic, $1)='+Z' + fi + ;; + aCC*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_static, $1)='${wl}-a ${wl}archive' + case $host_cpu in + hppa*64*|ia64*) + # +Z the default + ;; + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='+Z' + ;; + esac + ;; + *) + ;; + esac + ;; + interix*) + # This is c89, which is MS Visual C++ (no shared libs) + # Anyone wants to do a port? + ;; + irix5* | irix6* | nonstopux*) + case $cc_basename in + CC*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + # CC pic flag -KPIC is the default. + ;; + *) + ;; + esac + ;; + linux* | k*bsd*-gnu | kopensolaris*-gnu) + case $cc_basename in + KCC*) + # KAI C++ Compiler + _LT_TAGVAR(lt_prog_compiler_wl, $1)='--backend -Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + ecpc* ) + # old Intel C++ for x86_64 which still supported -KPIC. + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + ;; + icpc* ) + # Intel C++, used to be incompatible with GCC. + # ICC 10 doesn't accept -KPIC any more. + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + ;; + pgCC* | pgcpp*) + # Portland Group C++ compiler + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fpic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + cxx*) + # Compaq C++ + # Make sure the PIC flag is empty. It appears that all Alpha + # Linux and Compaq Tru64 Unix objects are PIC. + _LT_TAGVAR(lt_prog_compiler_pic, $1)= + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + ;; + xlc* | xlC* | bgxl[[cC]]* | mpixl[[cC]]*) + # IBM XL 8.0, 9.0 on PPC and BlueGene + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-qpic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-qstaticlink' + ;; + *) + case `$CC -V 2>&1 | sed 5q` in + *Sun\ C*) + # Sun C++ 5.9 + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Qoption ld ' + ;; + esac + ;; + esac + ;; + lynxos*) + ;; + m88k*) + ;; + mvs*) + case $cc_basename in + cxx*) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-W c,exportall' + ;; + *) + ;; + esac + ;; + netbsd*) + ;; + *qnx* | *nto*) + # QNX uses GNU C++, but need to define -shared option too, otherwise + # it will coredump. + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC -shared' + ;; + osf3* | osf4* | osf5*) + case $cc_basename in + KCC*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='--backend -Wl,' + ;; + RCC*) + # Rational C++ 2.4.1 + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-pic' + ;; + cxx*) + # Digital/Compaq C++ + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + # Make sure the PIC flag is empty. It appears that all Alpha + # Linux and Compaq Tru64 Unix objects are PIC. + _LT_TAGVAR(lt_prog_compiler_pic, $1)= + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + ;; + *) + ;; + esac + ;; + psos*) + ;; + solaris*) + case $cc_basename in + CC* | sunCC*) + # Sun C++ 4.2, 5.x and Centerline C++ + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Qoption ld ' + ;; + gcx*) + # Green Hills C++ Compiler + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-PIC' + ;; + *) + ;; + esac + ;; + sunos4*) + case $cc_basename in + CC*) + # Sun C++ 4.x + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-pic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + lcc*) + # Lucid + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-pic' + ;; + *) + ;; + esac + ;; + sysv5* | unixware* | sco3.2v5* | sco5v6* | OpenUNIX*) + case $cc_basename in + CC*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + esac + ;; + tandem*) + case $cc_basename in + NCC*) + # NonStop-UX NCC 3.20 + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + ;; + *) + ;; + esac + ;; + vxworks*) + ;; + *) + _LT_TAGVAR(lt_prog_compiler_can_build_shared, $1)=no + ;; + esac + fi +], +[ + if test "$GCC" = yes; then + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + + case $host_os in + aix*) + # All AIX code is PIC. + if test "$host_cpu" = ia64; then + # AIX 5 now supports IA64 processor + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + fi + ;; + + amigaos*) + case $host_cpu in + powerpc) + # see comment about AmigaOS4 .so support + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + m68k) + # FIXME: we need at least 68020 code to build shared libraries, but + # adding the `-m68020' flag to GCC prevents building anything better, + # like `-m68040'. + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-m68020 -resident32 -malways-restore-a4' + ;; + esac + ;; + + beos* | irix5* | irix6* | nonstopux* | osf3* | osf4* | osf5*) + # PIC is the default for these OSes. + ;; + + mingw* | cygwin* | pw32* | os2* | cegcc*) + # This hack is so that the source file can tell whether it is being + # built for inclusion in a dll (and should export symbols for example). + # Although the cygwin gcc ignores -fPIC, still need this for old-style + # (--disable-auto-import) libraries + m4_if([$1], [GCJ], [], + [_LT_TAGVAR(lt_prog_compiler_pic, $1)='-DDLL_EXPORT']) + ;; + + darwin* | rhapsody*) + # PIC is the default on this platform + # Common symbols not allowed in MH_DYLIB files + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fno-common' + ;; + + haiku*) + # PIC is the default for Haiku. + # The "-static" flag exists, but is broken. + _LT_TAGVAR(lt_prog_compiler_static, $1)= + ;; + + hpux*) + # PIC is the default for 64-bit PA HP-UX, but not for 32-bit + # PA HP-UX. On IA64 HP-UX, PIC is the default but the pic flag + # sets the default TLS model and affects inlining. + case $host_cpu in + hppa*64*) + # +Z the default + ;; + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + esac + ;; + + interix[[3-9]]*) + # Interix 3.x gcc -fpic/-fPIC options generate broken code. + # Instead, we relocate shared libraries at runtime. + ;; + + msdosdjgpp*) + # Just because we use GCC doesn't mean we suddenly get shared libraries + # on systems that don't support them. + _LT_TAGVAR(lt_prog_compiler_can_build_shared, $1)=no + enable_shared=no + ;; + + *nto* | *qnx*) + # QNX uses GNU C++, but need to define -shared option too, otherwise + # it will coredump. + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC -shared' + ;; + + sysv4*MP*) + if test -d /usr/nec; then + _LT_TAGVAR(lt_prog_compiler_pic, $1)=-Kconform_pic + fi + ;; + + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + ;; + esac + + case $cc_basename in + nvcc*) # Cuda Compiler Driver 2.2 + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Xlinker ' + if test -n "$_LT_TAGVAR(lt_prog_compiler_pic, $1)"; then + _LT_TAGVAR(lt_prog_compiler_pic, $1)="-Xcompiler $_LT_TAGVAR(lt_prog_compiler_pic, $1)" + fi + ;; + esac + else + # PORTME Check for flag to pass linker flags through the system compiler. + case $host_os in + aix*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + if test "$host_cpu" = ia64; then + # AIX 5 now supports IA64 processor + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + else + _LT_TAGVAR(lt_prog_compiler_static, $1)='-bnso -bI:/lib/syscalls.exp' + fi + ;; + + mingw* | cygwin* | pw32* | os2* | cegcc*) + # This hack is so that the source file can tell whether it is being + # built for inclusion in a dll (and should export symbols for example). + m4_if([$1], [GCJ], [], + [_LT_TAGVAR(lt_prog_compiler_pic, $1)='-DDLL_EXPORT']) + ;; + + hpux9* | hpux10* | hpux11*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + # PIC is the default for IA64 HP-UX and 64-bit HP-UX, but + # not for PA HP-UX. + case $host_cpu in + hppa*64*|ia64*) + # +Z the default + ;; + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='+Z' + ;; + esac + # Is there a better lt_prog_compiler_static that works with the bundled CC? + _LT_TAGVAR(lt_prog_compiler_static, $1)='${wl}-a ${wl}archive' + ;; + + irix5* | irix6* | nonstopux*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + # PIC (with -KPIC) is the default. + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + ;; + + linux* | k*bsd*-gnu | kopensolaris*-gnu) + case $cc_basename in + # old Intel for x86_64 which still supported -KPIC. + ecc*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + ;; + # icc used to be incompatible with GCC. + # ICC 10 doesn't accept -KPIC any more. + icc* | ifort*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + ;; + # Lahey Fortran 8.1. + lf95*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='--shared' + _LT_TAGVAR(lt_prog_compiler_static, $1)='--static' + ;; + nagfor*) + # NAG Fortran compiler + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,-Wl,,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-PIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + pgcc* | pgf77* | pgf90* | pgf95* | pgfortran*) + # Portland Group compilers (*not* the Pentium gcc compiler, + # which looks to be a dead project) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fpic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + ccc*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + # All Alpha code is PIC. + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + ;; + xl* | bgxl* | bgf* | mpixl*) + # IBM XL C 8.0/Fortran 10.1, 11.1 on PPC and BlueGene + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-qpic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-qstaticlink' + ;; + *) + case `$CC -V 2>&1 | sed 5q` in + *Sun\ Ceres\ Fortran* | *Sun*Fortran*\ [[1-7]].* | *Sun*Fortran*\ 8.[[0-3]]*) + # Sun Fortran 8.3 passes all unrecognized flags to the linker + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + _LT_TAGVAR(lt_prog_compiler_wl, $1)='' + ;; + *Sun\ F* | *Sun*Fortran*) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Qoption ld ' + ;; + *Sun\ C*) + # Sun C 5.9 + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + ;; + *Intel*\ [[CF]]*Compiler*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-static' + ;; + *Portland\ Group*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fpic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + esac + ;; + esac + ;; + + newsos6) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + + *nto* | *qnx*) + # QNX uses GNU C++, but need to define -shared option too, otherwise + # it will coredump. + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-fPIC -shared' + ;; + + osf3* | osf4* | osf5*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + # All OSF/1 code is PIC. + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + ;; + + rdos*) + _LT_TAGVAR(lt_prog_compiler_static, $1)='-non_shared' + ;; + + solaris*) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + case $cc_basename in + f77* | f90* | f95* | sunf77* | sunf90* | sunf95*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Qoption ld ';; + *) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,';; + esac + ;; + + sunos4*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Qoption ld ' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-PIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + + sysv4 | sysv4.2uw2* | sysv4.3*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + + sysv4*MP*) + if test -d /usr/nec ;then + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-Kconform_pic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + fi + ;; + + sysv5* | unixware* | sco3.2v5* | sco5v6* | OpenUNIX*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-KPIC' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + + unicos*) + _LT_TAGVAR(lt_prog_compiler_wl, $1)='-Wl,' + _LT_TAGVAR(lt_prog_compiler_can_build_shared, $1)=no + ;; + + uts4*) + _LT_TAGVAR(lt_prog_compiler_pic, $1)='-pic' + _LT_TAGVAR(lt_prog_compiler_static, $1)='-Bstatic' + ;; + + *) + _LT_TAGVAR(lt_prog_compiler_can_build_shared, $1)=no + ;; + esac + fi +]) +case $host_os in + # For platforms which do not support PIC, -DPIC is meaningless: + *djgpp*) + _LT_TAGVAR(lt_prog_compiler_pic, $1)= + ;; + *) + _LT_TAGVAR(lt_prog_compiler_pic, $1)="$_LT_TAGVAR(lt_prog_compiler_pic, $1)@&t@m4_if([$1],[],[ -DPIC],[m4_if([$1],[CXX],[ -DPIC],[])])" + ;; +esac + +AC_CACHE_CHECK([for $compiler option to produce PIC], + [_LT_TAGVAR(lt_cv_prog_compiler_pic, $1)], + [_LT_TAGVAR(lt_cv_prog_compiler_pic, $1)=$_LT_TAGVAR(lt_prog_compiler_pic, $1)]) +_LT_TAGVAR(lt_prog_compiler_pic, $1)=$_LT_TAGVAR(lt_cv_prog_compiler_pic, $1) + +# +# Check to make sure the PIC flag actually works. +# +if test -n "$_LT_TAGVAR(lt_prog_compiler_pic, $1)"; then + _LT_COMPILER_OPTION([if $compiler PIC flag $_LT_TAGVAR(lt_prog_compiler_pic, $1) works], + [_LT_TAGVAR(lt_cv_prog_compiler_pic_works, $1)], + [$_LT_TAGVAR(lt_prog_compiler_pic, $1)@&t@m4_if([$1],[],[ -DPIC],[m4_if([$1],[CXX],[ -DPIC],[])])], [], + [case $_LT_TAGVAR(lt_prog_compiler_pic, $1) in + "" | " "*) ;; + *) _LT_TAGVAR(lt_prog_compiler_pic, $1)=" $_LT_TAGVAR(lt_prog_compiler_pic, $1)" ;; + esac], + [_LT_TAGVAR(lt_prog_compiler_pic, $1)= + _LT_TAGVAR(lt_prog_compiler_can_build_shared, $1)=no]) +fi +_LT_TAGDECL([pic_flag], [lt_prog_compiler_pic], [1], + [Additional compiler flags for building library objects]) + +_LT_TAGDECL([wl], [lt_prog_compiler_wl], [1], + [How to pass a linker flag through the compiler]) +# +# Check to make sure the static flag actually works. +# +wl=$_LT_TAGVAR(lt_prog_compiler_wl, $1) eval lt_tmp_static_flag=\"$_LT_TAGVAR(lt_prog_compiler_static, $1)\" +_LT_LINKER_OPTION([if $compiler static flag $lt_tmp_static_flag works], + _LT_TAGVAR(lt_cv_prog_compiler_static_works, $1), + $lt_tmp_static_flag, + [], + [_LT_TAGVAR(lt_prog_compiler_static, $1)=]) +_LT_TAGDECL([link_static_flag], [lt_prog_compiler_static], [1], + [Compiler flag to prevent dynamic linking]) +])# _LT_COMPILER_PIC + + +# _LT_LINKER_SHLIBS([TAGNAME]) +# ---------------------------- +# See if the linker supports building shared libraries. +m4_defun([_LT_LINKER_SHLIBS], +[AC_REQUIRE([LT_PATH_LD])dnl +AC_REQUIRE([LT_PATH_NM])dnl +m4_require([_LT_PATH_MANIFEST_TOOL])dnl +m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_DECL_EGREP])dnl +m4_require([_LT_DECL_SED])dnl +m4_require([_LT_CMD_GLOBAL_SYMBOLS])dnl +m4_require([_LT_TAG_COMPILER])dnl +AC_MSG_CHECKING([whether the $compiler linker ($LD) supports shared libraries]) +m4_if([$1], [CXX], [ + _LT_TAGVAR(export_symbols_cmds, $1)='$NM $libobjs $convenience | $global_symbol_pipe | $SED '\''s/.* //'\'' | sort | uniq > $export_symbols' + _LT_TAGVAR(exclude_expsyms, $1)=['_GLOBAL_OFFSET_TABLE_|_GLOBAL__F[ID]_.*'] + case $host_os in + aix[[4-9]]*) + # If we're using GNU nm, then we don't want the "-C" option. + # -C means demangle to AIX nm, but means don't demangle with GNU nm + # Also, AIX nm treats weak defined symbols like other global defined + # symbols, whereas GNU nm marks them as "W". + if $NM -V 2>&1 | $GREP 'GNU' > /dev/null; then + _LT_TAGVAR(export_symbols_cmds, $1)='$NM -Bpg $libobjs $convenience | awk '\''{ if (((\$ 2 == "T") || (\$ 2 == "D") || (\$ 2 == "B") || (\$ 2 == "W")) && ([substr](\$ 3,1,1) != ".")) { print \$ 3 } }'\'' | sort -u > $export_symbols' + else + _LT_TAGVAR(export_symbols_cmds, $1)='$NM -BCpg $libobjs $convenience | awk '\''{ if (((\$ 2 == "T") || (\$ 2 == "D") || (\$ 2 == "B")) && ([substr](\$ 3,1,1) != ".")) { print \$ 3 } }'\'' | sort -u > $export_symbols' + fi + ;; + pw32*) + _LT_TAGVAR(export_symbols_cmds, $1)="$ltdll_cmds" + ;; + cygwin* | mingw* | cegcc*) + case $cc_basename in + cl*) + _LT_TAGVAR(exclude_expsyms, $1)='_NULL_IMPORT_DESCRIPTOR|_IMPORT_DESCRIPTOR_.*' + ;; + *) + _LT_TAGVAR(export_symbols_cmds, $1)='$NM $libobjs $convenience | $global_symbol_pipe | $SED -e '\''/^[[BCDGRS]][[ ]]/s/.*[[ ]]\([[^ ]]*\)/\1 DATA/;s/^.*[[ ]]__nm__\([[^ ]]*\)[[ ]][[^ ]]*/\1 DATA/;/^I[[ ]]/d;/^[[AITW]][[ ]]/s/.* //'\'' | sort | uniq > $export_symbols' + _LT_TAGVAR(exclude_expsyms, $1)=['[_]+GLOBAL_OFFSET_TABLE_|[_]+GLOBAL__[FID]_.*|[_]+head_[A-Za-z0-9_]+_dll|[A-Za-z0-9_]+_dll_iname'] + ;; + esac + ;; + *) + _LT_TAGVAR(export_symbols_cmds, $1)='$NM $libobjs $convenience | $global_symbol_pipe | $SED '\''s/.* //'\'' | sort | uniq > $export_symbols' + ;; + esac +], [ + runpath_var= + _LT_TAGVAR(allow_undefined_flag, $1)= + _LT_TAGVAR(always_export_symbols, $1)=no + _LT_TAGVAR(archive_cmds, $1)= + _LT_TAGVAR(archive_expsym_cmds, $1)= + _LT_TAGVAR(compiler_needs_object, $1)=no + _LT_TAGVAR(enable_shared_with_static_runtimes, $1)=no + _LT_TAGVAR(export_dynamic_flag_spec, $1)= + _LT_TAGVAR(export_symbols_cmds, $1)='$NM $libobjs $convenience | $global_symbol_pipe | $SED '\''s/.* //'\'' | sort | uniq > $export_symbols' + _LT_TAGVAR(hardcode_automatic, $1)=no + _LT_TAGVAR(hardcode_direct, $1)=no + _LT_TAGVAR(hardcode_direct_absolute, $1)=no + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)= + _LT_TAGVAR(hardcode_libdir_separator, $1)= + _LT_TAGVAR(hardcode_minus_L, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=unsupported + _LT_TAGVAR(inherit_rpath, $1)=no + _LT_TAGVAR(link_all_deplibs, $1)=unknown + _LT_TAGVAR(module_cmds, $1)= + _LT_TAGVAR(module_expsym_cmds, $1)= + _LT_TAGVAR(old_archive_from_new_cmds, $1)= + _LT_TAGVAR(old_archive_from_expsyms_cmds, $1)= + _LT_TAGVAR(thread_safe_flag_spec, $1)= + _LT_TAGVAR(whole_archive_flag_spec, $1)= + # include_expsyms should be a list of space-separated symbols to be *always* + # included in the symbol list + _LT_TAGVAR(include_expsyms, $1)= + # exclude_expsyms can be an extended regexp of symbols to exclude + # it will be wrapped by ` (' and `)$', so one must not match beginning or + # end of line. Example: `a|bc|.*d.*' will exclude the symbols `a' and `bc', + # as well as any symbol that contains `d'. + _LT_TAGVAR(exclude_expsyms, $1)=['_GLOBAL_OFFSET_TABLE_|_GLOBAL__F[ID]_.*'] + # Although _GLOBAL_OFFSET_TABLE_ is a valid symbol C name, most a.out + # platforms (ab)use it in PIC code, but their linkers get confused if + # the symbol is explicitly referenced. Since portable code cannot + # rely on this symbol name, it's probably fine to never include it in + # preloaded symbol tables. + # Exclude shared library initialization/finalization symbols. +dnl Note also adjust exclude_expsyms for C++ above. + extract_expsyms_cmds= + + case $host_os in + cygwin* | mingw* | pw32* | cegcc*) + # FIXME: the MSVC++ port hasn't been tested in a loooong time + # When not using gcc, we currently assume that we are using + # Microsoft Visual C++. + if test "$GCC" != yes; then + with_gnu_ld=no + fi + ;; + interix*) + # we just hope/assume this is gcc and not c89 (= MSVC++) + with_gnu_ld=yes + ;; + openbsd*) + with_gnu_ld=no + ;; + esac + + _LT_TAGVAR(ld_shlibs, $1)=yes + + # On some targets, GNU ld is compatible enough with the native linker + # that we're better off using the native interface for both. + lt_use_gnu_ld_interface=no + if test "$with_gnu_ld" = yes; then + case $host_os in + aix*) + # The AIX port of GNU ld has always aspired to compatibility + # with the native linker. However, as the warning in the GNU ld + # block says, versions before 2.19.5* couldn't really create working + # shared libraries, regardless of the interface used. + case `$LD -v 2>&1` in + *\ \(GNU\ Binutils\)\ 2.19.5*) ;; + *\ \(GNU\ Binutils\)\ 2.[[2-9]]*) ;; + *\ \(GNU\ Binutils\)\ [[3-9]]*) ;; + *) + lt_use_gnu_ld_interface=yes + ;; + esac + ;; + *) + lt_use_gnu_ld_interface=yes + ;; + esac + fi + + if test "$lt_use_gnu_ld_interface" = yes; then + # If archive_cmds runs LD, not CC, wlarc should be empty + wlarc='${wl}' + + # Set some defaults for GNU ld with shared library support. These + # are reset later if shared libraries are not supported. Putting them + # here allows them to be overridden if necessary. + runpath_var=LD_RUN_PATH + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-dynamic' + # ancient GNU ld didn't support --whole-archive et. al. + if $LD --help 2>&1 | $GREP 'no-whole-archive' > /dev/null; then + _LT_TAGVAR(whole_archive_flag_spec, $1)="$wlarc"'--whole-archive$convenience '"$wlarc"'--no-whole-archive' + else + _LT_TAGVAR(whole_archive_flag_spec, $1)= + fi + supports_anon_versioning=no + case `$LD -v 2>&1` in + *GNU\ gold*) supports_anon_versioning=yes ;; + *\ [[01]].* | *\ 2.[[0-9]].* | *\ 2.10.*) ;; # catch versions < 2.11 + *\ 2.11.93.0.2\ *) supports_anon_versioning=yes ;; # RH7.3 ... + *\ 2.11.92.0.12\ *) supports_anon_versioning=yes ;; # Mandrake 8.2 ... + *\ 2.11.*) ;; # other 2.11 versions + *) supports_anon_versioning=yes ;; + esac + + # See if GNU ld supports shared libraries. + case $host_os in + aix[[3-9]]*) + # On AIX/PPC, the GNU linker is very broken + if test "$host_cpu" != ia64; then + _LT_TAGVAR(ld_shlibs, $1)=no + cat <<_LT_EOF 1>&2 + +*** Warning: the GNU linker, at least up to release 2.19, is reported +*** to be unable to reliably create shared libraries on AIX. +*** Therefore, libtool is disabling shared libraries support. If you +*** really care for shared libraries, you may want to install binutils +*** 2.20 or above, or modify your PATH so that a non-GNU linker is found. +*** You will then need to restart the configuration process. + +_LT_EOF + fi + ;; + + amigaos*) + case $host_cpu in + powerpc) + # see comment about AmigaOS4 .so support + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='' + ;; + m68k) + _LT_TAGVAR(archive_cmds, $1)='$RM $output_objdir/a2ixlibrary.data~$ECHO "#define NAME $libname" > $output_objdir/a2ixlibrary.data~$ECHO "#define LIBRARY_ID 1" >> $output_objdir/a2ixlibrary.data~$ECHO "#define VERSION $major" >> $output_objdir/a2ixlibrary.data~$ECHO "#define REVISION $revision" >> $output_objdir/a2ixlibrary.data~$AR $AR_FLAGS $lib $libobjs~$RANLIB $lib~(cd $output_objdir && a2ixlibrary -32)' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_minus_L, $1)=yes + ;; + esac + ;; + + beos*) + if $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + # Joseph Beckenbach says some releases of gcc + # support --undefined. This deserves some investigation. FIXME + _LT_TAGVAR(archive_cmds, $1)='$CC -nostart $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + cygwin* | mingw* | pw32* | cegcc*) + # _LT_TAGVAR(hardcode_libdir_flag_spec, $1) is actually meaningless, + # as there is no search path for DLLs. + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-all-symbols' + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + _LT_TAGVAR(always_export_symbols, $1)=no + _LT_TAGVAR(enable_shared_with_static_runtimes, $1)=yes + _LT_TAGVAR(export_symbols_cmds, $1)='$NM $libobjs $convenience | $global_symbol_pipe | $SED -e '\''/^[[BCDGRS]][[ ]]/s/.*[[ ]]\([[^ ]]*\)/\1 DATA/;s/^.*[[ ]]__nm__\([[^ ]]*\)[[ ]][[^ ]]*/\1 DATA/;/^I[[ ]]/d;/^[[AITW]][[ ]]/s/.* //'\'' | sort | uniq > $export_symbols' + _LT_TAGVAR(exclude_expsyms, $1)=['[_]+GLOBAL_OFFSET_TABLE_|[_]+GLOBAL__[FID]_.*|[_]+head_[A-Za-z0-9_]+_dll|[A-Za-z0-9_]+_dll_iname'] + + if $LD --help 2>&1 | $GREP 'auto-import' > /dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags -o $output_objdir/$soname ${wl}--enable-auto-image-base -Xlinker --out-implib -Xlinker $lib' + # If the export-symbols file already is a .def file (1st line + # is EXPORTS), use it as is; otherwise, prepend... + _LT_TAGVAR(archive_expsym_cmds, $1)='if test "x`$SED 1q $export_symbols`" = xEXPORTS; then + cp $export_symbols $output_objdir/$soname.def; + else + echo EXPORTS > $output_objdir/$soname.def; + cat $export_symbols >> $output_objdir/$soname.def; + fi~ + $CC -shared $output_objdir/$soname.def $libobjs $deplibs $compiler_flags -o $output_objdir/$soname ${wl}--enable-auto-image-base -Xlinker --out-implib -Xlinker $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + haiku*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(link_all_deplibs, $1)=yes + ;; + + interix[[3-9]]*) + _LT_TAGVAR(hardcode_direct, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + # Hack: On Interix 3.x, we cannot compile PIC because of a broken gcc. + # Instead, shared libraries are loaded at an image base (0x10000000 by + # default) and relocated if they conflict, which is a slow very memory + # consuming and fragmenting process. To avoid this, we pick a random, + # 256 KiB-aligned image base between 0x50000000 and 0x6FFC0000 at link + # time. Moving up from 0x10000000 also allows more sbrk(2) space. + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-h,$soname ${wl}--image-base,`expr ${RANDOM-$$} % 4096 / 2 \* 262144 + 1342177280` -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='sed "s,^,_," $export_symbols >$output_objdir/$soname.expsym~$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-h,$soname ${wl}--retain-symbols-file,$output_objdir/$soname.expsym ${wl}--image-base,`expr ${RANDOM-$$} % 4096 / 2 \* 262144 + 1342177280` -o $lib' + ;; + + gnu* | linux* | tpf* | k*bsd*-gnu | kopensolaris*-gnu) + tmp_diet=no + if test "$host_os" = linux-dietlibc; then + case $cc_basename in + diet\ *) tmp_diet=yes;; # linux-dietlibc with static linking (!diet-dyn) + esac + fi + if $LD --help 2>&1 | $EGREP ': supported targets:.* elf' > /dev/null \ + && test "$tmp_diet" = no + then + tmp_addflag=' $pic_flag' + tmp_sharedflag='-shared' + case $cc_basename,$host_cpu in + pgcc*) # Portland Group C compiler + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + tmp_addflag=' $pic_flag' + ;; + pgf77* | pgf90* | pgf95* | pgfortran*) + # Portland Group f77 and f90 compilers + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + tmp_addflag=' $pic_flag -Mnomain' ;; + ecc*,ia64* | icc*,ia64*) # Intel C compiler on ia64 + tmp_addflag=' -i_dynamic' ;; + efc*,ia64* | ifort*,ia64*) # Intel Fortran compiler on ia64 + tmp_addflag=' -i_dynamic -nofor_main' ;; + ifc* | ifort*) # Intel Fortran compiler + tmp_addflag=' -nofor_main' ;; + lf95*) # Lahey Fortran 8.1 + _LT_TAGVAR(whole_archive_flag_spec, $1)= + tmp_sharedflag='--shared' ;; + xl[[cC]]* | bgxl[[cC]]* | mpixl[[cC]]*) # IBM XL C 8.0 on PPC (deal with xlf below) + tmp_sharedflag='-qmkshrobj' + tmp_addflag= ;; + nvcc*) # Cuda Compiler Driver 2.2 + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + _LT_TAGVAR(compiler_needs_object, $1)=yes + ;; + esac + case `$CC -V 2>&1 | sed 5q` in + *Sun\ C*) # Sun C 5.9 + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive`new_convenience=; for conv in $convenience\"\"; do test -z \"$conv\" || new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + _LT_TAGVAR(compiler_needs_object, $1)=yes + tmp_sharedflag='-G' ;; + *Sun\ F*) # Sun Fortran 8.3 + tmp_sharedflag='-G' ;; + esac + _LT_TAGVAR(archive_cmds, $1)='$CC '"$tmp_sharedflag""$tmp_addflag"' $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + + if test "x$supports_anon_versioning" = xyes; then + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $output_objdir/$libname.ver~ + cat $export_symbols | sed -e "s/\(.*\)/\1;/" >> $output_objdir/$libname.ver~ + echo "local: *; };" >> $output_objdir/$libname.ver~ + $CC '"$tmp_sharedflag""$tmp_addflag"' $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-version-script ${wl}$output_objdir/$libname.ver -o $lib' + fi + + case $cc_basename in + xlf* | bgf* | bgxlf* | mpixlf*) + # IBM XL Fortran 10.1 on PPC cannot create shared libs itself + _LT_TAGVAR(whole_archive_flag_spec, $1)='--whole-archive$convenience --no-whole-archive' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(archive_cmds, $1)='$LD -shared $libobjs $deplibs $linker_flags -soname $soname -o $lib' + if test "x$supports_anon_versioning" = xyes; then + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $output_objdir/$libname.ver~ + cat $export_symbols | sed -e "s/\(.*\)/\1;/" >> $output_objdir/$libname.ver~ + echo "local: *; };" >> $output_objdir/$libname.ver~ + $LD -shared $libobjs $deplibs $linker_flags -soname $soname -version-script $output_objdir/$libname.ver -o $lib' + fi + ;; + esac + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + netbsd*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ >/dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$LD -Bshareable $libobjs $deplibs $linker_flags -o $lib' + wlarc= + else + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + fi + ;; + + solaris*) + if $LD -v 2>&1 | $GREP 'BFD 2\.8' > /dev/null; then + _LT_TAGVAR(ld_shlibs, $1)=no + cat <<_LT_EOF 1>&2 + +*** Warning: The releases 2.8.* of the GNU linker cannot reliably +*** create shared libraries on Solaris systems. Therefore, libtool +*** is disabling shared libraries support. We urge you to upgrade GNU +*** binutils to release 2.9.1 or newer. Another option is to modify +*** your PATH or compiler configuration so that the native linker is +*** used, and then restart. + +_LT_EOF + elif $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + sysv5* | sco3.2v5* | sco5v6* | unixware* | OpenUNIX*) + case `$LD -v 2>&1` in + *\ [[01]].* | *\ 2.[[0-9]].* | *\ 2.1[[0-5]].*) + _LT_TAGVAR(ld_shlibs, $1)=no + cat <<_LT_EOF 1>&2 + +*** Warning: Releases of the GNU linker prior to 2.16.91.0.3 can not +*** reliably create shared libraries on SCO systems. Therefore, libtool +*** is disabling shared libraries support. We urge you to upgrade GNU +*** binutils to release 2.16.91.0.3 or newer. Another option is to modify +*** your PATH or compiler configuration so that the native linker is +*** used, and then restart. + +_LT_EOF + ;; + *) + # For security reasons, it is highly recommended that you always + # use absolute paths for naming shared libraries, and exclude the + # DT_RUNPATH tag from executables and libraries. But doing so + # requires that you compile everything twice, which is a pain. + if $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + esac + ;; + + sunos4*) + _LT_TAGVAR(archive_cmds, $1)='$LD -assert pure-text -Bshareable -o $lib $libobjs $deplibs $linker_flags' + wlarc= + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + *) + if $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + esac + + if test "$_LT_TAGVAR(ld_shlibs, $1)" = no; then + runpath_var= + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)= + _LT_TAGVAR(export_dynamic_flag_spec, $1)= + _LT_TAGVAR(whole_archive_flag_spec, $1)= + fi + else + # PORTME fill in a description of your system's linker (not GNU ld) + case $host_os in + aix3*) + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + _LT_TAGVAR(always_export_symbols, $1)=yes + _LT_TAGVAR(archive_expsym_cmds, $1)='$LD -o $output_objdir/$soname $libobjs $deplibs $linker_flags -bE:$export_symbols -T512 -H512 -bM:SRE~$AR $AR_FLAGS $lib $output_objdir/$soname' + # Note: this linker hardcodes the directories in LIBPATH if there + # are no directories specified by -L. + _LT_TAGVAR(hardcode_minus_L, $1)=yes + if test "$GCC" = yes && test -z "$lt_prog_compiler_static"; then + # Neither direct hardcoding nor static linking is supported with a + # broken collect2. + _LT_TAGVAR(hardcode_direct, $1)=unsupported + fi + ;; + + aix[[4-9]]*) + if test "$host_cpu" = ia64; then + # On IA64, the linker does run time linking by default, so we don't + # have to do anything special. + aix_use_runtimelinking=no + exp_sym_flag='-Bexport' + no_entry_flag="" + else + # If we're using GNU nm, then we don't want the "-C" option. + # -C means demangle to AIX nm, but means don't demangle with GNU nm + # Also, AIX nm treats weak defined symbols like other global + # defined symbols, whereas GNU nm marks them as "W". + if $NM -V 2>&1 | $GREP 'GNU' > /dev/null; then + _LT_TAGVAR(export_symbols_cmds, $1)='$NM -Bpg $libobjs $convenience | awk '\''{ if (((\$ 2 == "T") || (\$ 2 == "D") || (\$ 2 == "B") || (\$ 2 == "W")) && ([substr](\$ 3,1,1) != ".")) { print \$ 3 } }'\'' | sort -u > $export_symbols' + else + _LT_TAGVAR(export_symbols_cmds, $1)='$NM -BCpg $libobjs $convenience | awk '\''{ if (((\$ 2 == "T") || (\$ 2 == "D") || (\$ 2 == "B")) && ([substr](\$ 3,1,1) != ".")) { print \$ 3 } }'\'' | sort -u > $export_symbols' + fi + aix_use_runtimelinking=no + + # Test if we are trying to use run time linking or normal + # AIX style linking. If -brtl is somewhere in LDFLAGS, we + # need to do runtime linking. + case $host_os in aix4.[[23]]|aix4.[[23]].*|aix[[5-9]]*) + for ld_flag in $LDFLAGS; do + if (test $ld_flag = "-brtl" || test $ld_flag = "-Wl,-brtl"); then + aix_use_runtimelinking=yes + break + fi + done + ;; + esac + + exp_sym_flag='-bexport' + no_entry_flag='-bnoentry' + fi + + # When large executables or shared objects are built, AIX ld can + # have problems creating the table of contents. If linking a library + # or program results in "error TOC overflow" add -mminimal-toc to + # CXXFLAGS/CFLAGS for g++/gcc. In the cases where that is not + # enough to fix the problem, add -Wl,-bbigtoc to LDFLAGS. + + _LT_TAGVAR(archive_cmds, $1)='' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + _LT_TAGVAR(hardcode_libdir_separator, $1)=':' + _LT_TAGVAR(link_all_deplibs, $1)=yes + _LT_TAGVAR(file_list_spec, $1)='${wl}-f,' + + if test "$GCC" = yes; then + case $host_os in aix4.[[012]]|aix4.[[012]].*) + # We only want to do this on AIX 4.2 and lower, the check + # below for broken collect2 doesn't work under 4.3+ + collect2name=`${CC} -print-prog-name=collect2` + if test -f "$collect2name" && + strings "$collect2name" | $GREP resolve_lib_name >/dev/null + then + # We have reworked collect2 + : + else + # We have old collect2 + _LT_TAGVAR(hardcode_direct, $1)=unsupported + # It fails to find uninstalled libraries when the uninstalled + # path is not listed in the libpath. Setting hardcode_minus_L + # to unsupported forces relinking + _LT_TAGVAR(hardcode_minus_L, $1)=yes + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)= + fi + ;; + esac + shared_flag='-shared' + if test "$aix_use_runtimelinking" = yes; then + shared_flag="$shared_flag "'${wl}-G' + fi + else + # not using gcc + if test "$host_cpu" = ia64; then + # VisualAge C++, Version 5.5 for AIX 5L for IA-64, Beta 3 Release + # chokes on -Wl,-G. The following line is correct: + shared_flag='-G' + else + if test "$aix_use_runtimelinking" = yes; then + shared_flag='${wl}-G' + else + shared_flag='${wl}-bM:SRE' + fi + fi + fi + + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-bexpall' + # It seems that -bexpall does not export symbols beginning with + # underscore (_), so it is better to generate a list of symbols to export. + _LT_TAGVAR(always_export_symbols, $1)=yes + if test "$aix_use_runtimelinking" = yes; then + # Warning - without using the other runtime loading flags (-brtl), + # -berok will link without error, but may produce a broken library. + _LT_TAGVAR(allow_undefined_flag, $1)='-berok' + # Determine the default libpath from the value encoded in an + # empty executable. + _LT_SYS_MODULE_PATH_AIX([$1]) + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-blibpath:$libdir:'"$aix_libpath" + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -o $output_objdir/$soname $libobjs $deplibs '"\${wl}$no_entry_flag"' $compiler_flags `if test "x${allow_undefined_flag}" != "x"; then func_echo_all "${wl}${allow_undefined_flag}"; else :; fi` '"\${wl}$exp_sym_flag:\$export_symbols $shared_flag" + else + if test "$host_cpu" = ia64; then + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-R $libdir:/usr/lib:/lib' + _LT_TAGVAR(allow_undefined_flag, $1)="-z nodefs" + _LT_TAGVAR(archive_expsym_cmds, $1)="\$CC $shared_flag"' -o $output_objdir/$soname $libobjs $deplibs '"\${wl}$no_entry_flag"' $compiler_flags ${wl}${allow_undefined_flag} '"\${wl}$exp_sym_flag:\$export_symbols" + else + # Determine the default libpath from the value encoded in an + # empty executable. + _LT_SYS_MODULE_PATH_AIX([$1]) + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-blibpath:$libdir:'"$aix_libpath" + # Warning - without using the other run time loading flags, + # -berok will link without error, but may produce a broken library. + _LT_TAGVAR(no_undefined_flag, $1)=' ${wl}-bernotok' + _LT_TAGVAR(allow_undefined_flag, $1)=' ${wl}-berok' + if test "$with_gnu_ld" = yes; then + # We only use this code for GNU lds that support --whole-archive. + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive$convenience ${wl}--no-whole-archive' + else + # Exported symbols can be pulled into shared objects from archives + _LT_TAGVAR(whole_archive_flag_spec, $1)='$convenience' + fi + _LT_TAGVAR(archive_cmds_need_lc, $1)=yes + # This is similar to how AIX traditionally builds its shared libraries. + _LT_TAGVAR(archive_expsym_cmds, $1)="\$CC $shared_flag"' -o $output_objdir/$soname $libobjs $deplibs ${wl}-bnoentry $compiler_flags ${wl}-bE:$export_symbols${allow_undefined_flag}~$AR $AR_FLAGS $output_objdir/$libname$release.a $output_objdir/$soname' + fi + fi + ;; + + amigaos*) + case $host_cpu in + powerpc) + # see comment about AmigaOS4 .so support + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='' + ;; + m68k) + _LT_TAGVAR(archive_cmds, $1)='$RM $output_objdir/a2ixlibrary.data~$ECHO "#define NAME $libname" > $output_objdir/a2ixlibrary.data~$ECHO "#define LIBRARY_ID 1" >> $output_objdir/a2ixlibrary.data~$ECHO "#define VERSION $major" >> $output_objdir/a2ixlibrary.data~$ECHO "#define REVISION $revision" >> $output_objdir/a2ixlibrary.data~$AR $AR_FLAGS $lib $libobjs~$RANLIB $lib~(cd $output_objdir && a2ixlibrary -32)' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_minus_L, $1)=yes + ;; + esac + ;; + + bsdi[[45]]*) + _LT_TAGVAR(export_dynamic_flag_spec, $1)=-rdynamic + ;; + + cygwin* | mingw* | pw32* | cegcc*) + # When not using gcc, we currently assume that we are using + # Microsoft Visual C++. + # hardcode_libdir_flag_spec is actually meaningless, as there is + # no search path for DLLs. + case $cc_basename in + cl*) + # Native MSVC + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)=' ' + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + _LT_TAGVAR(always_export_symbols, $1)=yes + _LT_TAGVAR(file_list_spec, $1)='@' + # Tell ltmain to make .lib files, not .a files. + libext=lib + # Tell ltmain to make .dll files, not .so files. + shrext_cmds=".dll" + # FIXME: Setting linknames here is a bad hack. + _LT_TAGVAR(archive_cmds, $1)='$CC -o $output_objdir/$soname $libobjs $compiler_flags $deplibs -Wl,-dll~linknames=' + _LT_TAGVAR(archive_expsym_cmds, $1)='if test "x`$SED 1q $export_symbols`" = xEXPORTS; then + sed -n -e 's/\\\\\\\(.*\\\\\\\)/-link\\\ -EXPORT:\\\\\\\1/' -e '1\\\!p' < $export_symbols > $output_objdir/$soname.exp; + else + sed -e 's/\\\\\\\(.*\\\\\\\)/-link\\\ -EXPORT:\\\\\\\1/' < $export_symbols > $output_objdir/$soname.exp; + fi~ + $CC -o $tool_output_objdir$soname $libobjs $compiler_flags $deplibs "@$tool_output_objdir$soname.exp" -Wl,-DLL,-IMPLIB:"$tool_output_objdir$libname.dll.lib"~ + linknames=' + # The linker will not automatically build a static lib if we build a DLL. + # _LT_TAGVAR(old_archive_from_new_cmds, $1)='true' + _LT_TAGVAR(enable_shared_with_static_runtimes, $1)=yes + _LT_TAGVAR(exclude_expsyms, $1)='_NULL_IMPORT_DESCRIPTOR|_IMPORT_DESCRIPTOR_.*' + _LT_TAGVAR(export_symbols_cmds, $1)='$NM $libobjs $convenience | $global_symbol_pipe | $SED -e '\''/^[[BCDGRS]][[ ]]/s/.*[[ ]]\([[^ ]]*\)/\1,DATA/'\'' | $SED -e '\''/^[[AITW]][[ ]]/s/.*[[ ]]//'\'' | sort | uniq > $export_symbols' + # Don't use ranlib + _LT_TAGVAR(old_postinstall_cmds, $1)='chmod 644 $oldlib' + _LT_TAGVAR(postlink_cmds, $1)='lt_outputfile="@OUTPUT@"~ + lt_tool_outputfile="@TOOL_OUTPUT@"~ + case $lt_outputfile in + *.exe|*.EXE) ;; + *) + lt_outputfile="$lt_outputfile.exe" + lt_tool_outputfile="$lt_tool_outputfile.exe" + ;; + esac~ + if test "$MANIFEST_TOOL" != ":" && test -f "$lt_outputfile.manifest"; then + $MANIFEST_TOOL -manifest "$lt_tool_outputfile.manifest" -outputresource:"$lt_tool_outputfile" || exit 1; + $RM "$lt_outputfile.manifest"; + fi' + ;; + *) + # Assume MSVC wrapper + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)=' ' + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + # Tell ltmain to make .lib files, not .a files. + libext=lib + # Tell ltmain to make .dll files, not .so files. + shrext_cmds=".dll" + # FIXME: Setting linknames here is a bad hack. + _LT_TAGVAR(archive_cmds, $1)='$CC -o $lib $libobjs $compiler_flags `func_echo_all "$deplibs" | $SED '\''s/ -lc$//'\''` -link -dll~linknames=' + # The linker will automatically build a .lib file if we build a DLL. + _LT_TAGVAR(old_archive_from_new_cmds, $1)='true' + # FIXME: Should let the user specify the lib program. + _LT_TAGVAR(old_archive_cmds, $1)='lib -OUT:$oldlib$oldobjs$old_deplibs' + _LT_TAGVAR(enable_shared_with_static_runtimes, $1)=yes + ;; + esac + ;; + + darwin* | rhapsody*) + _LT_DARWIN_LINKER_FEATURES($1) + ;; + + dgux*) + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + # FreeBSD 2.2.[012] allows us to include c++rt0.o to get C++ constructor + # support. Future versions do this automatically, but an explicit c++rt0.o + # does not break anything, and helps significantly (at the cost of a little + # extra space). + freebsd2.2*) + _LT_TAGVAR(archive_cmds, $1)='$LD -Bshareable -o $lib $libobjs $deplibs $linker_flags /usr/lib/c++rt0.o' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + # Unfortunately, older versions of FreeBSD 2 do not have this feature. + freebsd2.*) + _LT_TAGVAR(archive_cmds, $1)='$LD -Bshareable -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_minus_L, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + # FreeBSD 3 and greater uses gcc -shared to do shared libraries. + freebsd* | dragonfly*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + hpux9*) + if test "$GCC" = yes; then + _LT_TAGVAR(archive_cmds, $1)='$RM $output_objdir/$soname~$CC -shared $pic_flag ${wl}+b ${wl}$install_libdir -o $output_objdir/$soname $libobjs $deplibs $compiler_flags~test $output_objdir/$soname = $lib || mv $output_objdir/$soname $lib' + else + _LT_TAGVAR(archive_cmds, $1)='$RM $output_objdir/$soname~$LD -b +b $install_libdir -o $output_objdir/$soname $libobjs $deplibs $linker_flags~test $output_objdir/$soname = $lib || mv $output_objdir/$soname $lib' + fi + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}+b ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + _LT_TAGVAR(hardcode_direct, $1)=yes + + # hardcode_minus_L: Not really in the search PATH, + # but as the default location of the library. + _LT_TAGVAR(hardcode_minus_L, $1)=yes + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + ;; + + hpux10*) + if test "$GCC" = yes && test "$with_gnu_ld" = no; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $libobjs $deplibs $compiler_flags' + else + _LT_TAGVAR(archive_cmds, $1)='$LD -b +h $soname +b $install_libdir -o $lib $libobjs $deplibs $linker_flags' + fi + if test "$with_gnu_ld" = no; then + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}+b ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + # hardcode_minus_L: Not really in the search PATH, + # but as the default location of the library. + _LT_TAGVAR(hardcode_minus_L, $1)=yes + fi + ;; + + hpux11*) + if test "$GCC" = yes && test "$with_gnu_ld" = no; then + case $host_cpu in + hppa*64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared ${wl}+h ${wl}$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + ia64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag ${wl}+h ${wl}$soname ${wl}+nodefaultrpath -o $lib $libobjs $deplibs $compiler_flags' + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $libobjs $deplibs $compiler_flags' + ;; + esac + else + case $host_cpu in + hppa*64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + ia64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname ${wl}+nodefaultrpath -o $lib $libobjs $deplibs $compiler_flags' + ;; + *) + m4_if($1, [], [ + # Older versions of the 11.00 compiler do not understand -b yet + # (HP92453-01 A.11.01.20 doesn't, HP92453-01 B.11.X.35175-35176.GP does) + _LT_LINKER_OPTION([if $CC understands -b], + _LT_TAGVAR(lt_cv_prog_compiler__b, $1), [-b], + [_LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $libobjs $deplibs $compiler_flags'], + [_LT_TAGVAR(archive_cmds, $1)='$LD -b +h $soname +b $install_libdir -o $lib $libobjs $deplibs $linker_flags'])], + [_LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $libobjs $deplibs $compiler_flags']) + ;; + esac + fi + if test "$with_gnu_ld" = no; then + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}+b ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + + case $host_cpu in + hppa*64*|ia64*) + _LT_TAGVAR(hardcode_direct, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + *) + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + + # hardcode_minus_L: Not really in the search PATH, + # but as the default location of the library. + _LT_TAGVAR(hardcode_minus_L, $1)=yes + ;; + esac + fi + ;; + + irix5* | irix6* | nonstopux*) + if test "$GCC" = yes; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + # Try to use the -exported_symbol ld option, if it does not + # work, assume that -exports_file does not work either and + # implicitly export all symbols. + # This should be the same for all languages, so no per-tag cache variable. + AC_CACHE_CHECK([whether the $host_os linker accepts -exported_symbol], + [lt_cv_irix_exported_symbol], + [save_LDFLAGS="$LDFLAGS" + LDFLAGS="$LDFLAGS -shared ${wl}-exported_symbol ${wl}foo ${wl}-update_registry ${wl}/dev/null" + AC_LINK_IFELSE( + [AC_LANG_SOURCE( + [AC_LANG_CASE([C], [[int foo (void) { return 0; }]], + [C++], [[int foo (void) { return 0; }]], + [Fortran 77], [[ + subroutine foo + end]], + [Fortran], [[ + subroutine foo + end]])])], + [lt_cv_irix_exported_symbol=yes], + [lt_cv_irix_exported_symbol=no]) + LDFLAGS="$save_LDFLAGS"]) + if test "$lt_cv_irix_exported_symbol" = yes; then + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations ${wl}-exports_file ${wl}$export_symbols -o $lib' + fi + else + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -exports_file $export_symbols -o $lib' + fi + _LT_TAGVAR(archive_cmds_need_lc, $1)='no' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + _LT_TAGVAR(inherit_rpath, $1)=yes + _LT_TAGVAR(link_all_deplibs, $1)=yes + ;; + + netbsd*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ >/dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$LD -Bshareable -o $lib $libobjs $deplibs $linker_flags' # a.out + else + _LT_TAGVAR(archive_cmds, $1)='$LD -shared -o $lib $libobjs $deplibs $linker_flags' # ELF + fi + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + newsos6) + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + *nto* | *qnx*) + ;; + + openbsd*) + if test -f /usr/libexec/ld.so; then + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + if test -z "`echo __ELF__ | $CC -E - | $GREP __ELF__`" || test "$host_os-$host_cpu" = "openbsd2.8-powerpc"; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag -o $lib $libobjs $deplibs $compiler_flags ${wl}-retain-symbols-file,$export_symbols' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + else + case $host_os in + openbsd[[01]].* | openbsd2.[[0-7]] | openbsd2.[[0-7]].*) + _LT_TAGVAR(archive_cmds, $1)='$LD -Bshareable -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + ;; + esac + fi + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + os2*) + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_minus_L, $1)=yes + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + _LT_TAGVAR(archive_cmds, $1)='$ECHO "LIBRARY $libname INITINSTANCE" > $output_objdir/$libname.def~$ECHO "DESCRIPTION \"$libname\"" >> $output_objdir/$libname.def~echo DATA >> $output_objdir/$libname.def~echo " SINGLE NONSHARED" >> $output_objdir/$libname.def~echo EXPORTS >> $output_objdir/$libname.def~emxexp $libobjs >> $output_objdir/$libname.def~$CC -Zdll -Zcrtdll -o $lib $libobjs $deplibs $compiler_flags $output_objdir/$libname.def' + _LT_TAGVAR(old_archive_from_new_cmds, $1)='emximp -o $output_objdir/$libname.a $output_objdir/$libname.def' + ;; + + osf3*) + if test "$GCC" = yes; then + _LT_TAGVAR(allow_undefined_flag, $1)=' ${wl}-expect_unresolved ${wl}\*' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared${allow_undefined_flag} $libobjs $deplibs $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + else + _LT_TAGVAR(allow_undefined_flag, $1)=' -expect_unresolved \*' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared${allow_undefined_flag} $libobjs $deplibs $compiler_flags -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + fi + _LT_TAGVAR(archive_cmds_need_lc, $1)='no' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + ;; + + osf4* | osf5*) # as osf3* with the addition of -msym flag + if test "$GCC" = yes; then + _LT_TAGVAR(allow_undefined_flag, $1)=' ${wl}-expect_unresolved ${wl}\*' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared${allow_undefined_flag} $pic_flag $libobjs $deplibs $compiler_flags ${wl}-msym ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + else + _LT_TAGVAR(allow_undefined_flag, $1)=' -expect_unresolved \*' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared${allow_undefined_flag} $libobjs $deplibs $compiler_flags -msym -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='for i in `cat $export_symbols`; do printf "%s %s\\n" -exported_symbol "\$i" >> $lib.exp; done; printf "%s\\n" "-hidden">> $lib.exp~ + $CC -shared${allow_undefined_flag} ${wl}-input ${wl}$lib.exp $compiler_flags $libobjs $deplibs -soname $soname `test -n "$verstring" && $ECHO "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib~$RM $lib.exp' + + # Both c and cxx compiler support -rpath directly + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-rpath $libdir' + fi + _LT_TAGVAR(archive_cmds_need_lc, $1)='no' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + ;; + + solaris*) + _LT_TAGVAR(no_undefined_flag, $1)=' -z defs' + if test "$GCC" = yes; then + wlarc='${wl}' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag ${wl}-z ${wl}text ${wl}-h ${wl}$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -shared $pic_flag ${wl}-z ${wl}text ${wl}-M ${wl}$lib.exp ${wl}-h ${wl}$soname -o $lib $libobjs $deplibs $compiler_flags~$RM $lib.exp' + else + case `$CC -V 2>&1` in + *"Compilers 5.0"*) + wlarc='' + _LT_TAGVAR(archive_cmds, $1)='$LD -G${allow_undefined_flag} -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $LD -G${allow_undefined_flag} -M $lib.exp -h $soname -o $lib $libobjs $deplibs $linker_flags~$RM $lib.exp' + ;; + *) + wlarc='${wl}' + _LT_TAGVAR(archive_cmds, $1)='$CC -G${allow_undefined_flag} -h $soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -G${allow_undefined_flag} -M $lib.exp -h $soname -o $lib $libobjs $deplibs $compiler_flags~$RM $lib.exp' + ;; + esac + fi + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + case $host_os in + solaris2.[[0-5]] | solaris2.[[0-5]].*) ;; + *) + # The compiler driver will combine and reorder linker options, + # but understands `-z linker_flag'. GCC discards it without `$wl', + # but is careful enough not to reorder. + # Supported since Solaris 2.6 (maybe 2.5.1?) + if test "$GCC" = yes; then + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}-z ${wl}allextract$convenience ${wl}-z ${wl}defaultextract' + else + _LT_TAGVAR(whole_archive_flag_spec, $1)='-z allextract$convenience -z defaultextract' + fi + ;; + esac + _LT_TAGVAR(link_all_deplibs, $1)=yes + ;; + + sunos4*) + if test "x$host_vendor" = xsequent; then + # Use $CC to link under sequent, because it throws in some extra .o + # files that make .init and .fini sections work. + _LT_TAGVAR(archive_cmds, $1)='$CC -G ${wl}-h $soname -o $lib $libobjs $deplibs $compiler_flags' + else + _LT_TAGVAR(archive_cmds, $1)='$LD -assert pure-text -Bstatic -o $lib $libobjs $deplibs $linker_flags' + fi + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_minus_L, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + sysv4) + case $host_vendor in + sni) + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_direct, $1)=yes # is this really true??? + ;; + siemens) + ## LD is ld it makes a PLAMLIB + ## CC just makes a GrossModule. + _LT_TAGVAR(archive_cmds, $1)='$LD -G -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(reload_cmds, $1)='$CC -r -o $output$reload_objs' + _LT_TAGVAR(hardcode_direct, $1)=no + ;; + motorola) + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_direct, $1)=no #Motorola manual says yes, but my tests say they lie + ;; + esac + runpath_var='LD_RUN_PATH' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + sysv4.3*) + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(export_dynamic_flag_spec, $1)='-Bexport' + ;; + + sysv4*MP*) + if test -d /usr/nec; then + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + runpath_var=LD_RUN_PATH + hardcode_runpath_var=yes + _LT_TAGVAR(ld_shlibs, $1)=yes + fi + ;; + + sysv4*uw2* | sysv5OpenUNIX* | sysv5UnixWare7.[[01]].[[10]]* | unixware7* | sco3.2v5.0.[[024]]*) + _LT_TAGVAR(no_undefined_flag, $1)='${wl}-z,text' + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + runpath_var='LD_RUN_PATH' + + if test "$GCC" = yes; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + else + _LT_TAGVAR(archive_cmds, $1)='$CC -G ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -G ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + fi + ;; + + sysv5* | sco3.2v5* | sco5v6*) + # Note: We can NOT use -z defs as we might desire, because we do not + # link with -lc, and that would cause any symbols used from libc to + # always be unresolved, which means just about no library would + # ever link correctly. If we're not using GNU ld we use -z text + # though, which does catch some bad symbols but isn't as heavy-handed + # as -z defs. + _LT_TAGVAR(no_undefined_flag, $1)='${wl}-z,text' + _LT_TAGVAR(allow_undefined_flag, $1)='${wl}-z,nodefs' + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-R,$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=':' + _LT_TAGVAR(link_all_deplibs, $1)=yes + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-Bexport' + runpath_var='LD_RUN_PATH' + + if test "$GCC" = yes; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + else + _LT_TAGVAR(archive_cmds, $1)='$CC -G ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -G ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + fi + ;; + + uts4*) + _LT_TAGVAR(archive_cmds, $1)='$LD -G -h $soname -o $lib $libobjs $deplibs $linker_flags' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + + *) + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + + if test x$host_vendor = xsni; then + case $host in + sysv4 | sysv4.2uw2* | sysv4.3* | sysv5*) + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-Blargedynsym' + ;; + esac + fi + fi +]) +AC_MSG_RESULT([$_LT_TAGVAR(ld_shlibs, $1)]) +test "$_LT_TAGVAR(ld_shlibs, $1)" = no && can_build_shared=no + +_LT_TAGVAR(with_gnu_ld, $1)=$with_gnu_ld + +_LT_DECL([], [libext], [0], [Old archive suffix (normally "a")])dnl +_LT_DECL([], [shrext_cmds], [1], [Shared library suffix (normally ".so")])dnl +_LT_DECL([], [extract_expsyms_cmds], [2], + [The commands to extract the exported symbol list from a shared archive]) + +# +# Do we need to explicitly link libc? +# +case "x$_LT_TAGVAR(archive_cmds_need_lc, $1)" in +x|xyes) + # Assume -lc should be added + _LT_TAGVAR(archive_cmds_need_lc, $1)=yes + + if test "$enable_shared" = yes && test "$GCC" = yes; then + case $_LT_TAGVAR(archive_cmds, $1) in + *'~'*) + # FIXME: we may have to deal with multi-command sequences. + ;; + '$CC '*) + # Test whether the compiler implicitly links with -lc since on some + # systems, -lgcc has to come before -lc. If gcc already passes -lc + # to ld, don't add -lc before -lgcc. + AC_CACHE_CHECK([whether -lc should be explicitly linked in], + [lt_cv_]_LT_TAGVAR(archive_cmds_need_lc, $1), + [$RM conftest* + echo "$lt_simple_compile_test_code" > conftest.$ac_ext + + if AC_TRY_EVAL(ac_compile) 2>conftest.err; then + soname=conftest + lib=conftest + libobjs=conftest.$ac_objext + deplibs= + wl=$_LT_TAGVAR(lt_prog_compiler_wl, $1) + pic_flag=$_LT_TAGVAR(lt_prog_compiler_pic, $1) + compiler_flags=-v + linker_flags=-v + verstring= + output_objdir=. + libname=conftest + lt_save_allow_undefined_flag=$_LT_TAGVAR(allow_undefined_flag, $1) + _LT_TAGVAR(allow_undefined_flag, $1)= + if AC_TRY_EVAL(_LT_TAGVAR(archive_cmds, $1) 2\>\&1 \| $GREP \" -lc \" \>/dev/null 2\>\&1) + then + lt_cv_[]_LT_TAGVAR(archive_cmds_need_lc, $1)=no + else + lt_cv_[]_LT_TAGVAR(archive_cmds_need_lc, $1)=yes + fi + _LT_TAGVAR(allow_undefined_flag, $1)=$lt_save_allow_undefined_flag + else + cat conftest.err 1>&5 + fi + $RM conftest* + ]) + _LT_TAGVAR(archive_cmds_need_lc, $1)=$lt_cv_[]_LT_TAGVAR(archive_cmds_need_lc, $1) + ;; + esac + fi + ;; +esac + +_LT_TAGDECL([build_libtool_need_lc], [archive_cmds_need_lc], [0], + [Whether or not to add -lc for building shared libraries]) +_LT_TAGDECL([allow_libtool_libs_with_static_runtimes], + [enable_shared_with_static_runtimes], [0], + [Whether or not to disallow shared libs when runtime libs are static]) +_LT_TAGDECL([], [export_dynamic_flag_spec], [1], + [Compiler flag to allow reflexive dlopens]) +_LT_TAGDECL([], [whole_archive_flag_spec], [1], + [Compiler flag to generate shared objects directly from archives]) +_LT_TAGDECL([], [compiler_needs_object], [1], + [Whether the compiler copes with passing no objects directly]) +_LT_TAGDECL([], [old_archive_from_new_cmds], [2], + [Create an old-style archive from a shared archive]) +_LT_TAGDECL([], [old_archive_from_expsyms_cmds], [2], + [Create a temporary old-style archive to link instead of a shared archive]) +_LT_TAGDECL([], [archive_cmds], [2], [Commands used to build a shared archive]) +_LT_TAGDECL([], [archive_expsym_cmds], [2]) +_LT_TAGDECL([], [module_cmds], [2], + [Commands used to build a loadable module if different from building + a shared archive.]) +_LT_TAGDECL([], [module_expsym_cmds], [2]) +_LT_TAGDECL([], [with_gnu_ld], [1], + [Whether we are building with GNU ld or not]) +_LT_TAGDECL([], [allow_undefined_flag], [1], + [Flag that allows shared libraries with undefined symbols to be built]) +_LT_TAGDECL([], [no_undefined_flag], [1], + [Flag that enforces no undefined symbols]) +_LT_TAGDECL([], [hardcode_libdir_flag_spec], [1], + [Flag to hardcode $libdir into a binary during linking. + This must work even if $libdir does not exist]) +_LT_TAGDECL([], [hardcode_libdir_separator], [1], + [Whether we need a single "-rpath" flag with a separated argument]) +_LT_TAGDECL([], [hardcode_direct], [0], + [Set to "yes" if using DIR/libNAME${shared_ext} during linking hardcodes + DIR into the resulting binary]) +_LT_TAGDECL([], [hardcode_direct_absolute], [0], + [Set to "yes" if using DIR/libNAME${shared_ext} during linking hardcodes + DIR into the resulting binary and the resulting library dependency is + "absolute", i.e impossible to change by setting ${shlibpath_var} if the + library is relocated]) +_LT_TAGDECL([], [hardcode_minus_L], [0], + [Set to "yes" if using the -LDIR flag during linking hardcodes DIR + into the resulting binary]) +_LT_TAGDECL([], [hardcode_shlibpath_var], [0], + [Set to "yes" if using SHLIBPATH_VAR=DIR during linking hardcodes DIR + into the resulting binary]) +_LT_TAGDECL([], [hardcode_automatic], [0], + [Set to "yes" if building a shared library automatically hardcodes DIR + into the library and all subsequent libraries and executables linked + against it]) +_LT_TAGDECL([], [inherit_rpath], [0], + [Set to yes if linker adds runtime paths of dependent libraries + to runtime path list]) +_LT_TAGDECL([], [link_all_deplibs], [0], + [Whether libtool must link a program against all its dependency libraries]) +_LT_TAGDECL([], [always_export_symbols], [0], + [Set to "yes" if exported symbols are required]) +_LT_TAGDECL([], [export_symbols_cmds], [2], + [The commands to list exported symbols]) +_LT_TAGDECL([], [exclude_expsyms], [1], + [Symbols that should not be listed in the preloaded symbols]) +_LT_TAGDECL([], [include_expsyms], [1], + [Symbols that must always be exported]) +_LT_TAGDECL([], [prelink_cmds], [2], + [Commands necessary for linking programs (against libraries) with templates]) +_LT_TAGDECL([], [postlink_cmds], [2], + [Commands necessary for finishing linking programs]) +_LT_TAGDECL([], [file_list_spec], [1], + [Specify filename containing input files]) +dnl FIXME: Not yet implemented +dnl _LT_TAGDECL([], [thread_safe_flag_spec], [1], +dnl [Compiler flag to generate thread safe objects]) +])# _LT_LINKER_SHLIBS + + +# _LT_LANG_C_CONFIG([TAG]) +# ------------------------ +# Ensure that the configuration variables for a C compiler are suitably +# defined. These variables are subsequently used by _LT_CONFIG to write +# the compiler configuration to `libtool'. +m4_defun([_LT_LANG_C_CONFIG], +[m4_require([_LT_DECL_EGREP])dnl +lt_save_CC="$CC" +AC_LANG_PUSH(C) + +# Source file extension for C test sources. +ac_ext=c + +# Object file extension for compiled C test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# Code to be used in simple compile tests +lt_simple_compile_test_code="int some_variable = 0;" + +# Code to be used in simple link tests +lt_simple_link_test_code='int main(){return(0);}' + +_LT_TAG_COMPILER +# Save the default compiler, since it gets overwritten when the other +# tags are being tested, and _LT_TAGVAR(compiler, []) is a NOP. +compiler_DEFAULT=$CC + +# save warnings/boilerplate of simple test code +_LT_COMPILER_BOILERPLATE +_LT_LINKER_BOILERPLATE + +## CAVEAT EMPTOR: +## There is no encapsulation within the following macros, do not change +## the running order or otherwise move them around unless you know exactly +## what you are doing... +if test -n "$compiler"; then + _LT_COMPILER_NO_RTTI($1) + _LT_COMPILER_PIC($1) + _LT_COMPILER_C_O($1) + _LT_COMPILER_FILE_LOCKS($1) + _LT_LINKER_SHLIBS($1) + _LT_SYS_DYNAMIC_LINKER($1) + _LT_LINKER_HARDCODE_LIBPATH($1) + LT_SYS_DLOPEN_SELF + _LT_CMD_STRIPLIB + + # Report which library types will actually be built + AC_MSG_CHECKING([if libtool supports shared libraries]) + AC_MSG_RESULT([$can_build_shared]) + + AC_MSG_CHECKING([whether to build shared libraries]) + test "$can_build_shared" = "no" && enable_shared=no + + # On AIX, shared libraries and static libraries use the same namespace, and + # are all built from PIC. + case $host_os in + aix3*) + test "$enable_shared" = yes && enable_static=no + if test -n "$RANLIB"; then + archive_cmds="$archive_cmds~\$RANLIB \$lib" + postinstall_cmds='$RANLIB $lib' + fi + ;; + + aix[[4-9]]*) + if test "$host_cpu" != ia64 && test "$aix_use_runtimelinking" = no ; then + test "$enable_shared" = yes && enable_static=no + fi + ;; + esac + AC_MSG_RESULT([$enable_shared]) + + AC_MSG_CHECKING([whether to build static libraries]) + # Make sure either enable_shared or enable_static is yes. + test "$enable_shared" = yes || enable_static=yes + AC_MSG_RESULT([$enable_static]) + + _LT_CONFIG($1) +fi +AC_LANG_POP +CC="$lt_save_CC" +])# _LT_LANG_C_CONFIG + + +# _LT_LANG_CXX_CONFIG([TAG]) +# -------------------------- +# Ensure that the configuration variables for a C++ compiler are suitably +# defined. These variables are subsequently used by _LT_CONFIG to write +# the compiler configuration to `libtool'. +m4_defun([_LT_LANG_CXX_CONFIG], +[m4_require([_LT_FILEUTILS_DEFAULTS])dnl +m4_require([_LT_DECL_EGREP])dnl +m4_require([_LT_PATH_MANIFEST_TOOL])dnl +if test -n "$CXX" && ( test "X$CXX" != "Xno" && + ( (test "X$CXX" = "Xg++" && `g++ -v >/dev/null 2>&1` ) || + (test "X$CXX" != "Xg++"))) ; then + AC_PROG_CXXCPP +else + _lt_caught_CXX_error=yes +fi + +AC_LANG_PUSH(C++) +_LT_TAGVAR(archive_cmds_need_lc, $1)=no +_LT_TAGVAR(allow_undefined_flag, $1)= +_LT_TAGVAR(always_export_symbols, $1)=no +_LT_TAGVAR(archive_expsym_cmds, $1)= +_LT_TAGVAR(compiler_needs_object, $1)=no +_LT_TAGVAR(export_dynamic_flag_spec, $1)= +_LT_TAGVAR(hardcode_direct, $1)=no +_LT_TAGVAR(hardcode_direct_absolute, $1)=no +_LT_TAGVAR(hardcode_libdir_flag_spec, $1)= +_LT_TAGVAR(hardcode_libdir_separator, $1)= +_LT_TAGVAR(hardcode_minus_L, $1)=no +_LT_TAGVAR(hardcode_shlibpath_var, $1)=unsupported +_LT_TAGVAR(hardcode_automatic, $1)=no +_LT_TAGVAR(inherit_rpath, $1)=no +_LT_TAGVAR(module_cmds, $1)= +_LT_TAGVAR(module_expsym_cmds, $1)= +_LT_TAGVAR(link_all_deplibs, $1)=unknown +_LT_TAGVAR(old_archive_cmds, $1)=$old_archive_cmds +_LT_TAGVAR(reload_flag, $1)=$reload_flag +_LT_TAGVAR(reload_cmds, $1)=$reload_cmds +_LT_TAGVAR(no_undefined_flag, $1)= +_LT_TAGVAR(whole_archive_flag_spec, $1)= +_LT_TAGVAR(enable_shared_with_static_runtimes, $1)=no + +# Source file extension for C++ test sources. +ac_ext=cpp + +# Object file extension for compiled C++ test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# No sense in running all these tests if we already determined that +# the CXX compiler isn't working. Some variables (like enable_shared) +# are currently assumed to apply to all compilers on this platform, +# and will be corrupted by setting them based on a non-working compiler. +if test "$_lt_caught_CXX_error" != yes; then + # Code to be used in simple compile tests + lt_simple_compile_test_code="int some_variable = 0;" + + # Code to be used in simple link tests + lt_simple_link_test_code='int main(int, char *[[]]) { return(0); }' + + # ltmain only uses $CC for tagged configurations so make sure $CC is set. + _LT_TAG_COMPILER + + # save warnings/boilerplate of simple test code + _LT_COMPILER_BOILERPLATE + _LT_LINKER_BOILERPLATE + + # Allow CC to be a program name with arguments. + lt_save_CC=$CC + lt_save_CFLAGS=$CFLAGS + lt_save_LD=$LD + lt_save_GCC=$GCC + GCC=$GXX + lt_save_with_gnu_ld=$with_gnu_ld + lt_save_path_LD=$lt_cv_path_LD + if test -n "${lt_cv_prog_gnu_ldcxx+set}"; then + lt_cv_prog_gnu_ld=$lt_cv_prog_gnu_ldcxx + else + $as_unset lt_cv_prog_gnu_ld + fi + if test -n "${lt_cv_path_LDCXX+set}"; then + lt_cv_path_LD=$lt_cv_path_LDCXX + else + $as_unset lt_cv_path_LD + fi + test -z "${LDCXX+set}" || LD=$LDCXX + CC=${CXX-"c++"} + CFLAGS=$CXXFLAGS + compiler=$CC + _LT_TAGVAR(compiler, $1)=$CC + _LT_CC_BASENAME([$compiler]) + + if test -n "$compiler"; then + # We don't want -fno-exception when compiling C++ code, so set the + # no_builtin_flag separately + if test "$GXX" = yes; then + _LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)=' -fno-builtin' + else + _LT_TAGVAR(lt_prog_compiler_no_builtin_flag, $1)= + fi + + if test "$GXX" = yes; then + # Set up default GNU C++ configuration + + LT_PATH_LD + + # Check if GNU C++ uses GNU ld as the underlying linker, since the + # archiving commands below assume that GNU ld is being used. + if test "$with_gnu_ld" = yes; then + _LT_TAGVAR(archive_cmds, $1)='$CC $pic_flag -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC $pic_flag -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-dynamic' + + # If archive_cmds runs LD, not CC, wlarc should be empty + # XXX I think wlarc can be eliminated in ltcf-cxx, but I need to + # investigate it a little bit more. (MM) + wlarc='${wl}' + + # ancient GNU ld didn't support --whole-archive et. al. + if eval "`$CC -print-prog-name=ld` --help 2>&1" | + $GREP 'no-whole-archive' > /dev/null; then + _LT_TAGVAR(whole_archive_flag_spec, $1)="$wlarc"'--whole-archive$convenience '"$wlarc"'--no-whole-archive' + else + _LT_TAGVAR(whole_archive_flag_spec, $1)= + fi + else + with_gnu_ld=no + wlarc= + + # A generic and very simple default shared library creation + # command for GNU C++ for the case where it uses the native + # linker, instead of GNU ld. If possible, this setting should + # overridden to take advantage of the native linker features on + # the platform it is being used on. + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -o $lib' + fi + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + output_verbose_link_cmd='$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP -v "^Configured with:" | $GREP "\-L"' + + else + GXX=no + with_gnu_ld=no + wlarc= + fi + + # PORTME: fill in a description of your system's C++ link characteristics + AC_MSG_CHECKING([whether the $compiler linker ($LD) supports shared libraries]) + _LT_TAGVAR(ld_shlibs, $1)=yes + case $host_os in + aix3*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + aix[[4-9]]*) + if test "$host_cpu" = ia64; then + # On IA64, the linker does run time linking by default, so we don't + # have to do anything special. + aix_use_runtimelinking=no + exp_sym_flag='-Bexport' + no_entry_flag="" + else + aix_use_runtimelinking=no + + # Test if we are trying to use run time linking or normal + # AIX style linking. If -brtl is somewhere in LDFLAGS, we + # need to do runtime linking. + case $host_os in aix4.[[23]]|aix4.[[23]].*|aix[[5-9]]*) + for ld_flag in $LDFLAGS; do + case $ld_flag in + *-brtl*) + aix_use_runtimelinking=yes + break + ;; + esac + done + ;; + esac + + exp_sym_flag='-bexport' + no_entry_flag='-bnoentry' + fi + + # When large executables or shared objects are built, AIX ld can + # have problems creating the table of contents. If linking a library + # or program results in "error TOC overflow" add -mminimal-toc to + # CXXFLAGS/CFLAGS for g++/gcc. In the cases where that is not + # enough to fix the problem, add -Wl,-bbigtoc to LDFLAGS. + + _LT_TAGVAR(archive_cmds, $1)='' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + _LT_TAGVAR(hardcode_libdir_separator, $1)=':' + _LT_TAGVAR(link_all_deplibs, $1)=yes + _LT_TAGVAR(file_list_spec, $1)='${wl}-f,' + + if test "$GXX" = yes; then + case $host_os in aix4.[[012]]|aix4.[[012]].*) + # We only want to do this on AIX 4.2 and lower, the check + # below for broken collect2 doesn't work under 4.3+ + collect2name=`${CC} -print-prog-name=collect2` + if test -f "$collect2name" && + strings "$collect2name" | $GREP resolve_lib_name >/dev/null + then + # We have reworked collect2 + : + else + # We have old collect2 + _LT_TAGVAR(hardcode_direct, $1)=unsupported + # It fails to find uninstalled libraries when the uninstalled + # path is not listed in the libpath. Setting hardcode_minus_L + # to unsupported forces relinking + _LT_TAGVAR(hardcode_minus_L, $1)=yes + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)= + fi + esac + shared_flag='-shared' + if test "$aix_use_runtimelinking" = yes; then + shared_flag="$shared_flag "'${wl}-G' + fi + else + # not using gcc + if test "$host_cpu" = ia64; then + # VisualAge C++, Version 5.5 for AIX 5L for IA-64, Beta 3 Release + # chokes on -Wl,-G. The following line is correct: + shared_flag='-G' + else + if test "$aix_use_runtimelinking" = yes; then + shared_flag='${wl}-G' + else + shared_flag='${wl}-bM:SRE' + fi + fi + fi + + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-bexpall' + # It seems that -bexpall does not export symbols beginning with + # underscore (_), so it is better to generate a list of symbols to + # export. + _LT_TAGVAR(always_export_symbols, $1)=yes + if test "$aix_use_runtimelinking" = yes; then + # Warning - without using the other runtime loading flags (-brtl), + # -berok will link without error, but may produce a broken library. + _LT_TAGVAR(allow_undefined_flag, $1)='-berok' + # Determine the default libpath from the value encoded in an empty + # executable. + _LT_SYS_MODULE_PATH_AIX([$1]) + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-blibpath:$libdir:'"$aix_libpath" + + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -o $output_objdir/$soname $libobjs $deplibs '"\${wl}$no_entry_flag"' $compiler_flags `if test "x${allow_undefined_flag}" != "x"; then func_echo_all "${wl}${allow_undefined_flag}"; else :; fi` '"\${wl}$exp_sym_flag:\$export_symbols $shared_flag" + else + if test "$host_cpu" = ia64; then + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-R $libdir:/usr/lib:/lib' + _LT_TAGVAR(allow_undefined_flag, $1)="-z nodefs" + _LT_TAGVAR(archive_expsym_cmds, $1)="\$CC $shared_flag"' -o $output_objdir/$soname $libobjs $deplibs '"\${wl}$no_entry_flag"' $compiler_flags ${wl}${allow_undefined_flag} '"\${wl}$exp_sym_flag:\$export_symbols" + else + # Determine the default libpath from the value encoded in an + # empty executable. + _LT_SYS_MODULE_PATH_AIX([$1]) + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-blibpath:$libdir:'"$aix_libpath" + # Warning - without using the other run time loading flags, + # -berok will link without error, but may produce a broken library. + _LT_TAGVAR(no_undefined_flag, $1)=' ${wl}-bernotok' + _LT_TAGVAR(allow_undefined_flag, $1)=' ${wl}-berok' + if test "$with_gnu_ld" = yes; then + # We only use this code for GNU lds that support --whole-archive. + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive$convenience ${wl}--no-whole-archive' + else + # Exported symbols can be pulled into shared objects from archives + _LT_TAGVAR(whole_archive_flag_spec, $1)='$convenience' + fi + _LT_TAGVAR(archive_cmds_need_lc, $1)=yes + # This is similar to how AIX traditionally builds its shared + # libraries. + _LT_TAGVAR(archive_expsym_cmds, $1)="\$CC $shared_flag"' -o $output_objdir/$soname $libobjs $deplibs ${wl}-bnoentry $compiler_flags ${wl}-bE:$export_symbols${allow_undefined_flag}~$AR $AR_FLAGS $output_objdir/$libname$release.a $output_objdir/$soname' + fi + fi + ;; + + beos*) + if $LD --help 2>&1 | $GREP ': supported targets:.* elf' > /dev/null; then + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + # Joseph Beckenbach says some releases of gcc + # support --undefined. This deserves some investigation. FIXME + _LT_TAGVAR(archive_cmds, $1)='$CC -nostart $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + chorus*) + case $cc_basename in + *) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + ;; + + cygwin* | mingw* | pw32* | cegcc*) + case $GXX,$cc_basename in + ,cl* | no,cl*) + # Native MSVC + # hardcode_libdir_flag_spec is actually meaningless, as there is + # no search path for DLLs. + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)=' ' + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + _LT_TAGVAR(always_export_symbols, $1)=yes + _LT_TAGVAR(file_list_spec, $1)='@' + # Tell ltmain to make .lib files, not .a files. + libext=lib + # Tell ltmain to make .dll files, not .so files. + shrext_cmds=".dll" + # FIXME: Setting linknames here is a bad hack. + _LT_TAGVAR(archive_cmds, $1)='$CC -o $output_objdir/$soname $libobjs $compiler_flags $deplibs -Wl,-dll~linknames=' + _LT_TAGVAR(archive_expsym_cmds, $1)='if test "x`$SED 1q $export_symbols`" = xEXPORTS; then + $SED -n -e 's/\\\\\\\(.*\\\\\\\)/-link\\\ -EXPORT:\\\\\\\1/' -e '1\\\!p' < $export_symbols > $output_objdir/$soname.exp; + else + $SED -e 's/\\\\\\\(.*\\\\\\\)/-link\\\ -EXPORT:\\\\\\\1/' < $export_symbols > $output_objdir/$soname.exp; + fi~ + $CC -o $tool_output_objdir$soname $libobjs $compiler_flags $deplibs "@$tool_output_objdir$soname.exp" -Wl,-DLL,-IMPLIB:"$tool_output_objdir$libname.dll.lib"~ + linknames=' + # The linker will not automatically build a static lib if we build a DLL. + # _LT_TAGVAR(old_archive_from_new_cmds, $1)='true' + _LT_TAGVAR(enable_shared_with_static_runtimes, $1)=yes + # Don't use ranlib + _LT_TAGVAR(old_postinstall_cmds, $1)='chmod 644 $oldlib' + _LT_TAGVAR(postlink_cmds, $1)='lt_outputfile="@OUTPUT@"~ + lt_tool_outputfile="@TOOL_OUTPUT@"~ + case $lt_outputfile in + *.exe|*.EXE) ;; + *) + lt_outputfile="$lt_outputfile.exe" + lt_tool_outputfile="$lt_tool_outputfile.exe" + ;; + esac~ + func_to_tool_file "$lt_outputfile"~ + if test "$MANIFEST_TOOL" != ":" && test -f "$lt_outputfile.manifest"; then + $MANIFEST_TOOL -manifest "$lt_tool_outputfile.manifest" -outputresource:"$lt_tool_outputfile" || exit 1; + $RM "$lt_outputfile.manifest"; + fi' + ;; + *) + # g++ + # _LT_TAGVAR(hardcode_libdir_flag_spec, $1) is actually meaningless, + # as there is no search path for DLLs. + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-L$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-all-symbols' + _LT_TAGVAR(allow_undefined_flag, $1)=unsupported + _LT_TAGVAR(always_export_symbols, $1)=no + _LT_TAGVAR(enable_shared_with_static_runtimes, $1)=yes + + if $LD --help 2>&1 | $GREP 'auto-import' > /dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -o $output_objdir/$soname ${wl}--enable-auto-image-base -Xlinker --out-implib -Xlinker $lib' + # If the export-symbols file already is a .def file (1st line + # is EXPORTS), use it as is; otherwise, prepend... + _LT_TAGVAR(archive_expsym_cmds, $1)='if test "x`$SED 1q $export_symbols`" = xEXPORTS; then + cp $export_symbols $output_objdir/$soname.def; + else + echo EXPORTS > $output_objdir/$soname.def; + cat $export_symbols >> $output_objdir/$soname.def; + fi~ + $CC -shared -nostdlib $output_objdir/$soname.def $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -o $output_objdir/$soname ${wl}--enable-auto-image-base -Xlinker --out-implib -Xlinker $lib' + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + esac + ;; + darwin* | rhapsody*) + _LT_DARWIN_LINKER_FEATURES($1) + ;; + + dgux*) + case $cc_basename in + ec++*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + ghcx*) + # Green Hills C++ Compiler + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + *) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + ;; + + freebsd2.*) + # C++ shared libraries reported to be fairly broken before + # switch to ELF + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + + freebsd-elf*) + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + ;; + + freebsd* | dragonfly*) + # FreeBSD 3 and later use GNU C++ and GNU ld with standard ELF + # conventions + _LT_TAGVAR(ld_shlibs, $1)=yes + ;; + + gnu*) + ;; + + haiku*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(link_all_deplibs, $1)=yes + ;; + + hpux9*) + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}+b ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_minus_L, $1)=yes # Not in the search PATH, + # but as the default + # location of the library. + + case $cc_basename in + CC*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + aCC*) + _LT_TAGVAR(archive_cmds, $1)='$RM $output_objdir/$soname~$CC -b ${wl}+b ${wl}$install_libdir -o $output_objdir/$soname $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~test $output_objdir/$soname = $lib || mv $output_objdir/$soname $lib' + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`($CC -b $CFLAGS -v conftest.$objext 2>&1) | $EGREP "\-L"`; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "$list"' + ;; + *) + if test "$GXX" = yes; then + _LT_TAGVAR(archive_cmds, $1)='$RM $output_objdir/$soname~$CC -shared -nostdlib $pic_flag ${wl}+b ${wl}$install_libdir -o $output_objdir/$soname $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~test $output_objdir/$soname = $lib || mv $output_objdir/$soname $lib' + else + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + esac + ;; + + hpux10*|hpux11*) + if test $with_gnu_ld = no; then + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}+b ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + + case $host_cpu in + hppa*64*|ia64*) + ;; + *) + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + ;; + esac + fi + case $host_cpu in + hppa*64*|ia64*) + _LT_TAGVAR(hardcode_direct, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + ;; + *) + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + _LT_TAGVAR(hardcode_minus_L, $1)=yes # Not in the search PATH, + # but as the default + # location of the library. + ;; + esac + + case $cc_basename in + CC*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + aCC*) + case $host_cpu in + hppa*64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + ia64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname ${wl}+nodefaultrpath -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -b ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + esac + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`($CC -b $CFLAGS -v conftest.$objext 2>&1) | $GREP "\-L"`; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "$list"' + ;; + *) + if test "$GXX" = yes; then + if test $with_gnu_ld = no; then + case $host_cpu in + hppa*64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -nostdlib -fPIC ${wl}+h ${wl}$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + ia64*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -nostdlib $pic_flag ${wl}+h ${wl}$soname ${wl}+nodefaultrpath -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -nostdlib $pic_flag ${wl}+h ${wl}$soname ${wl}+b ${wl}$install_libdir -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + ;; + esac + fi + else + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + esac + ;; + + interix[[3-9]]*) + _LT_TAGVAR(hardcode_direct, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + # Hack: On Interix 3.x, we cannot compile PIC because of a broken gcc. + # Instead, shared libraries are loaded at an image base (0x10000000 by + # default) and relocated if they conflict, which is a slow very memory + # consuming and fragmenting process. To avoid this, we pick a random, + # 256 KiB-aligned image base between 0x50000000 and 0x6FFC0000 at link + # time. Moving up from 0x10000000 also allows more sbrk(2) space. + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-h,$soname ${wl}--image-base,`expr ${RANDOM-$$} % 4096 / 2 \* 262144 + 1342177280` -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='sed "s,^,_," $export_symbols >$output_objdir/$soname.expsym~$CC -shared $pic_flag $libobjs $deplibs $compiler_flags ${wl}-h,$soname ${wl}--retain-symbols-file,$output_objdir/$soname.expsym ${wl}--image-base,`expr ${RANDOM-$$} % 4096 / 2 \* 262144 + 1342177280` -o $lib' + ;; + irix5* | irix6*) + case $cc_basename in + CC*) + # SGI C++ + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -all -multigot $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + + # Archives containing C++ object files must be created using + # "CC -ar", where "CC" is the IRIX C++ compiler. This is + # necessary to make sure instantiated templates are included + # in the archive. + _LT_TAGVAR(old_archive_cmds, $1)='$CC -ar -WR,-u -o $oldlib $oldobjs' + ;; + *) + if test "$GXX" = yes; then + if test "$with_gnu_ld" = no; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + else + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -nostdlib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` -o $lib' + fi + fi + _LT_TAGVAR(link_all_deplibs, $1)=yes + ;; + esac + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + _LT_TAGVAR(inherit_rpath, $1)=yes + ;; + + linux* | k*bsd*-gnu | kopensolaris*-gnu) + case $cc_basename in + KCC*) + # Kuck and Associates, Inc. (KAI) C++ Compiler + + # KCC will only create a shared library if the output file + # ends with ".so" (or ".sl" for HP-UX), so rename the library + # to its proper name (with version) after linking. + _LT_TAGVAR(archive_cmds, $1)='tempext=`echo $shared_ext | $SED -e '\''s/\([[^()0-9A-Za-z{}]]\)/\\\\\1/g'\''`; templib=`echo $lib | $SED -e "s/\${tempext}\..*/.so/"`; $CC $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags --soname $soname -o \$templib; mv \$templib $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='tempext=`echo $shared_ext | $SED -e '\''s/\([[^()0-9A-Za-z{}]]\)/\\\\\1/g'\''`; templib=`echo $lib | $SED -e "s/\${tempext}\..*/.so/"`; $CC $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags --soname $soname -o \$templib ${wl}-retain-symbols-file,$export_symbols; mv \$templib $lib' + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`$CC $CFLAGS -v conftest.$objext -o libconftest$shared_ext 2>&1 | $GREP "ld"`; rm -f libconftest$shared_ext; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "$list"' + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-dynamic' + + # Archives containing C++ object files must be created using + # "CC -Bstatic", where "CC" is the KAI C++ compiler. + _LT_TAGVAR(old_archive_cmds, $1)='$CC -Bstatic -o $oldlib $oldobjs' + ;; + icpc* | ecpc* ) + # Intel C++ + with_gnu_ld=yes + # version 8.0 and above of icpc choke on multiply defined symbols + # if we add $predep_objects and $postdep_objects, however 7.1 and + # earlier do not add the objects themselves. + case `$CC -V 2>&1` in + *"Version 7."*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + ;; + *) # Version 8.0 or newer + tmp_idyn= + case $host_cpu in + ia64*) tmp_idyn=' -i_dynamic';; + esac + _LT_TAGVAR(archive_cmds, $1)='$CC -shared'"$tmp_idyn"' $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared'"$tmp_idyn"' $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-retain-symbols-file $wl$export_symbols -o $lib' + ;; + esac + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-dynamic' + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive$convenience ${wl}--no-whole-archive' + ;; + pgCC* | pgcpp*) + # Portland Group C++ compiler + case `$CC -V` in + *pgCC\ [[1-5]].* | *pgcpp\ [[1-5]].*) + _LT_TAGVAR(prelink_cmds, $1)='tpldir=Template.dir~ + rm -rf $tpldir~ + $CC --prelink_objects --instantiation_dir $tpldir $objs $libobjs $compile_deplibs~ + compile_command="$compile_command `find $tpldir -name \*.o | sort | $NL2SP`"' + _LT_TAGVAR(old_archive_cmds, $1)='tpldir=Template.dir~ + rm -rf $tpldir~ + $CC --prelink_objects --instantiation_dir $tpldir $oldobjs$old_deplibs~ + $AR $AR_FLAGS $oldlib$oldobjs$old_deplibs `find $tpldir -name \*.o | sort | $NL2SP`~ + $RANLIB $oldlib' + _LT_TAGVAR(archive_cmds, $1)='tpldir=Template.dir~ + rm -rf $tpldir~ + $CC --prelink_objects --instantiation_dir $tpldir $predep_objects $libobjs $deplibs $convenience $postdep_objects~ + $CC -shared $pic_flag $predep_objects $libobjs $deplibs `find $tpldir -name \*.o | sort | $NL2SP` $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='tpldir=Template.dir~ + rm -rf $tpldir~ + $CC --prelink_objects --instantiation_dir $tpldir $predep_objects $libobjs $deplibs $convenience $postdep_objects~ + $CC -shared $pic_flag $predep_objects $libobjs $deplibs `find $tpldir -name \*.o | sort | $NL2SP` $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname ${wl}-retain-symbols-file ${wl}$export_symbols -o $lib' + ;; + *) # Version 6 and above use weak symbols + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname ${wl}-retain-symbols-file ${wl}$export_symbols -o $lib' + ;; + esac + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}--rpath ${wl}$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-dynamic' + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive`for conv in $convenience\"\"; do test -n \"$conv\" && new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + ;; + cxx*) + # Compaq C++ + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $wl$soname -o $lib ${wl}-retain-symbols-file $wl$export_symbols' + + runpath_var=LD_RUN_PATH + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-rpath $libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP "ld"`; templist=`func_echo_all "$templist" | $SED "s/\(^.*ld.*\)\( .*ld .*$\)/\1/"`; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "X$list" | $Xsed' + ;; + xl* | mpixl* | bgxl*) + # IBM XL 8.0 on PPC, with GNU ld + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}--export-dynamic' + _LT_TAGVAR(archive_cmds, $1)='$CC -qmkshrobj $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname -o $lib' + if test "x$supports_anon_versioning" = xyes; then + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $output_objdir/$libname.ver~ + cat $export_symbols | sed -e "s/\(.*\)/\1;/" >> $output_objdir/$libname.ver~ + echo "local: *; };" >> $output_objdir/$libname.ver~ + $CC -qmkshrobj $libobjs $deplibs $compiler_flags ${wl}-soname $wl$soname ${wl}-version-script ${wl}$output_objdir/$libname.ver -o $lib' + fi + ;; + *) + case `$CC -V 2>&1 | sed 5q` in + *Sun\ C*) + # Sun C++ 5.9 + _LT_TAGVAR(no_undefined_flag, $1)=' -zdefs' + _LT_TAGVAR(archive_cmds, $1)='$CC -G${allow_undefined_flag} -h$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -G${allow_undefined_flag} -h$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-retain-symbols-file ${wl}$export_symbols' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}--whole-archive`new_convenience=; for conv in $convenience\"\"; do test -z \"$conv\" || new_convenience=\"$new_convenience,$conv\"; done; func_echo_all \"$new_convenience\"` ${wl}--no-whole-archive' + _LT_TAGVAR(compiler_needs_object, $1)=yes + + # Not sure whether something based on + # $CC $CFLAGS -v conftest.$objext -o libconftest$shared_ext 2>&1 + # would be better. + output_verbose_link_cmd='func_echo_all' + + # Archives containing C++ object files must be created using + # "CC -xar", where "CC" is the Sun C++ compiler. This is + # necessary to make sure instantiated templates are included + # in the archive. + _LT_TAGVAR(old_archive_cmds, $1)='$CC -xar -o $oldlib $oldobjs' + ;; + esac + ;; + esac + ;; + + lynxos*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + + m88k*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + + mvs*) + case $cc_basename in + cxx*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + *) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + ;; + + netbsd*) + if echo __ELF__ | $CC -E - | $GREP __ELF__ >/dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$LD -Bshareable -o $lib $predep_objects $libobjs $deplibs $postdep_objects $linker_flags' + wlarc= + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + fi + # Workaround some broken pre-1.5 toolchains + output_verbose_link_cmd='$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP conftest.$objext | $SED -e "s:-lgcc -lc -lgcc::"' + ;; + + *nto* | *qnx*) + _LT_TAGVAR(ld_shlibs, $1)=yes + ;; + + openbsd2*) + # C++ shared libraries are fairly broken + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + + openbsd*) + if test -f /usr/libexec/ld.so; then + _LT_TAGVAR(hardcode_direct, $1)=yes + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(hardcode_direct_absolute, $1)=yes + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -o $lib' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + if test -z "`echo __ELF__ | $CC -E - | grep __ELF__`" || test "$host_os-$host_cpu" = "openbsd2.8-powerpc"; then + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared $pic_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-retain-symbols-file,$export_symbols -o $lib' + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-E' + _LT_TAGVAR(whole_archive_flag_spec, $1)="$wlarc"'--whole-archive$convenience '"$wlarc"'--no-whole-archive' + fi + output_verbose_link_cmd=func_echo_all + else + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + + osf3* | osf4* | osf5*) + case $cc_basename in + KCC*) + # Kuck and Associates, Inc. (KAI) C++ Compiler + + # KCC will only create a shared library if the output file + # ends with ".so" (or ".sl" for HP-UX), so rename the library + # to its proper name (with version) after linking. + _LT_TAGVAR(archive_cmds, $1)='tempext=`echo $shared_ext | $SED -e '\''s/\([[^()0-9A-Za-z{}]]\)/\\\\\1/g'\''`; templib=`echo "$lib" | $SED -e "s/\${tempext}\..*/.so/"`; $CC $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags --soname $soname -o \$templib; mv \$templib $lib' + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath,$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + + # Archives containing C++ object files must be created using + # the KAI C++ compiler. + case $host in + osf3*) _LT_TAGVAR(old_archive_cmds, $1)='$CC -Bstatic -o $oldlib $oldobjs' ;; + *) _LT_TAGVAR(old_archive_cmds, $1)='$CC -o $oldlib $oldobjs' ;; + esac + ;; + RCC*) + # Rational C++ 2.4.1 + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + cxx*) + case $host in + osf3*) + _LT_TAGVAR(allow_undefined_flag, $1)=' ${wl}-expect_unresolved ${wl}\*' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared${allow_undefined_flag} $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname $soname `test -n "$verstring" && func_echo_all "${wl}-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + ;; + *) + _LT_TAGVAR(allow_undefined_flag, $1)=' -expect_unresolved \*' + _LT_TAGVAR(archive_cmds, $1)='$CC -shared${allow_undefined_flag} $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -msym -soname $soname `test -n "$verstring" && func_echo_all "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='for i in `cat $export_symbols`; do printf "%s %s\\n" -exported_symbol "\$i" >> $lib.exp; done~ + echo "-hidden">> $lib.exp~ + $CC -shared$allow_undefined_flag $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags -msym -soname $soname ${wl}-input ${wl}$lib.exp `test -n "$verstring" && $ECHO "-set_version $verstring"` -update_registry ${output_objdir}/so_locations -o $lib~ + $RM $lib.exp' + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-rpath $libdir' + ;; + esac + + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + # + # There doesn't appear to be a way to prevent this compiler from + # explicitly linking system object files so we need to strip them + # from the output so that they don't get included in the library + # dependencies. + output_verbose_link_cmd='templist=`$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP "ld" | $GREP -v "ld:"`; templist=`func_echo_all "$templist" | $SED "s/\(^.*ld.*\)\( .*ld.*$\)/\1/"`; list=""; for z in $templist; do case $z in conftest.$objext) list="$list $z";; *.$objext);; *) list="$list $z";;esac; done; func_echo_all "$list"' + ;; + *) + if test "$GXX" = yes && test "$with_gnu_ld" = no; then + _LT_TAGVAR(allow_undefined_flag, $1)=' ${wl}-expect_unresolved ${wl}\*' + case $host in + osf3*) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared -nostdlib ${allow_undefined_flag} $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -nostdlib ${allow_undefined_flag} $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-msym ${wl}-soname ${wl}$soname `test -n "$verstring" && func_echo_all "${wl}-set_version ${wl}$verstring"` ${wl}-update_registry ${wl}${output_objdir}/so_locations -o $lib' + ;; + esac + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-rpath ${wl}$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=: + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + output_verbose_link_cmd='$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP -v "^Configured with:" | $GREP "\-L"' + + else + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + fi + ;; + esac + ;; + + psos*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + + sunos4*) + case $cc_basename in + CC*) + # Sun C++ 4.x + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + lcc*) + # Lucid + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + *) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + ;; + + solaris*) + case $cc_basename in + CC* | sunCC*) + # Sun C++ 4.2, 5.x and Centerline C++ + _LT_TAGVAR(archive_cmds_need_lc,$1)=yes + _LT_TAGVAR(no_undefined_flag, $1)=' -zdefs' + _LT_TAGVAR(archive_cmds, $1)='$CC -G${allow_undefined_flag} -h$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -G${allow_undefined_flag} ${wl}-M ${wl}$lib.exp -h$soname -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~$RM $lib.exp' + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='-R$libdir' + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + case $host_os in + solaris2.[[0-5]] | solaris2.[[0-5]].*) ;; + *) + # The compiler driver will combine and reorder linker options, + # but understands `-z linker_flag'. + # Supported since Solaris 2.6 (maybe 2.5.1?) + _LT_TAGVAR(whole_archive_flag_spec, $1)='-z allextract$convenience -z defaultextract' + ;; + esac + _LT_TAGVAR(link_all_deplibs, $1)=yes + + output_verbose_link_cmd='func_echo_all' + + # Archives containing C++ object files must be created using + # "CC -xar", where "CC" is the Sun C++ compiler. This is + # necessary to make sure instantiated templates are included + # in the archive. + _LT_TAGVAR(old_archive_cmds, $1)='$CC -xar -o $oldlib $oldobjs' + ;; + gcx*) + # Green Hills C++ Compiler + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-h $wl$soname -o $lib' + + # The C++ compiler must be used to create the archive. + _LT_TAGVAR(old_archive_cmds, $1)='$CC $LDFLAGS -archive -o $oldlib $oldobjs' + ;; + *) + # GNU C++ compiler with Solaris linker + if test "$GXX" = yes && test "$with_gnu_ld" = no; then + _LT_TAGVAR(no_undefined_flag, $1)=' ${wl}-z ${wl}defs' + if $CC --version | $GREP -v '^2\.7' > /dev/null; then + _LT_TAGVAR(archive_cmds, $1)='$CC -shared $pic_flag -nostdlib $LDFLAGS $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-h $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -shared $pic_flag -nostdlib ${wl}-M $wl$lib.exp -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~$RM $lib.exp' + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + output_verbose_link_cmd='$CC -shared $CFLAGS -v conftest.$objext 2>&1 | $GREP -v "^Configured with:" | $GREP "\-L"' + else + # g++ 2.7 appears to require `-G' NOT `-shared' on this + # platform. + _LT_TAGVAR(archive_cmds, $1)='$CC -G -nostdlib $LDFLAGS $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags ${wl}-h $wl$soname -o $lib' + _LT_TAGVAR(archive_expsym_cmds, $1)='echo "{ global:" > $lib.exp~cat $export_symbols | $SED -e "s/\(.*\)/\1;/" >> $lib.exp~echo "local: *; };" >> $lib.exp~ + $CC -G -nostdlib ${wl}-M $wl$lib.exp -o $lib $predep_objects $libobjs $deplibs $postdep_objects $compiler_flags~$RM $lib.exp' + + # Commands to make compiler produce verbose output that lists + # what "hidden" libraries, object files and flags are used when + # linking a shared library. + output_verbose_link_cmd='$CC -G $CFLAGS -v conftest.$objext 2>&1 | $GREP -v "^Configured with:" | $GREP "\-L"' + fi + + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-R $wl$libdir' + case $host_os in + solaris2.[[0-5]] | solaris2.[[0-5]].*) ;; + *) + _LT_TAGVAR(whole_archive_flag_spec, $1)='${wl}-z ${wl}allextract$convenience ${wl}-z ${wl}defaultextract' + ;; + esac + fi + ;; + esac + ;; + + sysv4*uw2* | sysv5OpenUNIX* | sysv5UnixWare7.[[01]].[[10]]* | unixware7* | sco3.2v5.0.[[024]]*) + _LT_TAGVAR(no_undefined_flag, $1)='${wl}-z,text' + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + runpath_var='LD_RUN_PATH' + + case $cc_basename in + CC*) + _LT_TAGVAR(archive_cmds, $1)='$CC -G ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -G ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + esac + ;; + + sysv5* | sco3.2v5* | sco5v6*) + # Note: We can NOT use -z defs as we might desire, because we do not + # link with -lc, and that would cause any symbols used from libc to + # always be unresolved, which means just about no library would + # ever link correctly. If we're not using GNU ld we use -z text + # though, which does catch some bad symbols but isn't as heavy-handed + # as -z defs. + _LT_TAGVAR(no_undefined_flag, $1)='${wl}-z,text' + _LT_TAGVAR(allow_undefined_flag, $1)='${wl}-z,nodefs' + _LT_TAGVAR(archive_cmds_need_lc, $1)=no + _LT_TAGVAR(hardcode_shlibpath_var, $1)=no + _LT_TAGVAR(hardcode_libdir_flag_spec, $1)='${wl}-R,$libdir' + _LT_TAGVAR(hardcode_libdir_separator, $1)=':' + _LT_TAGVAR(link_all_deplibs, $1)=yes + _LT_TAGVAR(export_dynamic_flag_spec, $1)='${wl}-Bexport' + runpath_var='LD_RUN_PATH' + + case $cc_basename in + CC*) + _LT_TAGVAR(archive_cmds, $1)='$CC -G ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -G ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(old_archive_cmds, $1)='$CC -Tprelink_objects $oldobjs~ + '"$_LT_TAGVAR(old_archive_cmds, $1)" + _LT_TAGVAR(reload_cmds, $1)='$CC -Tprelink_objects $reload_objs~ + '"$_LT_TAGVAR(reload_cmds, $1)" + ;; + *) + _LT_TAGVAR(archive_cmds, $1)='$CC -shared ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + _LT_TAGVAR(archive_expsym_cmds, $1)='$CC -shared ${wl}-Bexport:$export_symbols ${wl}-h,$soname -o $lib $libobjs $deplibs $compiler_flags' + ;; + esac + ;; + + tandem*) + case $cc_basename in + NCC*) + # NonStop-UX NCC 3.20 + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + *) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + ;; + + vxworks*) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + + *) + # FIXME: insert proper C++ library support + _LT_TAGVAR(ld_shlibs, $1)=no + ;; + esac + + AC_MSG_RESULT([$_LT_TAGVAR(ld_shlibs, $1)]) + test "$_LT_TAGVAR(ld_shlibs, $1)" = no && can_build_shared=no + + _LT_TAGVAR(GCC, $1)="$GXX" + _LT_TAGVAR(LD, $1)="$LD" + + ## CAVEAT EMPTOR: + ## There is no encapsulation within the following macros, do not change + ## the running order or otherwise move them around unless you know exactly + ## what you are doing... + _LT_SYS_HIDDEN_LIBDEPS($1) + _LT_COMPILER_PIC($1) + _LT_COMPILER_C_O($1) + _LT_COMPILER_FILE_LOCKS($1) + _LT_LINKER_SHLIBS($1) + _LT_SYS_DYNAMIC_LINKER($1) + _LT_LINKER_HARDCODE_LIBPATH($1) + + _LT_CONFIG($1) + fi # test -n "$compiler" + + CC=$lt_save_CC + CFLAGS=$lt_save_CFLAGS + LDCXX=$LD + LD=$lt_save_LD + GCC=$lt_save_GCC + with_gnu_ld=$lt_save_with_gnu_ld + lt_cv_path_LDCXX=$lt_cv_path_LD + lt_cv_path_LD=$lt_save_path_LD + lt_cv_prog_gnu_ldcxx=$lt_cv_prog_gnu_ld + lt_cv_prog_gnu_ld=$lt_save_with_gnu_ld +fi # test "$_lt_caught_CXX_error" != yes + +AC_LANG_POP +])# _LT_LANG_CXX_CONFIG + + +# _LT_FUNC_STRIPNAME_CNF +# ---------------------- +# func_stripname_cnf prefix suffix name +# strip PREFIX and SUFFIX off of NAME. +# PREFIX and SUFFIX must not contain globbing or regex special +# characters, hashes, percent signs, but SUFFIX may contain a leading +# dot (in which case that matches only a dot). +# +# This function is identical to the (non-XSI) version of func_stripname, +# except this one can be used by m4 code that may be executed by configure, +# rather than the libtool script. +m4_defun([_LT_FUNC_STRIPNAME_CNF],[dnl +AC_REQUIRE([_LT_DECL_SED]) +AC_REQUIRE([_LT_PROG_ECHO_BACKSLASH]) +func_stripname_cnf () +{ + case ${2} in + .*) func_stripname_result=`$ECHO "${3}" | $SED "s%^${1}%%; s%\\\\${2}\$%%"`;; + *) func_stripname_result=`$ECHO "${3}" | $SED "s%^${1}%%; s%${2}\$%%"`;; + esac +} # func_stripname_cnf +])# _LT_FUNC_STRIPNAME_CNF + +# _LT_SYS_HIDDEN_LIBDEPS([TAGNAME]) +# --------------------------------- +# Figure out "hidden" library dependencies from verbose +# compiler output when linking a shared library. +# Parse the compiler output and extract the necessary +# objects, libraries and library flags. +m4_defun([_LT_SYS_HIDDEN_LIBDEPS], +[m4_require([_LT_FILEUTILS_DEFAULTS])dnl +AC_REQUIRE([_LT_FUNC_STRIPNAME_CNF])dnl +# Dependencies to place before and after the object being linked: +_LT_TAGVAR(predep_objects, $1)= +_LT_TAGVAR(postdep_objects, $1)= +_LT_TAGVAR(predeps, $1)= +_LT_TAGVAR(postdeps, $1)= +_LT_TAGVAR(compiler_lib_search_path, $1)= + +dnl we can't use the lt_simple_compile_test_code here, +dnl because it contains code intended for an executable, +dnl not a library. It's possible we should let each +dnl tag define a new lt_????_link_test_code variable, +dnl but it's only used here... +m4_if([$1], [], [cat > conftest.$ac_ext <<_LT_EOF +int a; +void foo (void) { a = 0; } +_LT_EOF +], [$1], [CXX], [cat > conftest.$ac_ext <<_LT_EOF +class Foo +{ +public: + Foo (void) { a = 0; } +private: + int a; +}; +_LT_EOF +], [$1], [F77], [cat > conftest.$ac_ext <<_LT_EOF + subroutine foo + implicit none + integer*4 a + a=0 + return + end +_LT_EOF +], [$1], [FC], [cat > conftest.$ac_ext <<_LT_EOF + subroutine foo + implicit none + integer a + a=0 + return + end +_LT_EOF +], [$1], [GCJ], [cat > conftest.$ac_ext <<_LT_EOF +public class foo { + private int a; + public void bar (void) { + a = 0; + } +}; +_LT_EOF +], [$1], [GO], [cat > conftest.$ac_ext <<_LT_EOF +package foo +func foo() { +} +_LT_EOF +]) + +_lt_libdeps_save_CFLAGS=$CFLAGS +case "$CC $CFLAGS " in #( +*\ -flto*\ *) CFLAGS="$CFLAGS -fno-lto" ;; +*\ -fwhopr*\ *) CFLAGS="$CFLAGS -fno-whopr" ;; +*\ -fuse-linker-plugin*\ *) CFLAGS="$CFLAGS -fno-use-linker-plugin" ;; +esac + +dnl Parse the compiler output and extract the necessary +dnl objects, libraries and library flags. +if AC_TRY_EVAL(ac_compile); then + # Parse the compiler output and extract the necessary + # objects, libraries and library flags. + + # Sentinel used to keep track of whether or not we are before + # the conftest object file. + pre_test_object_deps_done=no + + for p in `eval "$output_verbose_link_cmd"`; do + case ${prev}${p} in + + -L* | -R* | -l*) + # Some compilers place space between "-{L,R}" and the path. + # Remove the space. + if test $p = "-L" || + test $p = "-R"; then + prev=$p + continue + fi + + # Expand the sysroot to ease extracting the directories later. + if test -z "$prev"; then + case $p in + -L*) func_stripname_cnf '-L' '' "$p"; prev=-L; p=$func_stripname_result ;; + -R*) func_stripname_cnf '-R' '' "$p"; prev=-R; p=$func_stripname_result ;; + -l*) func_stripname_cnf '-l' '' "$p"; prev=-l; p=$func_stripname_result ;; + esac + fi + case $p in + =*) func_stripname_cnf '=' '' "$p"; p=$lt_sysroot$func_stripname_result ;; + esac + if test "$pre_test_object_deps_done" = no; then + case ${prev} in + -L | -R) + # Internal compiler library paths should come after those + # provided the user. The postdeps already come after the + # user supplied libs so there is no need to process them. + if test -z "$_LT_TAGVAR(compiler_lib_search_path, $1)"; then + _LT_TAGVAR(compiler_lib_search_path, $1)="${prev}${p}" + else + _LT_TAGVAR(compiler_lib_search_path, $1)="${_LT_TAGVAR(compiler_lib_search_path, $1)} ${prev}${p}" + fi + ;; + # The "-l" case would never come before the object being + # linked, so don't bother handling this case. + esac + else + if test -z "$_LT_TAGVAR(postdeps, $1)"; then + _LT_TAGVAR(postdeps, $1)="${prev}${p}" + else + _LT_TAGVAR(postdeps, $1)="${_LT_TAGVAR(postdeps, $1)} ${prev}${p}" + fi + fi + prev= + ;; + + *.lto.$objext) ;; # Ignore GCC LTO objects + *.$objext) + # This assumes that the test object file only shows up + # once in the compiler output. + if test "$p" = "conftest.$objext"; then + pre_test_object_deps_done=yes + continue + fi + + if test "$pre_test_object_deps_done" = no; then + if test -z "$_LT_TAGVAR(predep_objects, $1)"; then + _LT_TAGVAR(predep_objects, $1)="$p" + else + _LT_TAGVAR(predep_objects, $1)="$_LT_TAGVAR(predep_objects, $1) $p" + fi + else + if test -z "$_LT_TAGVAR(postdep_objects, $1)"; then + _LT_TAGVAR(postdep_objects, $1)="$p" + else + _LT_TAGVAR(postdep_objects, $1)="$_LT_TAGVAR(postdep_objects, $1) $p" + fi + fi + ;; + + *) ;; # Ignore the rest. + + esac + done + + # Clean up. + rm -f a.out a.exe +else + echo "libtool.m4: error: problem compiling $1 test program" +fi + +$RM -f confest.$objext +CFLAGS=$_lt_libdeps_save_CFLAGS + +# PORTME: override above test on systems where it is broken +m4_if([$1], [CXX], +[case $host_os in +interix[[3-9]]*) + # Interix 3.5 installs completely hosed .la files for C++, so rather than + # hack all around it, let's just trust "g++" to DTRT. + _LT_TAGVAR(predep_objects,$1)= + _LT_TAGVAR(postdep_objects,$1)= + _LT_TAGVAR(postdeps,$1)= + ;; + +linux*) + case `$CC -V 2>&1 | sed 5q` in + *Sun\ C*) + # Sun C++ 5.9 + + # The more standards-conforming stlport4 library is + # incompatible with the Cstd library. Avoid specifying + # it if it's in CXXFLAGS. Ignore libCrun as + # -library=stlport4 depends on it. + case " $CXX $CXXFLAGS " in + *" -library=stlport4 "*) + solaris_use_stlport4=yes + ;; + esac + + if test "$solaris_use_stlport4" != yes; then + _LT_TAGVAR(postdeps,$1)='-library=Cstd -library=Crun' + fi + ;; + esac + ;; + +solaris*) + case $cc_basename in + CC* | sunCC*) + # The more standards-conforming stlport4 library is + # incompatible with the Cstd library. Avoid specifying + # it if it's in CXXFLAGS. Ignore libCrun as + # -library=stlport4 depends on it. + case " $CXX $CXXFLAGS " in + *" -library=stlport4 "*) + solaris_use_stlport4=yes + ;; + esac + + # Adding this requires a known-good setup of shared libraries for + # Sun compiler versions before 5.6, else PIC objects from an old + # archive will be linked into the output, leading to subtle bugs. + if test "$solaris_use_stlport4" != yes; then + _LT_TAGVAR(postdeps,$1)='-library=Cstd -library=Crun' + fi + ;; + esac + ;; +esac +]) + +case " $_LT_TAGVAR(postdeps, $1) " in +*" -lc "*) _LT_TAGVAR(archive_cmds_need_lc, $1)=no ;; +esac + _LT_TAGVAR(compiler_lib_search_dirs, $1)= +if test -n "${_LT_TAGVAR(compiler_lib_search_path, $1)}"; then + _LT_TAGVAR(compiler_lib_search_dirs, $1)=`echo " ${_LT_TAGVAR(compiler_lib_search_path, $1)}" | ${SED} -e 's! -L! !g' -e 's!^ !!'` +fi +_LT_TAGDECL([], [compiler_lib_search_dirs], [1], + [The directories searched by this compiler when creating a shared library]) +_LT_TAGDECL([], [predep_objects], [1], + [Dependencies to place before and after the objects being linked to + create a shared library]) +_LT_TAGDECL([], [postdep_objects], [1]) +_LT_TAGDECL([], [predeps], [1]) +_LT_TAGDECL([], [postdeps], [1]) +_LT_TAGDECL([], [compiler_lib_search_path], [1], + [The library search path used internally by the compiler when linking + a shared library]) +])# _LT_SYS_HIDDEN_LIBDEPS + + +# _LT_LANG_F77_CONFIG([TAG]) +# -------------------------- +# Ensure that the configuration variables for a Fortran 77 compiler are +# suitably defined. These variables are subsequently used by _LT_CONFIG +# to write the compiler configuration to `libtool'. +m4_defun([_LT_LANG_F77_CONFIG], +[AC_LANG_PUSH(Fortran 77) +if test -z "$F77" || test "X$F77" = "Xno"; then + _lt_disable_F77=yes +fi + +_LT_TAGVAR(archive_cmds_need_lc, $1)=no +_LT_TAGVAR(allow_undefined_flag, $1)= +_LT_TAGVAR(always_export_symbols, $1)=no +_LT_TAGVAR(archive_expsym_cmds, $1)= +_LT_TAGVAR(export_dynamic_flag_spec, $1)= +_LT_TAGVAR(hardcode_direct, $1)=no +_LT_TAGVAR(hardcode_direct_absolute, $1)=no +_LT_TAGVAR(hardcode_libdir_flag_spec, $1)= +_LT_TAGVAR(hardcode_libdir_separator, $1)= +_LT_TAGVAR(hardcode_minus_L, $1)=no +_LT_TAGVAR(hardcode_automatic, $1)=no +_LT_TAGVAR(inherit_rpath, $1)=no +_LT_TAGVAR(module_cmds, $1)= +_LT_TAGVAR(module_expsym_cmds, $1)= +_LT_TAGVAR(link_all_deplibs, $1)=unknown +_LT_TAGVAR(old_archive_cmds, $1)=$old_archive_cmds +_LT_TAGVAR(reload_flag, $1)=$reload_flag +_LT_TAGVAR(reload_cmds, $1)=$reload_cmds +_LT_TAGVAR(no_undefined_flag, $1)= +_LT_TAGVAR(whole_archive_flag_spec, $1)= +_LT_TAGVAR(enable_shared_with_static_runtimes, $1)=no + +# Source file extension for f77 test sources. +ac_ext=f + +# Object file extension for compiled f77 test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# No sense in running all these tests if we already determined that +# the F77 compiler isn't working. Some variables (like enable_shared) +# are currently assumed to apply to all compilers on this platform, +# and will be corrupted by setting them based on a non-working compiler. +if test "$_lt_disable_F77" != yes; then + # Code to be used in simple compile tests + lt_simple_compile_test_code="\ + subroutine t + return + end +" + + # Code to be used in simple link tests + lt_simple_link_test_code="\ + program t + end +" + + # ltmain only uses $CC for tagged configurations so make sure $CC is set. + _LT_TAG_COMPILER + + # save warnings/boilerplate of simple test code + _LT_COMPILER_BOILERPLATE + _LT_LINKER_BOILERPLATE + + # Allow CC to be a program name with arguments. + lt_save_CC="$CC" + lt_save_GCC=$GCC + lt_save_CFLAGS=$CFLAGS + CC=${F77-"f77"} + CFLAGS=$FFLAGS + compiler=$CC + _LT_TAGVAR(compiler, $1)=$CC + _LT_CC_BASENAME([$compiler]) + GCC=$G77 + if test -n "$compiler"; then + AC_MSG_CHECKING([if libtool supports shared libraries]) + AC_MSG_RESULT([$can_build_shared]) + + AC_MSG_CHECKING([whether to build shared libraries]) + test "$can_build_shared" = "no" && enable_shared=no + + # On AIX, shared libraries and static libraries use the same namespace, and + # are all built from PIC. + case $host_os in + aix3*) + test "$enable_shared" = yes && enable_static=no + if test -n "$RANLIB"; then + archive_cmds="$archive_cmds~\$RANLIB \$lib" + postinstall_cmds='$RANLIB $lib' + fi + ;; + aix[[4-9]]*) + if test "$host_cpu" != ia64 && test "$aix_use_runtimelinking" = no ; then + test "$enable_shared" = yes && enable_static=no + fi + ;; + esac + AC_MSG_RESULT([$enable_shared]) + + AC_MSG_CHECKING([whether to build static libraries]) + # Make sure either enable_shared or enable_static is yes. + test "$enable_shared" = yes || enable_static=yes + AC_MSG_RESULT([$enable_static]) + + _LT_TAGVAR(GCC, $1)="$G77" + _LT_TAGVAR(LD, $1)="$LD" + + ## CAVEAT EMPTOR: + ## There is no encapsulation within the following macros, do not change + ## the running order or otherwise move them around unless you know exactly + ## what you are doing... + _LT_COMPILER_PIC($1) + _LT_COMPILER_C_O($1) + _LT_COMPILER_FILE_LOCKS($1) + _LT_LINKER_SHLIBS($1) + _LT_SYS_DYNAMIC_LINKER($1) + _LT_LINKER_HARDCODE_LIBPATH($1) + + _LT_CONFIG($1) + fi # test -n "$compiler" + + GCC=$lt_save_GCC + CC="$lt_save_CC" + CFLAGS="$lt_save_CFLAGS" +fi # test "$_lt_disable_F77" != yes + +AC_LANG_POP +])# _LT_LANG_F77_CONFIG + + +# _LT_LANG_FC_CONFIG([TAG]) +# ------------------------- +# Ensure that the configuration variables for a Fortran compiler are +# suitably defined. These variables are subsequently used by _LT_CONFIG +# to write the compiler configuration to `libtool'. +m4_defun([_LT_LANG_FC_CONFIG], +[AC_LANG_PUSH(Fortran) + +if test -z "$FC" || test "X$FC" = "Xno"; then + _lt_disable_FC=yes +fi + +_LT_TAGVAR(archive_cmds_need_lc, $1)=no +_LT_TAGVAR(allow_undefined_flag, $1)= +_LT_TAGVAR(always_export_symbols, $1)=no +_LT_TAGVAR(archive_expsym_cmds, $1)= +_LT_TAGVAR(export_dynamic_flag_spec, $1)= +_LT_TAGVAR(hardcode_direct, $1)=no +_LT_TAGVAR(hardcode_direct_absolute, $1)=no +_LT_TAGVAR(hardcode_libdir_flag_spec, $1)= +_LT_TAGVAR(hardcode_libdir_separator, $1)= +_LT_TAGVAR(hardcode_minus_L, $1)=no +_LT_TAGVAR(hardcode_automatic, $1)=no +_LT_TAGVAR(inherit_rpath, $1)=no +_LT_TAGVAR(module_cmds, $1)= +_LT_TAGVAR(module_expsym_cmds, $1)= +_LT_TAGVAR(link_all_deplibs, $1)=unknown +_LT_TAGVAR(old_archive_cmds, $1)=$old_archive_cmds +_LT_TAGVAR(reload_flag, $1)=$reload_flag +_LT_TAGVAR(reload_cmds, $1)=$reload_cmds +_LT_TAGVAR(no_undefined_flag, $1)= +_LT_TAGVAR(whole_archive_flag_spec, $1)= +_LT_TAGVAR(enable_shared_with_static_runtimes, $1)=no + +# Source file extension for fc test sources. +ac_ext=${ac_fc_srcext-f} + +# Object file extension for compiled fc test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# No sense in running all these tests if we already determined that +# the FC compiler isn't working. Some variables (like enable_shared) +# are currently assumed to apply to all compilers on this platform, +# and will be corrupted by setting them based on a non-working compiler. +if test "$_lt_disable_FC" != yes; then + # Code to be used in simple compile tests + lt_simple_compile_test_code="\ + subroutine t + return + end +" + + # Code to be used in simple link tests + lt_simple_link_test_code="\ + program t + end +" + + # ltmain only uses $CC for tagged configurations so make sure $CC is set. + _LT_TAG_COMPILER + + # save warnings/boilerplate of simple test code + _LT_COMPILER_BOILERPLATE + _LT_LINKER_BOILERPLATE + + # Allow CC to be a program name with arguments. + lt_save_CC="$CC" + lt_save_GCC=$GCC + lt_save_CFLAGS=$CFLAGS + CC=${FC-"f95"} + CFLAGS=$FCFLAGS + compiler=$CC + GCC=$ac_cv_fc_compiler_gnu + + _LT_TAGVAR(compiler, $1)=$CC + _LT_CC_BASENAME([$compiler]) + + if test -n "$compiler"; then + AC_MSG_CHECKING([if libtool supports shared libraries]) + AC_MSG_RESULT([$can_build_shared]) + + AC_MSG_CHECKING([whether to build shared libraries]) + test "$can_build_shared" = "no" && enable_shared=no + + # On AIX, shared libraries and static libraries use the same namespace, and + # are all built from PIC. + case $host_os in + aix3*) + test "$enable_shared" = yes && enable_static=no + if test -n "$RANLIB"; then + archive_cmds="$archive_cmds~\$RANLIB \$lib" + postinstall_cmds='$RANLIB $lib' + fi + ;; + aix[[4-9]]*) + if test "$host_cpu" != ia64 && test "$aix_use_runtimelinking" = no ; then + test "$enable_shared" = yes && enable_static=no + fi + ;; + esac + AC_MSG_RESULT([$enable_shared]) + + AC_MSG_CHECKING([whether to build static libraries]) + # Make sure either enable_shared or enable_static is yes. + test "$enable_shared" = yes || enable_static=yes + AC_MSG_RESULT([$enable_static]) + + _LT_TAGVAR(GCC, $1)="$ac_cv_fc_compiler_gnu" + _LT_TAGVAR(LD, $1)="$LD" + + ## CAVEAT EMPTOR: + ## There is no encapsulation within the following macros, do not change + ## the running order or otherwise move them around unless you know exactly + ## what you are doing... + _LT_SYS_HIDDEN_LIBDEPS($1) + _LT_COMPILER_PIC($1) + _LT_COMPILER_C_O($1) + _LT_COMPILER_FILE_LOCKS($1) + _LT_LINKER_SHLIBS($1) + _LT_SYS_DYNAMIC_LINKER($1) + _LT_LINKER_HARDCODE_LIBPATH($1) + + _LT_CONFIG($1) + fi # test -n "$compiler" + + GCC=$lt_save_GCC + CC=$lt_save_CC + CFLAGS=$lt_save_CFLAGS +fi # test "$_lt_disable_FC" != yes + +AC_LANG_POP +])# _LT_LANG_FC_CONFIG + + +# _LT_LANG_GCJ_CONFIG([TAG]) +# -------------------------- +# Ensure that the configuration variables for the GNU Java Compiler compiler +# are suitably defined. These variables are subsequently used by _LT_CONFIG +# to write the compiler configuration to `libtool'. +m4_defun([_LT_LANG_GCJ_CONFIG], +[AC_REQUIRE([LT_PROG_GCJ])dnl +AC_LANG_SAVE + +# Source file extension for Java test sources. +ac_ext=java + +# Object file extension for compiled Java test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# Code to be used in simple compile tests +lt_simple_compile_test_code="class foo {}" + +# Code to be used in simple link tests +lt_simple_link_test_code='public class conftest { public static void main(String[[]] argv) {}; }' + +# ltmain only uses $CC for tagged configurations so make sure $CC is set. +_LT_TAG_COMPILER + +# save warnings/boilerplate of simple test code +_LT_COMPILER_BOILERPLATE +_LT_LINKER_BOILERPLATE + +# Allow CC to be a program name with arguments. +lt_save_CC=$CC +lt_save_CFLAGS=$CFLAGS +lt_save_GCC=$GCC +GCC=yes +CC=${GCJ-"gcj"} +CFLAGS=$GCJFLAGS +compiler=$CC +_LT_TAGVAR(compiler, $1)=$CC +_LT_TAGVAR(LD, $1)="$LD" +_LT_CC_BASENAME([$compiler]) + +# GCJ did not exist at the time GCC didn't implicitly link libc in. +_LT_TAGVAR(archive_cmds_need_lc, $1)=no + +_LT_TAGVAR(old_archive_cmds, $1)=$old_archive_cmds +_LT_TAGVAR(reload_flag, $1)=$reload_flag +_LT_TAGVAR(reload_cmds, $1)=$reload_cmds + +## CAVEAT EMPTOR: +## There is no encapsulation within the following macros, do not change +## the running order or otherwise move them around unless you know exactly +## what you are doing... +if test -n "$compiler"; then + _LT_COMPILER_NO_RTTI($1) + _LT_COMPILER_PIC($1) + _LT_COMPILER_C_O($1) + _LT_COMPILER_FILE_LOCKS($1) + _LT_LINKER_SHLIBS($1) + _LT_LINKER_HARDCODE_LIBPATH($1) + + _LT_CONFIG($1) +fi + +AC_LANG_RESTORE + +GCC=$lt_save_GCC +CC=$lt_save_CC +CFLAGS=$lt_save_CFLAGS +])# _LT_LANG_GCJ_CONFIG + + +# _LT_LANG_GO_CONFIG([TAG]) +# -------------------------- +# Ensure that the configuration variables for the GNU Go compiler +# are suitably defined. These variables are subsequently used by _LT_CONFIG +# to write the compiler configuration to `libtool'. +m4_defun([_LT_LANG_GO_CONFIG], +[AC_REQUIRE([LT_PROG_GO])dnl +AC_LANG_SAVE + +# Source file extension for Go test sources. +ac_ext=go + +# Object file extension for compiled Go test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# Code to be used in simple compile tests +lt_simple_compile_test_code="package main; func main() { }" + +# Code to be used in simple link tests +lt_simple_link_test_code='package main; func main() { }' + +# ltmain only uses $CC for tagged configurations so make sure $CC is set. +_LT_TAG_COMPILER + +# save warnings/boilerplate of simple test code +_LT_COMPILER_BOILERPLATE +_LT_LINKER_BOILERPLATE + +# Allow CC to be a program name with arguments. +lt_save_CC=$CC +lt_save_CFLAGS=$CFLAGS +lt_save_GCC=$GCC +GCC=yes +CC=${GOC-"gccgo"} +CFLAGS=$GOFLAGS +compiler=$CC +_LT_TAGVAR(compiler, $1)=$CC +_LT_TAGVAR(LD, $1)="$LD" +_LT_CC_BASENAME([$compiler]) + +# Go did not exist at the time GCC didn't implicitly link libc in. +_LT_TAGVAR(archive_cmds_need_lc, $1)=no + +_LT_TAGVAR(old_archive_cmds, $1)=$old_archive_cmds +_LT_TAGVAR(reload_flag, $1)=$reload_flag +_LT_TAGVAR(reload_cmds, $1)=$reload_cmds + +## CAVEAT EMPTOR: +## There is no encapsulation within the following macros, do not change +## the running order or otherwise move them around unless you know exactly +## what you are doing... +if test -n "$compiler"; then + _LT_COMPILER_NO_RTTI($1) + _LT_COMPILER_PIC($1) + _LT_COMPILER_C_O($1) + _LT_COMPILER_FILE_LOCKS($1) + _LT_LINKER_SHLIBS($1) + _LT_LINKER_HARDCODE_LIBPATH($1) + + _LT_CONFIG($1) +fi + +AC_LANG_RESTORE + +GCC=$lt_save_GCC +CC=$lt_save_CC +CFLAGS=$lt_save_CFLAGS +])# _LT_LANG_GO_CONFIG + + +# _LT_LANG_RC_CONFIG([TAG]) +# ------------------------- +# Ensure that the configuration variables for the Windows resource compiler +# are suitably defined. These variables are subsequently used by _LT_CONFIG +# to write the compiler configuration to `libtool'. +m4_defun([_LT_LANG_RC_CONFIG], +[AC_REQUIRE([LT_PROG_RC])dnl +AC_LANG_SAVE + +# Source file extension for RC test sources. +ac_ext=rc + +# Object file extension for compiled RC test sources. +objext=o +_LT_TAGVAR(objext, $1)=$objext + +# Code to be used in simple compile tests +lt_simple_compile_test_code='sample MENU { MENUITEM "&Soup", 100, CHECKED }' + +# Code to be used in simple link tests +lt_simple_link_test_code="$lt_simple_compile_test_code" + +# ltmain only uses $CC for tagged configurations so make sure $CC is set. +_LT_TAG_COMPILER + +# save warnings/boilerplate of simple test code +_LT_COMPILER_BOILERPLATE +_LT_LINKER_BOILERPLATE + +# Allow CC to be a program name with arguments. +lt_save_CC="$CC" +lt_save_CFLAGS=$CFLAGS +lt_save_GCC=$GCC +GCC= +CC=${RC-"windres"} +CFLAGS= +compiler=$CC +_LT_TAGVAR(compiler, $1)=$CC +_LT_CC_BASENAME([$compiler]) +_LT_TAGVAR(lt_cv_prog_compiler_c_o, $1)=yes + +if test -n "$compiler"; then + : + _LT_CONFIG($1) +fi + +GCC=$lt_save_GCC +AC_LANG_RESTORE +CC=$lt_save_CC +CFLAGS=$lt_save_CFLAGS +])# _LT_LANG_RC_CONFIG + + +# LT_PROG_GCJ +# ----------- +AC_DEFUN([LT_PROG_GCJ], +[m4_ifdef([AC_PROG_GCJ], [AC_PROG_GCJ], + [m4_ifdef([A][M_PROG_GCJ], [A][M_PROG_GCJ], + [AC_CHECK_TOOL(GCJ, gcj,) + test "x${GCJFLAGS+set}" = xset || GCJFLAGS="-g -O2" + AC_SUBST(GCJFLAGS)])])[]dnl +]) + +# Old name: +AU_ALIAS([LT_AC_PROG_GCJ], [LT_PROG_GCJ]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([LT_AC_PROG_GCJ], []) + + +# LT_PROG_GO +# ---------- +AC_DEFUN([LT_PROG_GO], +[AC_CHECK_TOOL(GOC, gccgo,) +]) + + +# LT_PROG_RC +# ---------- +AC_DEFUN([LT_PROG_RC], +[AC_CHECK_TOOL(RC, windres,) +]) + +# Old name: +AU_ALIAS([LT_AC_PROG_RC], [LT_PROG_RC]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([LT_AC_PROG_RC], []) + + +# _LT_DECL_EGREP +# -------------- +# If we don't have a new enough Autoconf to choose the best grep +# available, choose the one first in the user's PATH. +m4_defun([_LT_DECL_EGREP], +[AC_REQUIRE([AC_PROG_EGREP])dnl +AC_REQUIRE([AC_PROG_FGREP])dnl +test -z "$GREP" && GREP=grep +_LT_DECL([], [GREP], [1], [A grep program that handles long lines]) +_LT_DECL([], [EGREP], [1], [An ERE matcher]) +_LT_DECL([], [FGREP], [1], [A literal string matcher]) +dnl Non-bleeding-edge autoconf doesn't subst GREP, so do it here too +AC_SUBST([GREP]) +]) + + +# _LT_DECL_OBJDUMP +# -------------- +# If we don't have a new enough Autoconf to choose the best objdump +# available, choose the one first in the user's PATH. +m4_defun([_LT_DECL_OBJDUMP], +[AC_CHECK_TOOL(OBJDUMP, objdump, false) +test -z "$OBJDUMP" && OBJDUMP=objdump +_LT_DECL([], [OBJDUMP], [1], [An object symbol dumper]) +AC_SUBST([OBJDUMP]) +]) + +# _LT_DECL_DLLTOOL +# ---------------- +# Ensure DLLTOOL variable is set. +m4_defun([_LT_DECL_DLLTOOL], +[AC_CHECK_TOOL(DLLTOOL, dlltool, false) +test -z "$DLLTOOL" && DLLTOOL=dlltool +_LT_DECL([], [DLLTOOL], [1], [DLL creation program]) +AC_SUBST([DLLTOOL]) +]) + +# _LT_DECL_SED +# ------------ +# Check for a fully-functional sed program, that truncates +# as few characters as possible. Prefer GNU sed if found. +m4_defun([_LT_DECL_SED], +[AC_PROG_SED +test -z "$SED" && SED=sed +Xsed="$SED -e 1s/^X//" +_LT_DECL([], [SED], [1], [A sed program that does not truncate output]) +_LT_DECL([], [Xsed], ["\$SED -e 1s/^X//"], + [Sed that helps us avoid accidentally triggering echo(1) options like -n]) +])# _LT_DECL_SED + +m4_ifndef([AC_PROG_SED], [ +############################################################ +# NOTE: This macro has been submitted for inclusion into # +# GNU Autoconf as AC_PROG_SED. When it is available in # +# a released version of Autoconf we should remove this # +# macro and use it instead. # +############################################################ + +m4_defun([AC_PROG_SED], +[AC_MSG_CHECKING([for a sed that does not truncate output]) +AC_CACHE_VAL(lt_cv_path_SED, +[# Loop through the user's path and test for sed and gsed. +# Then use that list of sed's as ones to test for truncation. +as_save_IFS=$IFS; IFS=$PATH_SEPARATOR +for as_dir in $PATH +do + IFS=$as_save_IFS + test -z "$as_dir" && as_dir=. + for lt_ac_prog in sed gsed; do + for ac_exec_ext in '' $ac_executable_extensions; do + if $as_executable_p "$as_dir/$lt_ac_prog$ac_exec_ext"; then + lt_ac_sed_list="$lt_ac_sed_list $as_dir/$lt_ac_prog$ac_exec_ext" + fi + done + done +done +IFS=$as_save_IFS +lt_ac_max=0 +lt_ac_count=0 +# Add /usr/xpg4/bin/sed as it is typically found on Solaris +# along with /bin/sed that truncates output. +for lt_ac_sed in $lt_ac_sed_list /usr/xpg4/bin/sed; do + test ! -f $lt_ac_sed && continue + cat /dev/null > conftest.in + lt_ac_count=0 + echo $ECHO_N "0123456789$ECHO_C" >conftest.in + # Check for GNU sed and select it if it is found. + if "$lt_ac_sed" --version 2>&1 < /dev/null | grep 'GNU' > /dev/null; then + lt_cv_path_SED=$lt_ac_sed + break + fi + while true; do + cat conftest.in conftest.in >conftest.tmp + mv conftest.tmp conftest.in + cp conftest.in conftest.nl + echo >>conftest.nl + $lt_ac_sed -e 's/a$//' < conftest.nl >conftest.out || break + cmp -s conftest.out conftest.nl || break + # 10000 chars as input seems more than enough + test $lt_ac_count -gt 10 && break + lt_ac_count=`expr $lt_ac_count + 1` + if test $lt_ac_count -gt $lt_ac_max; then + lt_ac_max=$lt_ac_count + lt_cv_path_SED=$lt_ac_sed + fi + done +done +]) +SED=$lt_cv_path_SED +AC_SUBST([SED]) +AC_MSG_RESULT([$SED]) +])#AC_PROG_SED +])#m4_ifndef + +# Old name: +AU_ALIAS([LT_AC_PROG_SED], [AC_PROG_SED]) +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([LT_AC_PROG_SED], []) + + +# _LT_CHECK_SHELL_FEATURES +# ------------------------ +# Find out whether the shell is Bourne or XSI compatible, +# or has some other useful features. +m4_defun([_LT_CHECK_SHELL_FEATURES], +[AC_MSG_CHECKING([whether the shell understands some XSI constructs]) +# Try some XSI features +xsi_shell=no +( _lt_dummy="a/b/c" + test "${_lt_dummy##*/},${_lt_dummy%/*},${_lt_dummy#??}"${_lt_dummy%"$_lt_dummy"}, \ + = c,a/b,b/c, \ + && eval 'test $(( 1 + 1 )) -eq 2 \ + && test "${#_lt_dummy}" -eq 5' ) >/dev/null 2>&1 \ + && xsi_shell=yes +AC_MSG_RESULT([$xsi_shell]) +_LT_CONFIG_LIBTOOL_INIT([xsi_shell='$xsi_shell']) + +AC_MSG_CHECKING([whether the shell understands "+="]) +lt_shell_append=no +( foo=bar; set foo baz; eval "$[1]+=\$[2]" && test "$foo" = barbaz ) \ + >/dev/null 2>&1 \ + && lt_shell_append=yes +AC_MSG_RESULT([$lt_shell_append]) +_LT_CONFIG_LIBTOOL_INIT([lt_shell_append='$lt_shell_append']) + +if ( (MAIL=60; unset MAIL) || exit) >/dev/null 2>&1; then + lt_unset=unset +else + lt_unset=false +fi +_LT_DECL([], [lt_unset], [0], [whether the shell understands "unset"])dnl + +# test EBCDIC or ASCII +case `echo X|tr X '\101'` in + A) # ASCII based system + # \n is not interpreted correctly by Solaris 8 /usr/ucb/tr + lt_SP2NL='tr \040 \012' + lt_NL2SP='tr \015\012 \040\040' + ;; + *) # EBCDIC based system + lt_SP2NL='tr \100 \n' + lt_NL2SP='tr \r\n \100\100' + ;; +esac +_LT_DECL([SP2NL], [lt_SP2NL], [1], [turn spaces into newlines])dnl +_LT_DECL([NL2SP], [lt_NL2SP], [1], [turn newlines into spaces])dnl +])# _LT_CHECK_SHELL_FEATURES + + +# _LT_PROG_FUNCTION_REPLACE (FUNCNAME, REPLACEMENT-BODY) +# ------------------------------------------------------ +# In `$cfgfile', look for function FUNCNAME delimited by `^FUNCNAME ()$' and +# '^} FUNCNAME ', and replace its body with REPLACEMENT-BODY. +m4_defun([_LT_PROG_FUNCTION_REPLACE], +[dnl { +sed -e '/^$1 ()$/,/^} # $1 /c\ +$1 ()\ +{\ +m4_bpatsubsts([$2], [$], [\\], [^\([ ]\)], [\\\1]) +} # Extended-shell $1 implementation' "$cfgfile" > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") +test 0 -eq $? || _lt_function_replace_fail=: +]) + + +# _LT_PROG_REPLACE_SHELLFNS +# ------------------------- +# Replace existing portable implementations of several shell functions with +# equivalent extended shell implementations where those features are available.. +m4_defun([_LT_PROG_REPLACE_SHELLFNS], +[if test x"$xsi_shell" = xyes; then + _LT_PROG_FUNCTION_REPLACE([func_dirname], [dnl + case ${1} in + */*) func_dirname_result="${1%/*}${2}" ;; + * ) func_dirname_result="${3}" ;; + esac]) + + _LT_PROG_FUNCTION_REPLACE([func_basename], [dnl + func_basename_result="${1##*/}"]) + + _LT_PROG_FUNCTION_REPLACE([func_dirname_and_basename], [dnl + case ${1} in + */*) func_dirname_result="${1%/*}${2}" ;; + * ) func_dirname_result="${3}" ;; + esac + func_basename_result="${1##*/}"]) + + _LT_PROG_FUNCTION_REPLACE([func_stripname], [dnl + # pdksh 5.2.14 does not do ${X%$Y} correctly if both X and Y are + # positional parameters, so assign one to ordinary parameter first. + func_stripname_result=${3} + func_stripname_result=${func_stripname_result#"${1}"} + func_stripname_result=${func_stripname_result%"${2}"}]) + + _LT_PROG_FUNCTION_REPLACE([func_split_long_opt], [dnl + func_split_long_opt_name=${1%%=*} + func_split_long_opt_arg=${1#*=}]) + + _LT_PROG_FUNCTION_REPLACE([func_split_short_opt], [dnl + func_split_short_opt_arg=${1#??} + func_split_short_opt_name=${1%"$func_split_short_opt_arg"}]) + + _LT_PROG_FUNCTION_REPLACE([func_lo2o], [dnl + case ${1} in + *.lo) func_lo2o_result=${1%.lo}.${objext} ;; + *) func_lo2o_result=${1} ;; + esac]) + + _LT_PROG_FUNCTION_REPLACE([func_xform], [ func_xform_result=${1%.*}.lo]) + + _LT_PROG_FUNCTION_REPLACE([func_arith], [ func_arith_result=$(( $[*] ))]) + + _LT_PROG_FUNCTION_REPLACE([func_len], [ func_len_result=${#1}]) +fi + +if test x"$lt_shell_append" = xyes; then + _LT_PROG_FUNCTION_REPLACE([func_append], [ eval "${1}+=\\${2}"]) + + _LT_PROG_FUNCTION_REPLACE([func_append_quoted], [dnl + func_quote_for_eval "${2}" +dnl m4 expansion turns \\\\ into \\, and then the shell eval turns that into \ + eval "${1}+=\\\\ \\$func_quote_for_eval_result"]) + + # Save a `func_append' function call where possible by direct use of '+=' + sed -e 's%func_append \([[a-zA-Z_]]\{1,\}\) "%\1+="%g' $cfgfile > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") + test 0 -eq $? || _lt_function_replace_fail=: +else + # Save a `func_append' function call even when '+=' is not available + sed -e 's%func_append \([[a-zA-Z_]]\{1,\}\) "%\1="$\1%g' $cfgfile > $cfgfile.tmp \ + && mv -f "$cfgfile.tmp" "$cfgfile" \ + || (rm -f "$cfgfile" && cp "$cfgfile.tmp" "$cfgfile" && rm -f "$cfgfile.tmp") + test 0 -eq $? || _lt_function_replace_fail=: +fi + +if test x"$_lt_function_replace_fail" = x":"; then + AC_MSG_WARN([Unable to substitute extended shell functions in $ofile]) +fi +]) + +# _LT_PATH_CONVERSION_FUNCTIONS +# ----------------------------- +# Determine which file name conversion functions should be used by +# func_to_host_file (and, implicitly, by func_to_host_path). These are needed +# for certain cross-compile configurations and native mingw. +m4_defun([_LT_PATH_CONVERSION_FUNCTIONS], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +AC_REQUIRE([AC_CANONICAL_BUILD])dnl +AC_MSG_CHECKING([how to convert $build file names to $host format]) +AC_CACHE_VAL(lt_cv_to_host_file_cmd, +[case $host in + *-*-mingw* ) + case $build in + *-*-mingw* ) # actually msys + lt_cv_to_host_file_cmd=func_convert_file_msys_to_w32 + ;; + *-*-cygwin* ) + lt_cv_to_host_file_cmd=func_convert_file_cygwin_to_w32 + ;; + * ) # otherwise, assume *nix + lt_cv_to_host_file_cmd=func_convert_file_nix_to_w32 + ;; + esac + ;; + *-*-cygwin* ) + case $build in + *-*-mingw* ) # actually msys + lt_cv_to_host_file_cmd=func_convert_file_msys_to_cygwin + ;; + *-*-cygwin* ) + lt_cv_to_host_file_cmd=func_convert_file_noop + ;; + * ) # otherwise, assume *nix + lt_cv_to_host_file_cmd=func_convert_file_nix_to_cygwin + ;; + esac + ;; + * ) # unhandled hosts (and "normal" native builds) + lt_cv_to_host_file_cmd=func_convert_file_noop + ;; +esac +]) +to_host_file_cmd=$lt_cv_to_host_file_cmd +AC_MSG_RESULT([$lt_cv_to_host_file_cmd]) +_LT_DECL([to_host_file_cmd], [lt_cv_to_host_file_cmd], + [0], [convert $build file names to $host format])dnl + +AC_MSG_CHECKING([how to convert $build file names to toolchain format]) +AC_CACHE_VAL(lt_cv_to_tool_file_cmd, +[#assume ordinary cross tools, or native build. +lt_cv_to_tool_file_cmd=func_convert_file_noop +case $host in + *-*-mingw* ) + case $build in + *-*-mingw* ) # actually msys + lt_cv_to_tool_file_cmd=func_convert_file_msys_to_w32 + ;; + esac + ;; +esac +]) +to_tool_file_cmd=$lt_cv_to_tool_file_cmd +AC_MSG_RESULT([$lt_cv_to_tool_file_cmd]) +_LT_DECL([to_tool_file_cmd], [lt_cv_to_tool_file_cmd], + [0], [convert $build files to toolchain format])dnl +])# _LT_PATH_CONVERSION_FUNCTIONS diff --git a/libconfig-1.4.9/m4/ltoptions.m4 b/libconfig-1.4.9/m4/ltoptions.m4 new file mode 100644 index 0000000000000000000000000000000000000000..5d9acd8e23bcfd20d353804aff13666ecbed54f4 --- /dev/null +++ b/libconfig-1.4.9/m4/ltoptions.m4 @@ -0,0 +1,384 @@ +# Helper functions for option handling. -*- Autoconf -*- +# +# Copyright (C) 2004, 2005, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# Written by Gary V. Vaughan, 2004 +# +# This file is free software; the Free Software Foundation gives +# unlimited permission to copy and/or distribute it, with or without +# modifications, as long as this notice is preserved. + +# serial 7 ltoptions.m4 + +# This is to help aclocal find these macros, as it can't see m4_define. +AC_DEFUN([LTOPTIONS_VERSION], [m4_if([1])]) + + +# _LT_MANGLE_OPTION(MACRO-NAME, OPTION-NAME) +# ------------------------------------------ +m4_define([_LT_MANGLE_OPTION], +[[_LT_OPTION_]m4_bpatsubst($1__$2, [[^a-zA-Z0-9_]], [_])]) + + +# _LT_SET_OPTION(MACRO-NAME, OPTION-NAME) +# --------------------------------------- +# Set option OPTION-NAME for macro MACRO-NAME, and if there is a +# matching handler defined, dispatch to it. Other OPTION-NAMEs are +# saved as a flag. +m4_define([_LT_SET_OPTION], +[m4_define(_LT_MANGLE_OPTION([$1], [$2]))dnl +m4_ifdef(_LT_MANGLE_DEFUN([$1], [$2]), + _LT_MANGLE_DEFUN([$1], [$2]), + [m4_warning([Unknown $1 option `$2'])])[]dnl +]) + + +# _LT_IF_OPTION(MACRO-NAME, OPTION-NAME, IF-SET, [IF-NOT-SET]) +# ------------------------------------------------------------ +# Execute IF-SET if OPTION is set, IF-NOT-SET otherwise. +m4_define([_LT_IF_OPTION], +[m4_ifdef(_LT_MANGLE_OPTION([$1], [$2]), [$3], [$4])]) + + +# _LT_UNLESS_OPTIONS(MACRO-NAME, OPTION-LIST, IF-NOT-SET) +# ------------------------------------------------------- +# Execute IF-NOT-SET unless all options in OPTION-LIST for MACRO-NAME +# are set. +m4_define([_LT_UNLESS_OPTIONS], +[m4_foreach([_LT_Option], m4_split(m4_normalize([$2])), + [m4_ifdef(_LT_MANGLE_OPTION([$1], _LT_Option), + [m4_define([$0_found])])])[]dnl +m4_ifdef([$0_found], [m4_undefine([$0_found])], [$3 +])[]dnl +]) + + +# _LT_SET_OPTIONS(MACRO-NAME, OPTION-LIST) +# ---------------------------------------- +# OPTION-LIST is a space-separated list of Libtool options associated +# with MACRO-NAME. If any OPTION has a matching handler declared with +# LT_OPTION_DEFINE, dispatch to that macro; otherwise complain about +# the unknown option and exit. +m4_defun([_LT_SET_OPTIONS], +[# Set options +m4_foreach([_LT_Option], m4_split(m4_normalize([$2])), + [_LT_SET_OPTION([$1], _LT_Option)]) + +m4_if([$1],[LT_INIT],[ + dnl + dnl Simply set some default values (i.e off) if boolean options were not + dnl specified: + _LT_UNLESS_OPTIONS([LT_INIT], [dlopen], [enable_dlopen=no + ]) + _LT_UNLESS_OPTIONS([LT_INIT], [win32-dll], [enable_win32_dll=no + ]) + dnl + dnl If no reference was made to various pairs of opposing options, then + dnl we run the default mode handler for the pair. For example, if neither + dnl `shared' nor `disable-shared' was passed, we enable building of shared + dnl archives by default: + _LT_UNLESS_OPTIONS([LT_INIT], [shared disable-shared], [_LT_ENABLE_SHARED]) + _LT_UNLESS_OPTIONS([LT_INIT], [static disable-static], [_LT_ENABLE_STATIC]) + _LT_UNLESS_OPTIONS([LT_INIT], [pic-only no-pic], [_LT_WITH_PIC]) + _LT_UNLESS_OPTIONS([LT_INIT], [fast-install disable-fast-install], + [_LT_ENABLE_FAST_INSTALL]) + ]) +])# _LT_SET_OPTIONS + + +## --------------------------------- ## +## Macros to handle LT_INIT options. ## +## --------------------------------- ## + +# _LT_MANGLE_DEFUN(MACRO-NAME, OPTION-NAME) +# ----------------------------------------- +m4_define([_LT_MANGLE_DEFUN], +[[_LT_OPTION_DEFUN_]m4_bpatsubst(m4_toupper([$1__$2]), [[^A-Z0-9_]], [_])]) + + +# LT_OPTION_DEFINE(MACRO-NAME, OPTION-NAME, CODE) +# ----------------------------------------------- +m4_define([LT_OPTION_DEFINE], +[m4_define(_LT_MANGLE_DEFUN([$1], [$2]), [$3])[]dnl +])# LT_OPTION_DEFINE + + +# dlopen +# ------ +LT_OPTION_DEFINE([LT_INIT], [dlopen], [enable_dlopen=yes +]) + +AU_DEFUN([AC_LIBTOOL_DLOPEN], +[_LT_SET_OPTION([LT_INIT], [dlopen]) +AC_DIAGNOSE([obsolete], +[$0: Remove this warning and the call to _LT_SET_OPTION when you +put the `dlopen' option into LT_INIT's first parameter.]) +]) + +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_DLOPEN], []) + + +# win32-dll +# --------- +# Declare package support for building win32 dll's. +LT_OPTION_DEFINE([LT_INIT], [win32-dll], +[enable_win32_dll=yes + +case $host in +*-*-cygwin* | *-*-mingw* | *-*-pw32* | *-*-cegcc*) + AC_CHECK_TOOL(AS, as, false) + AC_CHECK_TOOL(DLLTOOL, dlltool, false) + AC_CHECK_TOOL(OBJDUMP, objdump, false) + ;; +esac + +test -z "$AS" && AS=as +_LT_DECL([], [AS], [1], [Assembler program])dnl + +test -z "$DLLTOOL" && DLLTOOL=dlltool +_LT_DECL([], [DLLTOOL], [1], [DLL creation program])dnl + +test -z "$OBJDUMP" && OBJDUMP=objdump +_LT_DECL([], [OBJDUMP], [1], [Object dumper program])dnl +])# win32-dll + +AU_DEFUN([AC_LIBTOOL_WIN32_DLL], +[AC_REQUIRE([AC_CANONICAL_HOST])dnl +_LT_SET_OPTION([LT_INIT], [win32-dll]) +AC_DIAGNOSE([obsolete], +[$0: Remove this warning and the call to _LT_SET_OPTION when you +put the `win32-dll' option into LT_INIT's first parameter.]) +]) + +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_WIN32_DLL], []) + + +# _LT_ENABLE_SHARED([DEFAULT]) +# ---------------------------- +# implement the --enable-shared flag, and supports the `shared' and +# `disable-shared' LT_INIT options. +# DEFAULT is either `yes' or `no'. If omitted, it defaults to `yes'. +m4_define([_LT_ENABLE_SHARED], +[m4_define([_LT_ENABLE_SHARED_DEFAULT], [m4_if($1, no, no, yes)])dnl +AC_ARG_ENABLE([shared], + [AS_HELP_STRING([--enable-shared@<:@=PKGS@:>@], + [build shared libraries @<:@default=]_LT_ENABLE_SHARED_DEFAULT[@:>@])], + [p=${PACKAGE-default} + case $enableval in + yes) enable_shared=yes ;; + no) enable_shared=no ;; + *) + enable_shared=no + # Look at the argument we got. We use all the common list separators. + lt_save_ifs="$IFS"; IFS="${IFS}$PATH_SEPARATOR," + for pkg in $enableval; do + IFS="$lt_save_ifs" + if test "X$pkg" = "X$p"; then + enable_shared=yes + fi + done + IFS="$lt_save_ifs" + ;; + esac], + [enable_shared=]_LT_ENABLE_SHARED_DEFAULT) + + _LT_DECL([build_libtool_libs], [enable_shared], [0], + [Whether or not to build shared libraries]) +])# _LT_ENABLE_SHARED + +LT_OPTION_DEFINE([LT_INIT], [shared], [_LT_ENABLE_SHARED([yes])]) +LT_OPTION_DEFINE([LT_INIT], [disable-shared], [_LT_ENABLE_SHARED([no])]) + +# Old names: +AC_DEFUN([AC_ENABLE_SHARED], +[_LT_SET_OPTION([LT_INIT], m4_if([$1], [no], [disable-])[shared]) +]) + +AC_DEFUN([AC_DISABLE_SHARED], +[_LT_SET_OPTION([LT_INIT], [disable-shared]) +]) + +AU_DEFUN([AM_ENABLE_SHARED], [AC_ENABLE_SHARED($@)]) +AU_DEFUN([AM_DISABLE_SHARED], [AC_DISABLE_SHARED($@)]) + +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AM_ENABLE_SHARED], []) +dnl AC_DEFUN([AM_DISABLE_SHARED], []) + + + +# _LT_ENABLE_STATIC([DEFAULT]) +# ---------------------------- +# implement the --enable-static flag, and support the `static' and +# `disable-static' LT_INIT options. +# DEFAULT is either `yes' or `no'. If omitted, it defaults to `yes'. +m4_define([_LT_ENABLE_STATIC], +[m4_define([_LT_ENABLE_STATIC_DEFAULT], [m4_if($1, no, no, yes)])dnl +AC_ARG_ENABLE([static], + [AS_HELP_STRING([--enable-static@<:@=PKGS@:>@], + [build static libraries @<:@default=]_LT_ENABLE_STATIC_DEFAULT[@:>@])], + [p=${PACKAGE-default} + case $enableval in + yes) enable_static=yes ;; + no) enable_static=no ;; + *) + enable_static=no + # Look at the argument we got. We use all the common list separators. + lt_save_ifs="$IFS"; IFS="${IFS}$PATH_SEPARATOR," + for pkg in $enableval; do + IFS="$lt_save_ifs" + if test "X$pkg" = "X$p"; then + enable_static=yes + fi + done + IFS="$lt_save_ifs" + ;; + esac], + [enable_static=]_LT_ENABLE_STATIC_DEFAULT) + + _LT_DECL([build_old_libs], [enable_static], [0], + [Whether or not to build static libraries]) +])# _LT_ENABLE_STATIC + +LT_OPTION_DEFINE([LT_INIT], [static], [_LT_ENABLE_STATIC([yes])]) +LT_OPTION_DEFINE([LT_INIT], [disable-static], [_LT_ENABLE_STATIC([no])]) + +# Old names: +AC_DEFUN([AC_ENABLE_STATIC], +[_LT_SET_OPTION([LT_INIT], m4_if([$1], [no], [disable-])[static]) +]) + +AC_DEFUN([AC_DISABLE_STATIC], +[_LT_SET_OPTION([LT_INIT], [disable-static]) +]) + +AU_DEFUN([AM_ENABLE_STATIC], [AC_ENABLE_STATIC($@)]) +AU_DEFUN([AM_DISABLE_STATIC], [AC_DISABLE_STATIC($@)]) + +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AM_ENABLE_STATIC], []) +dnl AC_DEFUN([AM_DISABLE_STATIC], []) + + + +# _LT_ENABLE_FAST_INSTALL([DEFAULT]) +# ---------------------------------- +# implement the --enable-fast-install flag, and support the `fast-install' +# and `disable-fast-install' LT_INIT options. +# DEFAULT is either `yes' or `no'. If omitted, it defaults to `yes'. +m4_define([_LT_ENABLE_FAST_INSTALL], +[m4_define([_LT_ENABLE_FAST_INSTALL_DEFAULT], [m4_if($1, no, no, yes)])dnl +AC_ARG_ENABLE([fast-install], + [AS_HELP_STRING([--enable-fast-install@<:@=PKGS@:>@], + [optimize for fast installation @<:@default=]_LT_ENABLE_FAST_INSTALL_DEFAULT[@:>@])], + [p=${PACKAGE-default} + case $enableval in + yes) enable_fast_install=yes ;; + no) enable_fast_install=no ;; + *) + enable_fast_install=no + # Look at the argument we got. We use all the common list separators. + lt_save_ifs="$IFS"; IFS="${IFS}$PATH_SEPARATOR," + for pkg in $enableval; do + IFS="$lt_save_ifs" + if test "X$pkg" = "X$p"; then + enable_fast_install=yes + fi + done + IFS="$lt_save_ifs" + ;; + esac], + [enable_fast_install=]_LT_ENABLE_FAST_INSTALL_DEFAULT) + +_LT_DECL([fast_install], [enable_fast_install], [0], + [Whether or not to optimize for fast installation])dnl +])# _LT_ENABLE_FAST_INSTALL + +LT_OPTION_DEFINE([LT_INIT], [fast-install], [_LT_ENABLE_FAST_INSTALL([yes])]) +LT_OPTION_DEFINE([LT_INIT], [disable-fast-install], [_LT_ENABLE_FAST_INSTALL([no])]) + +# Old names: +AU_DEFUN([AC_ENABLE_FAST_INSTALL], +[_LT_SET_OPTION([LT_INIT], m4_if([$1], [no], [disable-])[fast-install]) +AC_DIAGNOSE([obsolete], +[$0: Remove this warning and the call to _LT_SET_OPTION when you put +the `fast-install' option into LT_INIT's first parameter.]) +]) + +AU_DEFUN([AC_DISABLE_FAST_INSTALL], +[_LT_SET_OPTION([LT_INIT], [disable-fast-install]) +AC_DIAGNOSE([obsolete], +[$0: Remove this warning and the call to _LT_SET_OPTION when you put +the `disable-fast-install' option into LT_INIT's first parameter.]) +]) + +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_ENABLE_FAST_INSTALL], []) +dnl AC_DEFUN([AM_DISABLE_FAST_INSTALL], []) + + +# _LT_WITH_PIC([MODE]) +# -------------------- +# implement the --with-pic flag, and support the `pic-only' and `no-pic' +# LT_INIT options. +# MODE is either `yes' or `no'. If omitted, it defaults to `both'. +m4_define([_LT_WITH_PIC], +[AC_ARG_WITH([pic], + [AS_HELP_STRING([--with-pic@<:@=PKGS@:>@], + [try to use only PIC/non-PIC objects @<:@default=use both@:>@])], + [lt_p=${PACKAGE-default} + case $withval in + yes|no) pic_mode=$withval ;; + *) + pic_mode=default + # Look at the argument we got. We use all the common list separators. + lt_save_ifs="$IFS"; IFS="${IFS}$PATH_SEPARATOR," + for lt_pkg in $withval; do + IFS="$lt_save_ifs" + if test "X$lt_pkg" = "X$lt_p"; then + pic_mode=yes + fi + done + IFS="$lt_save_ifs" + ;; + esac], + [pic_mode=default]) + +test -z "$pic_mode" && pic_mode=m4_default([$1], [default]) + +_LT_DECL([], [pic_mode], [0], [What type of objects to build])dnl +])# _LT_WITH_PIC + +LT_OPTION_DEFINE([LT_INIT], [pic-only], [_LT_WITH_PIC([yes])]) +LT_OPTION_DEFINE([LT_INIT], [no-pic], [_LT_WITH_PIC([no])]) + +# Old name: +AU_DEFUN([AC_LIBTOOL_PICMODE], +[_LT_SET_OPTION([LT_INIT], [pic-only]) +AC_DIAGNOSE([obsolete], +[$0: Remove this warning and the call to _LT_SET_OPTION when you +put the `pic-only' option into LT_INIT's first parameter.]) +]) + +dnl aclocal-1.4 backwards compatibility: +dnl AC_DEFUN([AC_LIBTOOL_PICMODE], []) + +## ----------------- ## +## LTDL_INIT Options ## +## ----------------- ## + +m4_define([_LTDL_MODE], []) +LT_OPTION_DEFINE([LTDL_INIT], [nonrecursive], + [m4_define([_LTDL_MODE], [nonrecursive])]) +LT_OPTION_DEFINE([LTDL_INIT], [recursive], + [m4_define([_LTDL_MODE], [recursive])]) +LT_OPTION_DEFINE([LTDL_INIT], [subproject], + [m4_define([_LTDL_MODE], [subproject])]) + +m4_define([_LTDL_TYPE], []) +LT_OPTION_DEFINE([LTDL_INIT], [installable], + [m4_define([_LTDL_TYPE], [installable])]) +LT_OPTION_DEFINE([LTDL_INIT], [convenience], + [m4_define([_LTDL_TYPE], [convenience])]) diff --git a/libconfig-1.4.9/m4/ltsugar.m4 b/libconfig-1.4.9/m4/ltsugar.m4 new file mode 100644 index 0000000000000000000000000000000000000000..9000a057d31ddf75cb85ccda8757de4493bcdbe7 --- /dev/null +++ b/libconfig-1.4.9/m4/ltsugar.m4 @@ -0,0 +1,123 @@ +# ltsugar.m4 -- libtool m4 base layer. -*-Autoconf-*- +# +# Copyright (C) 2004, 2005, 2007, 2008 Free Software Foundation, Inc. +# Written by Gary V. Vaughan, 2004 +# +# This file is free software; the Free Software Foundation gives +# unlimited permission to copy and/or distribute it, with or without +# modifications, as long as this notice is preserved. + +# serial 6 ltsugar.m4 + +# This is to help aclocal find these macros, as it can't see m4_define. +AC_DEFUN([LTSUGAR_VERSION], [m4_if([0.1])]) + + +# lt_join(SEP, ARG1, [ARG2...]) +# ----------------------------- +# Produce ARG1SEPARG2...SEPARGn, omitting [] arguments and their +# associated separator. +# Needed until we can rely on m4_join from Autoconf 2.62, since all earlier +# versions in m4sugar had bugs. +m4_define([lt_join], +[m4_if([$#], [1], [], + [$#], [2], [[$2]], + [m4_if([$2], [], [], [[$2]_])$0([$1], m4_shift(m4_shift($@)))])]) +m4_define([_lt_join], +[m4_if([$#$2], [2], [], + [m4_if([$2], [], [], [[$1$2]])$0([$1], m4_shift(m4_shift($@)))])]) + + +# lt_car(LIST) +# lt_cdr(LIST) +# ------------ +# Manipulate m4 lists. +# These macros are necessary as long as will still need to support +# Autoconf-2.59 which quotes differently. +m4_define([lt_car], [[$1]]) +m4_define([lt_cdr], +[m4_if([$#], 0, [m4_fatal([$0: cannot be called without arguments])], + [$#], 1, [], + [m4_dquote(m4_shift($@))])]) +m4_define([lt_unquote], $1) + + +# lt_append(MACRO-NAME, STRING, [SEPARATOR]) +# ------------------------------------------ +# Redefine MACRO-NAME to hold its former content plus `SEPARATOR'`STRING'. +# Note that neither SEPARATOR nor STRING are expanded; they are appended +# to MACRO-NAME as is (leaving the expansion for when MACRO-NAME is invoked). +# No SEPARATOR is output if MACRO-NAME was previously undefined (different +# than defined and empty). +# +# This macro is needed until we can rely on Autoconf 2.62, since earlier +# versions of m4sugar mistakenly expanded SEPARATOR but not STRING. +m4_define([lt_append], +[m4_define([$1], + m4_ifdef([$1], [m4_defn([$1])[$3]])[$2])]) + + + +# lt_combine(SEP, PREFIX-LIST, INFIX, SUFFIX1, [SUFFIX2...]) +# ---------------------------------------------------------- +# Produce a SEP delimited list of all paired combinations of elements of +# PREFIX-LIST with SUFFIX1 through SUFFIXn. Each element of the list +# has the form PREFIXmINFIXSUFFIXn. +# Needed until we can rely on m4_combine added in Autoconf 2.62. +m4_define([lt_combine], +[m4_if(m4_eval([$# > 3]), [1], + [m4_pushdef([_Lt_sep], [m4_define([_Lt_sep], m4_defn([lt_car]))])]]dnl +[[m4_foreach([_Lt_prefix], [$2], + [m4_foreach([_Lt_suffix], + ]m4_dquote(m4_dquote(m4_shift(m4_shift(m4_shift($@)))))[, + [_Lt_sep([$1])[]m4_defn([_Lt_prefix])[$3]m4_defn([_Lt_suffix])])])])]) + + +# lt_if_append_uniq(MACRO-NAME, VARNAME, [SEPARATOR], [UNIQ], [NOT-UNIQ]) +# ----------------------------------------------------------------------- +# Iff MACRO-NAME does not yet contain VARNAME, then append it (delimited +# by SEPARATOR if supplied) and expand UNIQ, else NOT-UNIQ. +m4_define([lt_if_append_uniq], +[m4_ifdef([$1], + [m4_if(m4_index([$3]m4_defn([$1])[$3], [$3$2$3]), [-1], + [lt_append([$1], [$2], [$3])$4], + [$5])], + [lt_append([$1], [$2], [$3])$4])]) + + +# lt_dict_add(DICT, KEY, VALUE) +# ----------------------------- +m4_define([lt_dict_add], +[m4_define([$1($2)], [$3])]) + + +# lt_dict_add_subkey(DICT, KEY, SUBKEY, VALUE) +# -------------------------------------------- +m4_define([lt_dict_add_subkey], +[m4_define([$1($2:$3)], [$4])]) + + +# lt_dict_fetch(DICT, KEY, [SUBKEY]) +# ---------------------------------- +m4_define([lt_dict_fetch], +[m4_ifval([$3], + m4_ifdef([$1($2:$3)], [m4_defn([$1($2:$3)])]), + m4_ifdef([$1($2)], [m4_defn([$1($2)])]))]) + + +# lt_if_dict_fetch(DICT, KEY, [SUBKEY], VALUE, IF-TRUE, [IF-FALSE]) +# ----------------------------------------------------------------- +m4_define([lt_if_dict_fetch], +[m4_if(lt_dict_fetch([$1], [$2], [$3]), [$4], + [$5], + [$6])]) + + +# lt_dict_filter(DICT, [SUBKEY], VALUE, [SEPARATOR], KEY, [...]) +# -------------------------------------------------------------- +m4_define([lt_dict_filter], +[m4_if([$5], [], [], + [lt_join(m4_quote(m4_default([$4], [[, ]])), + lt_unquote(m4_split(m4_normalize(m4_foreach(_Lt_key, lt_car([m4_shiftn(4, $@)]), + [lt_if_dict_fetch([$1], _Lt_key, [$2], [$3], [_Lt_key ])])))))])[]dnl +]) diff --git a/libconfig-1.4.9/m4/ltversion.m4 b/libconfig-1.4.9/m4/ltversion.m4 new file mode 100644 index 0000000000000000000000000000000000000000..07a8602d48d615a65800b14446d8c8c8694f2818 --- /dev/null +++ b/libconfig-1.4.9/m4/ltversion.m4 @@ -0,0 +1,23 @@ +# ltversion.m4 -- version numbers -*- Autoconf -*- +# +# Copyright (C) 2004 Free Software Foundation, Inc. +# Written by Scott James Remnant, 2004 +# +# This file is free software; the Free Software Foundation gives +# unlimited permission to copy and/or distribute it, with or without +# modifications, as long as this notice is preserved. + +# @configure_input@ + +# serial 3337 ltversion.m4 +# This file is part of GNU Libtool + +m4_define([LT_PACKAGE_VERSION], [2.4.2]) +m4_define([LT_PACKAGE_REVISION], [1.3337]) + +AC_DEFUN([LTVERSION_VERSION], +[macro_version='2.4.2' +macro_revision='1.3337' +_LT_DECL(, macro_version, 0, [Which release of libtool.m4 was used?]) +_LT_DECL(, macro_revision, 0) +]) diff --git a/libconfig-1.4.9/m4/lt~obsolete.m4 b/libconfig-1.4.9/m4/lt~obsolete.m4 new file mode 100644 index 0000000000000000000000000000000000000000..c573da90c5ccebffba4dce9a6462036bfa986d5f --- /dev/null +++ b/libconfig-1.4.9/m4/lt~obsolete.m4 @@ -0,0 +1,98 @@ +# lt~obsolete.m4 -- aclocal satisfying obsolete definitions. -*-Autoconf-*- +# +# Copyright (C) 2004, 2005, 2007, 2009 Free Software Foundation, Inc. +# Written by Scott James Remnant, 2004. +# +# This file is free software; the Free Software Foundation gives +# unlimited permission to copy and/or distribute it, with or without +# modifications, as long as this notice is preserved. + +# serial 5 lt~obsolete.m4 + +# These exist entirely to fool aclocal when bootstrapping libtool. +# +# In the past libtool.m4 has provided macros via AC_DEFUN (or AU_DEFUN) +# which have later been changed to m4_define as they aren't part of the +# exported API, or moved to Autoconf or Automake where they belong. +# +# The trouble is, aclocal is a bit thick. It'll see the old AC_DEFUN +# in /usr/share/aclocal/libtool.m4 and remember it, then when it sees us +# using a macro with the same name in our local m4/libtool.m4 it'll +# pull the old libtool.m4 in (it doesn't see our shiny new m4_define +# and doesn't know about Autoconf macros at all.) +# +# So we provide this file, which has a silly filename so it's always +# included after everything else. This provides aclocal with the +# AC_DEFUNs it wants, but when m4 processes it, it doesn't do anything +# because those macros already exist, or will be overwritten later. +# We use AC_DEFUN over AU_DEFUN for compatibility with aclocal-1.6. +# +# Anytime we withdraw an AC_DEFUN or AU_DEFUN, remember to add it here. +# Yes, that means every name once taken will need to remain here until +# we give up compatibility with versions before 1.7, at which point +# we need to keep only those names which we still refer to. + +# This is to help aclocal find these macros, as it can't see m4_define. +AC_DEFUN([LTOBSOLETE_VERSION], [m4_if([1])]) + +m4_ifndef([AC_LIBTOOL_LINKER_OPTION], [AC_DEFUN([AC_LIBTOOL_LINKER_OPTION])]) +m4_ifndef([AC_PROG_EGREP], [AC_DEFUN([AC_PROG_EGREP])]) +m4_ifndef([_LT_AC_PROG_ECHO_BACKSLASH], [AC_DEFUN([_LT_AC_PROG_ECHO_BACKSLASH])]) +m4_ifndef([_LT_AC_SHELL_INIT], [AC_DEFUN([_LT_AC_SHELL_INIT])]) +m4_ifndef([_LT_AC_SYS_LIBPATH_AIX], [AC_DEFUN([_LT_AC_SYS_LIBPATH_AIX])]) +m4_ifndef([_LT_PROG_LTMAIN], [AC_DEFUN([_LT_PROG_LTMAIN])]) +m4_ifndef([_LT_AC_TAGVAR], [AC_DEFUN([_LT_AC_TAGVAR])]) +m4_ifndef([AC_LTDL_ENABLE_INSTALL], [AC_DEFUN([AC_LTDL_ENABLE_INSTALL])]) +m4_ifndef([AC_LTDL_PREOPEN], [AC_DEFUN([AC_LTDL_PREOPEN])]) +m4_ifndef([_LT_AC_SYS_COMPILER], [AC_DEFUN([_LT_AC_SYS_COMPILER])]) +m4_ifndef([_LT_AC_LOCK], [AC_DEFUN([_LT_AC_LOCK])]) +m4_ifndef([AC_LIBTOOL_SYS_OLD_ARCHIVE], [AC_DEFUN([AC_LIBTOOL_SYS_OLD_ARCHIVE])]) +m4_ifndef([_LT_AC_TRY_DLOPEN_SELF], [AC_DEFUN([_LT_AC_TRY_DLOPEN_SELF])]) +m4_ifndef([AC_LIBTOOL_PROG_CC_C_O], [AC_DEFUN([AC_LIBTOOL_PROG_CC_C_O])]) +m4_ifndef([AC_LIBTOOL_SYS_HARD_LINK_LOCKS], [AC_DEFUN([AC_LIBTOOL_SYS_HARD_LINK_LOCKS])]) +m4_ifndef([AC_LIBTOOL_OBJDIR], [AC_DEFUN([AC_LIBTOOL_OBJDIR])]) +m4_ifndef([AC_LTDL_OBJDIR], [AC_DEFUN([AC_LTDL_OBJDIR])]) +m4_ifndef([AC_LIBTOOL_PROG_LD_HARDCODE_LIBPATH], [AC_DEFUN([AC_LIBTOOL_PROG_LD_HARDCODE_LIBPATH])]) +m4_ifndef([AC_LIBTOOL_SYS_LIB_STRIP], [AC_DEFUN([AC_LIBTOOL_SYS_LIB_STRIP])]) +m4_ifndef([AC_PATH_MAGIC], [AC_DEFUN([AC_PATH_MAGIC])]) +m4_ifndef([AC_PROG_LD_GNU], [AC_DEFUN([AC_PROG_LD_GNU])]) +m4_ifndef([AC_PROG_LD_RELOAD_FLAG], [AC_DEFUN([AC_PROG_LD_RELOAD_FLAG])]) +m4_ifndef([AC_DEPLIBS_CHECK_METHOD], [AC_DEFUN([AC_DEPLIBS_CHECK_METHOD])]) +m4_ifndef([AC_LIBTOOL_PROG_COMPILER_NO_RTTI], [AC_DEFUN([AC_LIBTOOL_PROG_COMPILER_NO_RTTI])]) +m4_ifndef([AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE], [AC_DEFUN([AC_LIBTOOL_SYS_GLOBAL_SYMBOL_PIPE])]) +m4_ifndef([AC_LIBTOOL_PROG_COMPILER_PIC], [AC_DEFUN([AC_LIBTOOL_PROG_COMPILER_PIC])]) +m4_ifndef([AC_LIBTOOL_PROG_LD_SHLIBS], [AC_DEFUN([AC_LIBTOOL_PROG_LD_SHLIBS])]) +m4_ifndef([AC_LIBTOOL_POSTDEP_PREDEP], [AC_DEFUN([AC_LIBTOOL_POSTDEP_PREDEP])]) +m4_ifndef([LT_AC_PROG_EGREP], [AC_DEFUN([LT_AC_PROG_EGREP])]) +m4_ifndef([LT_AC_PROG_SED], [AC_DEFUN([LT_AC_PROG_SED])]) +m4_ifndef([_LT_CC_BASENAME], [AC_DEFUN([_LT_CC_BASENAME])]) +m4_ifndef([_LT_COMPILER_BOILERPLATE], [AC_DEFUN([_LT_COMPILER_BOILERPLATE])]) +m4_ifndef([_LT_LINKER_BOILERPLATE], [AC_DEFUN([_LT_LINKER_BOILERPLATE])]) +m4_ifndef([_AC_PROG_LIBTOOL], [AC_DEFUN([_AC_PROG_LIBTOOL])]) +m4_ifndef([AC_LIBTOOL_SETUP], [AC_DEFUN([AC_LIBTOOL_SETUP])]) +m4_ifndef([_LT_AC_CHECK_DLFCN], [AC_DEFUN([_LT_AC_CHECK_DLFCN])]) +m4_ifndef([AC_LIBTOOL_SYS_DYNAMIC_LINKER], [AC_DEFUN([AC_LIBTOOL_SYS_DYNAMIC_LINKER])]) +m4_ifndef([_LT_AC_TAGCONFIG], [AC_DEFUN([_LT_AC_TAGCONFIG])]) +m4_ifndef([AC_DISABLE_FAST_INSTALL], [AC_DEFUN([AC_DISABLE_FAST_INSTALL])]) +m4_ifndef([_LT_AC_LANG_CXX], [AC_DEFUN([_LT_AC_LANG_CXX])]) +m4_ifndef([_LT_AC_LANG_F77], [AC_DEFUN([_LT_AC_LANG_F77])]) +m4_ifndef([_LT_AC_LANG_GCJ], [AC_DEFUN([_LT_AC_LANG_GCJ])]) +m4_ifndef([AC_LIBTOOL_LANG_C_CONFIG], [AC_DEFUN([AC_LIBTOOL_LANG_C_CONFIG])]) +m4_ifndef([_LT_AC_LANG_C_CONFIG], [AC_DEFUN([_LT_AC_LANG_C_CONFIG])]) +m4_ifndef([AC_LIBTOOL_LANG_CXX_CONFIG], [AC_DEFUN([AC_LIBTOOL_LANG_CXX_CONFIG])]) +m4_ifndef([_LT_AC_LANG_CXX_CONFIG], [AC_DEFUN([_LT_AC_LANG_CXX_CONFIG])]) +m4_ifndef([AC_LIBTOOL_LANG_F77_CONFIG], [AC_DEFUN([AC_LIBTOOL_LANG_F77_CONFIG])]) +m4_ifndef([_LT_AC_LANG_F77_CONFIG], [AC_DEFUN([_LT_AC_LANG_F77_CONFIG])]) +m4_ifndef([AC_LIBTOOL_LANG_GCJ_CONFIG], [AC_DEFUN([AC_LIBTOOL_LANG_GCJ_CONFIG])]) +m4_ifndef([_LT_AC_LANG_GCJ_CONFIG], [AC_DEFUN([_LT_AC_LANG_GCJ_CONFIG])]) +m4_ifndef([AC_LIBTOOL_LANG_RC_CONFIG], [AC_DEFUN([AC_LIBTOOL_LANG_RC_CONFIG])]) +m4_ifndef([_LT_AC_LANG_RC_CONFIG], [AC_DEFUN([_LT_AC_LANG_RC_CONFIG])]) +m4_ifndef([AC_LIBTOOL_CONFIG], [AC_DEFUN([AC_LIBTOOL_CONFIG])]) +m4_ifndef([_LT_AC_FILE_LTDLL_C], [AC_DEFUN([_LT_AC_FILE_LTDLL_C])]) +m4_ifndef([_LT_REQUIRED_DARWIN_CHECKS], [AC_DEFUN([_LT_REQUIRED_DARWIN_CHECKS])]) +m4_ifndef([_LT_AC_PROG_CXXCPP], [AC_DEFUN([_LT_AC_PROG_CXXCPP])]) +m4_ifndef([_LT_PREPARE_SED_QUOTE_VARS], [AC_DEFUN([_LT_PREPARE_SED_QUOTE_VARS])]) +m4_ifndef([_LT_PROG_ECHO_BACKSLASH], [AC_DEFUN([_LT_PROG_ECHO_BACKSLASH])]) +m4_ifndef([_LT_PROG_F77], [AC_DEFUN([_LT_PROG_F77])]) +m4_ifndef([_LT_PROG_FC], [AC_DEFUN([_LT_PROG_FC])]) +m4_ifndef([_LT_PROG_CXX], [AC_DEFUN([_LT_PROG_CXX])]) diff --git a/libconfig-1.4.9/stamp-h1 b/libconfig-1.4.9/stamp-h1 new file mode 100644 index 0000000000000000000000000000000000000000..eacafcf1c62cc5a370fce2d0c9610d8a8ee8ecc4 --- /dev/null +++ b/libconfig-1.4.9/stamp-h1 @@ -0,0 +1 @@ +timestamp for ac_config.h diff --git a/libconfig-1.4.9/test.cfg b/libconfig-1.4.9/test.cfg new file mode 100644 index 0000000000000000000000000000000000000000..66a4fa96899a1b0245f0a0b3a86bc161846c24fe --- /dev/null +++ b/libconfig-1.4.9/test.cfg @@ -0,0 +1,82 @@ +#---------------------------- +# Example Configuration File +#--------------------------- +# + +application: +{ + + /* This section defines some settings for our + * main application window, such as size and + * position. + */ + + window: + { + title = "My Application"; + size = { /* width */ w = 640; /* height */ h = 480; }; + pos = { x = 350; y = 250; }; + }; + + a = 5; + b = 6; + ff = 1E6; + test-comment = "/* hello\n \"there\"*/"; + + test-long-string = "A very long string that spans multiple lines. " + /* but wait, there's more... */ "Adjacent strings are automatically" + " concatenated."; + + test-escaped-string = "\"This is\n a test.\""; + + group1: + { + x = 5; y = 10; + my_array = [ 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22 ]; + flag = TRUE; + + group2: { zzz = "this is a test"; }; + + states = [ "CT", // Connecticut + "CA", // California + "TX", // Texas + "NV", // Nevada + "FL" // Florida + ]; + }; + + /* this would cause an error */ + // a = "hi!"; +}; + +binary = [ 0xAA, 0xBB, 0xCC ]; + +list = ( ( "abc", 123, true ), 1.234, ( /* an empty list */ ) ,[ 1, 2, 3 ], + { a = (1, 2, true); } ); + +books = ( "inventory", + { title = "Treasure Island"; + author = "Robert Louis Stevenson"; + price = 29.99; + qty = 5; }, + { title = "Snow Crash"; + author = "Neal Stephenson"; + price = 9.99; + qty = 8; }, + { } ); + +# miscellaneous stuff + +misc: +{ + port = 5000; + pi = 3.14159265; + enabled = FALSE; + mask = 0xAABBCCDD; + unicode = "STARGΛ̊TE SG-1"; // UTF-8 string + bigint = 9223372036854775807L; + bighex = 0x1122334455667788L; +}; + + +### eof diff --git a/libconfig-1.4.9/tests/.deps/libconfig_tests-tests.Po b/libconfig-1.4.9/tests/.deps/libconfig_tests-tests.Po new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/tests/.deps/libconfig_tests-tests.Po @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/tests/Makefile b/libconfig-1.4.9/tests/Makefile new file mode 100644 index 0000000000000000000000000000000000000000..ad09513978aff64a7c0002b012eb36459dd27afe --- /dev/null +++ b/libconfig-1.4.9/tests/Makefile @@ -0,0 +1,505 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# tests/Makefile. Generated from Makefile.in by configure. + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + + + + +pkgdatadir = $(datadir)/libconfig +pkgincludedir = $(includedir)/libconfig +pkglibdir = $(libdir)/libconfig +pkglibexecdir = $(libexecdir)/libconfig +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = x86_64-unknown-linux-gnu +host_triplet = x86_64-unknown-linux-gnu +target_triplet = x86_64-unknown-linux-gnu +noinst_PROGRAMS = libconfig_tests$(EXEEXT) +subdir = tests +DIST_COMMON = $(srcdir)/Makefile.am $(srcdir)/Makefile.in +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = +CONFIG_CLEAN_VPATH_FILES = +PROGRAMS = $(noinst_PROGRAMS) +am_libconfig_tests_OBJECTS = libconfig_tests-tests.$(OBJEXT) +libconfig_tests_OBJECTS = $(am_libconfig_tests_OBJECTS) +libconfig_tests_DEPENDENCIES = +DEFAULT_INCLUDES = -I. -I$(top_builddir) +depcomp = $(SHELL) $(top_srcdir)/aux-build/depcomp +am__depfiles_maybe = depfiles +am__mv = mv -f +COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +LTCOMPILE = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +CCLD = $(CC) +LINK = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) $(AM_LDFLAGS) \ + $(LDFLAGS) -o $@ +SOURCES = $(libconfig_tests_SOURCES) +DIST_SOURCES = $(libconfig_tests_SOURCES) +ETAGS = etags +CTAGS = ctags +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +ACLOCAL = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run aclocal-1.11 +AMTAR = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run tar +AR = ar +AS = as +AUTOCONF = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoconf +AUTOHEADER = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoheader +AUTOMAKE = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run automake-1.11 +AWK = gawk +CC = gcc +CCDEPMODE = depmode=gcc3 +CFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter +CPP = gcc -E +CPPFLAGS = +CXX = g++ +CXXCPP = g++ -E +CXXDEPMODE = depmode=gcc3 +CXXFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wno-unused-parameter +CYGPATH_W = echo +DEFS = -DHAVE_CONFIG_H +DEPDIR = .deps +DLLTOOL = false +DSYMUTIL = +DUMPBIN = +ECHO_C = +ECHO_N = -n +ECHO_T = +EGREP = /usr/bin/grep -E +EXEEXT = +FGREP = /usr/bin/grep -F +GREP = /usr/bin/grep +INSTALL = /usr/bin/install -c +INSTALL_DATA = ${INSTALL} -m 644 +INSTALL_PROGRAM = ${INSTALL} +INSTALL_SCRIPT = ${INSTALL} +INSTALL_STRIP_PROGRAM = $(install_sh) -c -s +LD = /usr/bin/ld -m elf_x86_64 +LDFLAGS = +LEX = flex +LEXLIB = +LEX_OUTPUT_ROOT = lex.yy +LIBOBJS = +LIBS = +LIBTOOL = $(SHELL) $(top_builddir)/libtool +LIPO = +LN_S = ln -s +LTLIBOBJS = +MAKEINFO = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run makeinfo +MANIFEST_TOOL = : +MKDIR_P = /usr/bin/mkdir -p +NM = /usr/bin/nm -B +NMEDIT = +OBJDUMP = objdump +OBJEXT = o +OTOOL = +OTOOL64 = +PACKAGE = libconfig +PACKAGE_BUGREPORT = hyperrealm@gmail.com +PACKAGE_NAME = libconfig +PACKAGE_STRING = libconfig 1.4.9 +PACKAGE_TARNAME = libconfig +PACKAGE_URL = http://www.hyperrealm.com/main.php?s=libconfig +PACKAGE_VERSION = 1.4.9 +PATH_SEPARATOR = : +RANLIB = ranlib +SED = /usr/bin/sed +SET_MAKE = +SHELL = /bin/sh +STRIP = strip +VERSION = 1.4.9 +YACC = bison -y +YFLAGS = +abs_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/tests +abs_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/tests +abs_top_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +abs_top_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +ac_ct_AR = ar +ac_ct_CC = gcc +ac_ct_CXX = g++ +ac_ct_DUMPBIN = +am__include = include +am__leading_dot = . +am__quote = +am__tar = ${AMTAR} chof - "$$tardir" +am__untar = ${AMTAR} xf - +bindir = ${exec_prefix}/bin +build = x86_64-unknown-linux-gnu +build_alias = +build_cpu = x86_64 +build_os = linux-gnu +build_vendor = unknown +builddir = . +datadir = ${datarootdir} +datarootdir = ${prefix}/share +docdir = ${datarootdir}/doc/${PACKAGE_TARNAME} +dvidir = ${docdir} +exec_prefix = ${prefix} +host = x86_64-unknown-linux-gnu +host_alias = +host_cpu = x86_64 +host_os = linux-gnu +host_vendor = unknown +htmldir = ${docdir} +includedir = ${prefix}/include +infodir = ${datarootdir}/info +install_sh = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/install-sh +libdir = ${exec_prefix}/lib +libexecdir = ${exec_prefix}/libexec +localedir = ${datarootdir}/locale +localstatedir = ${prefix}/var +mandir = ${datarootdir}/man +mkdir_p = /usr/bin/mkdir -p +oldincludedir = /usr/include +pdfdir = ${docdir} +prefix = /usr/local +program_transform_name = s,x,x, +psdir = ${docdir} +sbindir = ${exec_prefix}/sbin +sharedstatedir = ${prefix}/com +srcdir = . +sysconfdir = ${prefix}/etc +target = x86_64-unknown-linux-gnu +target_alias = +target_cpu = x86_64 +target_os = linux-gnu +target_vendor = unknown +top_build_prefix = ../ +top_builddir = .. +top_srcdir = .. +libconfig_tests_SOURCES = tests.c +libconfig_tests_CPPFLAGS = -I../tinytest -I../lib +libconfig_tests_LDADD = -L../tinytest -ltinytest \ + -L../lib/.libs -lconfig + +EXTRA_DIST = \ + tests.vcproj \ + testdata/*.cfg \ + testdata/*.txt + +all: all-am + +.SUFFIXES: +.SUFFIXES: .c .lo .o .obj +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu tests/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu tests/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): + +clean-noinstPROGRAMS: + @list='$(noinst_PROGRAMS)'; test -n "$$list" || exit 0; \ + echo " rm -f" $$list; \ + rm -f $$list || exit $$?; \ + test -n "$(EXEEXT)" || exit 0; \ + list=`for p in $$list; do echo "$$p"; done | sed 's/$(EXEEXT)$$//'`; \ + echo " rm -f" $$list; \ + rm -f $$list +libconfig_tests$(EXEEXT): $(libconfig_tests_OBJECTS) $(libconfig_tests_DEPENDENCIES) + @rm -f libconfig_tests$(EXEEXT) + $(LINK) $(libconfig_tests_OBJECTS) $(libconfig_tests_LDADD) $(LIBS) + +mostlyclean-compile: + -rm -f *.$(OBJEXT) + +distclean-compile: + -rm -f *.tab.c + +include ./$(DEPDIR)/libconfig_tests-tests.Po + +.c.o: + $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +# source='$<' object='$@' libtool=no \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(COMPILE) -c $< + +.c.obj: + $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'` + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +# source='$<' object='$@' libtool=no \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(COMPILE) -c `$(CYGPATH_W) '$<'` + +.c.lo: + $(LTCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo +# source='$<' object='$@' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LTCOMPILE) -c -o $@ $< + +libconfig_tests-tests.o: tests.c + $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_tests_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_tests-tests.o -MD -MP -MF $(DEPDIR)/libconfig_tests-tests.Tpo -c -o libconfig_tests-tests.o `test -f 'tests.c' || echo '$(srcdir)/'`tests.c + $(am__mv) $(DEPDIR)/libconfig_tests-tests.Tpo $(DEPDIR)/libconfig_tests-tests.Po +# source='tests.c' object='libconfig_tests-tests.o' libtool=no \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_tests_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_tests-tests.o `test -f 'tests.c' || echo '$(srcdir)/'`tests.c + +libconfig_tests-tests.obj: tests.c + $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_tests_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_tests-tests.obj -MD -MP -MF $(DEPDIR)/libconfig_tests-tests.Tpo -c -o libconfig_tests-tests.obj `if test -f 'tests.c'; then $(CYGPATH_W) 'tests.c'; else $(CYGPATH_W) '$(srcdir)/tests.c'; fi` + $(am__mv) $(DEPDIR)/libconfig_tests-tests.Tpo $(DEPDIR)/libconfig_tests-tests.Po +# source='tests.c' object='libconfig_tests-tests.obj' libtool=no \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_tests_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_tests-tests.obj `if test -f 'tests.c'; then $(CYGPATH_W) 'tests.c'; else $(CYGPATH_W) '$(srcdir)/tests.c'; fi` + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done +check-am: all-am +check: check-am +all-am: Makefile $(PROGRAMS) +installdirs: +install: install-am +install-exec: install-exec-am +install-data: install-data-am +uninstall: uninstall-am + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-am +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-am + +clean-am: clean-generic clean-libtool clean-noinstPROGRAMS \ + mostlyclean-am + +distclean: distclean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +distclean-am: clean-am distclean-compile distclean-generic \ + distclean-tags + +dvi: dvi-am + +dvi-am: + +html: html-am + +html-am: + +info: info-am + +info-am: + +install-data-am: + +install-dvi: install-dvi-am + +install-dvi-am: + +install-exec-am: + +install-html: install-html-am + +install-html-am: + +install-info: install-info-am + +install-info-am: + +install-man: + +install-pdf: install-pdf-am + +install-pdf-am: + +install-ps: install-ps-am + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-am + +mostlyclean-am: mostlyclean-compile mostlyclean-generic \ + mostlyclean-libtool + +pdf: pdf-am + +pdf-am: + +ps: ps-am + +ps-am: + +uninstall-am: + +.MAKE: install-am install-strip + +.PHONY: CTAGS GTAGS all all-am check check-am clean clean-generic \ + clean-libtool clean-noinstPROGRAMS ctags distclean \ + distclean-compile distclean-generic distclean-libtool \ + distclean-tags distdir dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-info install-info-am install-man \ + install-pdf install-pdf-am install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + maintainer-clean maintainer-clean-generic mostlyclean \ + mostlyclean-compile mostlyclean-generic mostlyclean-libtool \ + pdf pdf-am ps ps-am tags uninstall uninstall-am + + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/tests/Makefile.am b/libconfig-1.4.9/tests/Makefile.am new file mode 100644 index 0000000000000000000000000000000000000000..5d773f1766e5f5904196557ceb695c229c81b380 --- /dev/null +++ b/libconfig-1.4.9/tests/Makefile.am @@ -0,0 +1,15 @@ + +noinst_PROGRAMS = libconfig_tests + +libconfig_tests_SOURCES = tests.c + +libconfig_tests_CPPFLAGS = -I../tinytest -I../lib + +libconfig_tests_LDADD = -L../tinytest -ltinytest \ + -L../lib/.libs -lconfig + + +EXTRA_DIST = \ + tests.vcproj \ + testdata/*.cfg \ + testdata/*.txt diff --git a/libconfig-1.4.9/tests/Makefile.in b/libconfig-1.4.9/tests/Makefile.in new file mode 100644 index 0000000000000000000000000000000000000000..ecf67de910eb76e15ba8f6585a96892a24141047 --- /dev/null +++ b/libconfig-1.4.9/tests/Makefile.in @@ -0,0 +1,505 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# @configure_input@ + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + +@SET_MAKE@ + +VPATH = @srcdir@ +pkgdatadir = $(datadir)/@PACKAGE@ +pkgincludedir = $(includedir)/@PACKAGE@ +pkglibdir = $(libdir)/@PACKAGE@ +pkglibexecdir = $(libexecdir)/@PACKAGE@ +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = @build@ +host_triplet = @host@ +target_triplet = @target@ +noinst_PROGRAMS = libconfig_tests$(EXEEXT) +subdir = tests +DIST_COMMON = $(srcdir)/Makefile.am $(srcdir)/Makefile.in +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = +CONFIG_CLEAN_VPATH_FILES = +PROGRAMS = $(noinst_PROGRAMS) +am_libconfig_tests_OBJECTS = libconfig_tests-tests.$(OBJEXT) +libconfig_tests_OBJECTS = $(am_libconfig_tests_OBJECTS) +libconfig_tests_DEPENDENCIES = +DEFAULT_INCLUDES = -I.@am__isrc@ -I$(top_builddir) +depcomp = $(SHELL) $(top_srcdir)/aux-build/depcomp +am__depfiles_maybe = depfiles +am__mv = mv -f +COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +LTCOMPILE = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +CCLD = $(CC) +LINK = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) $(AM_LDFLAGS) \ + $(LDFLAGS) -o $@ +SOURCES = $(libconfig_tests_SOURCES) +DIST_SOURCES = $(libconfig_tests_SOURCES) +ETAGS = etags +CTAGS = ctags +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +ACLOCAL = @ACLOCAL@ +AMTAR = @AMTAR@ +AR = @AR@ +AS = @AS@ +AUTOCONF = @AUTOCONF@ +AUTOHEADER = @AUTOHEADER@ +AUTOMAKE = @AUTOMAKE@ +AWK = @AWK@ +CC = @CC@ +CCDEPMODE = @CCDEPMODE@ +CFLAGS = @CFLAGS@ +CPP = @CPP@ +CPPFLAGS = @CPPFLAGS@ +CXX = @CXX@ +CXXCPP = @CXXCPP@ +CXXDEPMODE = @CXXDEPMODE@ +CXXFLAGS = @CXXFLAGS@ +CYGPATH_W = @CYGPATH_W@ +DEFS = @DEFS@ +DEPDIR = @DEPDIR@ +DLLTOOL = @DLLTOOL@ +DSYMUTIL = @DSYMUTIL@ +DUMPBIN = @DUMPBIN@ +ECHO_C = @ECHO_C@ +ECHO_N = @ECHO_N@ +ECHO_T = @ECHO_T@ +EGREP = @EGREP@ +EXEEXT = @EXEEXT@ +FGREP = @FGREP@ +GREP = @GREP@ +INSTALL = @INSTALL@ +INSTALL_DATA = @INSTALL_DATA@ +INSTALL_PROGRAM = @INSTALL_PROGRAM@ +INSTALL_SCRIPT = @INSTALL_SCRIPT@ +INSTALL_STRIP_PROGRAM = @INSTALL_STRIP_PROGRAM@ +LD = @LD@ +LDFLAGS = @LDFLAGS@ +LEX = @LEX@ +LEXLIB = @LEXLIB@ +LEX_OUTPUT_ROOT = @LEX_OUTPUT_ROOT@ +LIBOBJS = @LIBOBJS@ +LIBS = @LIBS@ +LIBTOOL = @LIBTOOL@ +LIPO = @LIPO@ +LN_S = @LN_S@ +LTLIBOBJS = @LTLIBOBJS@ +MAKEINFO = @MAKEINFO@ +MANIFEST_TOOL = @MANIFEST_TOOL@ +MKDIR_P = @MKDIR_P@ +NM = @NM@ +NMEDIT = @NMEDIT@ +OBJDUMP = @OBJDUMP@ +OBJEXT = @OBJEXT@ +OTOOL = @OTOOL@ +OTOOL64 = @OTOOL64@ +PACKAGE = @PACKAGE@ +PACKAGE_BUGREPORT = @PACKAGE_BUGREPORT@ +PACKAGE_NAME = @PACKAGE_NAME@ +PACKAGE_STRING = @PACKAGE_STRING@ +PACKAGE_TARNAME = @PACKAGE_TARNAME@ +PACKAGE_URL = @PACKAGE_URL@ +PACKAGE_VERSION = @PACKAGE_VERSION@ +PATH_SEPARATOR = @PATH_SEPARATOR@ +RANLIB = @RANLIB@ +SED = @SED@ +SET_MAKE = @SET_MAKE@ +SHELL = @SHELL@ +STRIP = @STRIP@ +VERSION = @VERSION@ +YACC = @YACC@ +YFLAGS = @YFLAGS@ +abs_builddir = @abs_builddir@ +abs_srcdir = @abs_srcdir@ +abs_top_builddir = @abs_top_builddir@ +abs_top_srcdir = @abs_top_srcdir@ +ac_ct_AR = @ac_ct_AR@ +ac_ct_CC = @ac_ct_CC@ +ac_ct_CXX = @ac_ct_CXX@ +ac_ct_DUMPBIN = @ac_ct_DUMPBIN@ +am__include = @am__include@ +am__leading_dot = @am__leading_dot@ +am__quote = @am__quote@ +am__tar = @am__tar@ +am__untar = @am__untar@ +bindir = @bindir@ +build = @build@ +build_alias = @build_alias@ +build_cpu = @build_cpu@ +build_os = @build_os@ +build_vendor = @build_vendor@ +builddir = @builddir@ +datadir = @datadir@ +datarootdir = @datarootdir@ +docdir = @docdir@ +dvidir = @dvidir@ +exec_prefix = @exec_prefix@ +host = @host@ +host_alias = @host_alias@ +host_cpu = @host_cpu@ +host_os = @host_os@ +host_vendor = @host_vendor@ +htmldir = @htmldir@ +includedir = @includedir@ +infodir = @infodir@ +install_sh = @install_sh@ +libdir = @libdir@ +libexecdir = @libexecdir@ +localedir = @localedir@ +localstatedir = @localstatedir@ +mandir = @mandir@ +mkdir_p = @mkdir_p@ +oldincludedir = @oldincludedir@ +pdfdir = @pdfdir@ +prefix = @prefix@ +program_transform_name = @program_transform_name@ +psdir = @psdir@ +sbindir = @sbindir@ +sharedstatedir = @sharedstatedir@ +srcdir = @srcdir@ +sysconfdir = @sysconfdir@ +target = @target@ +target_alias = @target_alias@ +target_cpu = @target_cpu@ +target_os = @target_os@ +target_vendor = @target_vendor@ +top_build_prefix = @top_build_prefix@ +top_builddir = @top_builddir@ +top_srcdir = @top_srcdir@ +libconfig_tests_SOURCES = tests.c +libconfig_tests_CPPFLAGS = -I../tinytest -I../lib +libconfig_tests_LDADD = -L../tinytest -ltinytest \ + -L../lib/.libs -lconfig + +EXTRA_DIST = \ + tests.vcproj \ + testdata/*.cfg \ + testdata/*.txt + +all: all-am + +.SUFFIXES: +.SUFFIXES: .c .lo .o .obj +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu tests/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu tests/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): + +clean-noinstPROGRAMS: + @list='$(noinst_PROGRAMS)'; test -n "$$list" || exit 0; \ + echo " rm -f" $$list; \ + rm -f $$list || exit $$?; \ + test -n "$(EXEEXT)" || exit 0; \ + list=`for p in $$list; do echo "$$p"; done | sed 's/$(EXEEXT)$$//'`; \ + echo " rm -f" $$list; \ + rm -f $$list +libconfig_tests$(EXEEXT): $(libconfig_tests_OBJECTS) $(libconfig_tests_DEPENDENCIES) + @rm -f libconfig_tests$(EXEEXT) + $(LINK) $(libconfig_tests_OBJECTS) $(libconfig_tests_LDADD) $(LIBS) + +mostlyclean-compile: + -rm -f *.$(OBJEXT) + +distclean-compile: + -rm -f *.tab.c + +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/libconfig_tests-tests.Po@am__quote@ + +.c.o: +@am__fastdepCC_TRUE@ $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='$<' object='$@' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(COMPILE) -c $< + +.c.obj: +@am__fastdepCC_TRUE@ $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'` +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='$<' object='$@' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(COMPILE) -c `$(CYGPATH_W) '$<'` + +.c.lo: +@am__fastdepCC_TRUE@ $(LTCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='$<' object='$@' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LTCOMPILE) -c -o $@ $< + +libconfig_tests-tests.o: tests.c +@am__fastdepCC_TRUE@ $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_tests_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_tests-tests.o -MD -MP -MF $(DEPDIR)/libconfig_tests-tests.Tpo -c -o libconfig_tests-tests.o `test -f 'tests.c' || echo '$(srcdir)/'`tests.c +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/libconfig_tests-tests.Tpo $(DEPDIR)/libconfig_tests-tests.Po +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='tests.c' object='libconfig_tests-tests.o' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_tests_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_tests-tests.o `test -f 'tests.c' || echo '$(srcdir)/'`tests.c + +libconfig_tests-tests.obj: tests.c +@am__fastdepCC_TRUE@ $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_tests_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -MT libconfig_tests-tests.obj -MD -MP -MF $(DEPDIR)/libconfig_tests-tests.Tpo -c -o libconfig_tests-tests.obj `if test -f 'tests.c'; then $(CYGPATH_W) 'tests.c'; else $(CYGPATH_W) '$(srcdir)/tests.c'; fi` +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/libconfig_tests-tests.Tpo $(DEPDIR)/libconfig_tests-tests.Po +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='tests.c' object='libconfig_tests-tests.obj' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(libconfig_tests_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) -c -o libconfig_tests-tests.obj `if test -f 'tests.c'; then $(CYGPATH_W) 'tests.c'; else $(CYGPATH_W) '$(srcdir)/tests.c'; fi` + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done +check-am: all-am +check: check-am +all-am: Makefile $(PROGRAMS) +installdirs: +install: install-am +install-exec: install-exec-am +install-data: install-data-am +uninstall: uninstall-am + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-am +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-am + +clean-am: clean-generic clean-libtool clean-noinstPROGRAMS \ + mostlyclean-am + +distclean: distclean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +distclean-am: clean-am distclean-compile distclean-generic \ + distclean-tags + +dvi: dvi-am + +dvi-am: + +html: html-am + +html-am: + +info: info-am + +info-am: + +install-data-am: + +install-dvi: install-dvi-am + +install-dvi-am: + +install-exec-am: + +install-html: install-html-am + +install-html-am: + +install-info: install-info-am + +install-info-am: + +install-man: + +install-pdf: install-pdf-am + +install-pdf-am: + +install-ps: install-ps-am + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-am + +mostlyclean-am: mostlyclean-compile mostlyclean-generic \ + mostlyclean-libtool + +pdf: pdf-am + +pdf-am: + +ps: ps-am + +ps-am: + +uninstall-am: + +.MAKE: install-am install-strip + +.PHONY: CTAGS GTAGS all all-am check check-am clean clean-generic \ + clean-libtool clean-noinstPROGRAMS ctags distclean \ + distclean-compile distclean-generic distclean-libtool \ + distclean-tags distdir dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-info install-info-am install-man \ + install-pdf install-pdf-am install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + maintainer-clean maintainer-clean-generic mostlyclean \ + mostlyclean-compile mostlyclean-generic mostlyclean-libtool \ + pdf pdf-am ps ps-am tags uninstall uninstall-am + + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/tests/testdata/bad_input_0.cfg b/libconfig-1.4.9/tests/testdata/bad_input_0.cfg new file mode 100644 index 0000000000000000000000000000000000000000..587be6b4c3f93f93c489c0111bba5596147a26cb --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/bad_input_0.cfg @@ -0,0 +1 @@ +x diff --git a/libconfig-1.4.9/tests/testdata/bad_input_1.cfg b/libconfig-1.4.9/tests/testdata/bad_input_1.cfg new file mode 100644 index 0000000000000000000000000000000000000000..ee788b60bf7842ed4a78f7c98cbf65279c1aa101 --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/bad_input_1.cfg @@ -0,0 +1,7 @@ + +foo: +{ + a = 100; + b = 10; + a = "hello"; +}; diff --git a/libconfig-1.4.9/tests/testdata/input_0.cfg b/libconfig-1.4.9/tests/testdata/input_0.cfg new file mode 100644 index 0000000000000000000000000000000000000000..e69de29bb2d1d6434b8b29ae775ad8c2e48c5391 diff --git a/libconfig-1.4.9/tests/testdata/input_1.cfg b/libconfig-1.4.9/tests/testdata/input_1.cfg new file mode 100644 index 0000000000000000000000000000000000000000..131bb5e964e2263f05e31ace65d66c3254a3fc20 --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/input_1.cfg @@ -0,0 +1,3 @@ +// Empty file + +// (no settings, only comments) diff --git a/libconfig-1.4.9/tests/testdata/input_2.cfg b/libconfig-1.4.9/tests/testdata/input_2.cfg new file mode 100644 index 0000000000000000000000000000000000000000..e342dcadacb2ba15392e56234d755f5bef85c025 --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/input_2.cfg @@ -0,0 +1,18 @@ + +// File with extraneous whitespace. + + foo = 1; + + + + bar + = + "Hello, " + "world!" +; + + +baz = 2; + + + diff --git a/libconfig-1.4.9/tests/testdata/input_3.cfg b/libconfig-1.4.9/tests/testdata/input_3.cfg new file mode 100644 index 0000000000000000000000000000000000000000..ce71ad66c574f5b5e1c39d0ea9c68eb793542efc --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/input_3.cfg @@ -0,0 +1,7 @@ +// File has no trailing newline. + +foo = 1; + +bar = 2; + +baz = 3; \ No newline at end of file diff --git a/libconfig-1.4.9/tests/testdata/input_4.cfg b/libconfig-1.4.9/tests/testdata/input_4.cfg new file mode 100644 index 0000000000000000000000000000000000000000..f80387550ee70f1f79f4f1e1c07cb2062758aa6f --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/input_4.cfg @@ -0,0 +1,8 @@ +// Last line has whitespace but no trailing newline. + +foo = 1; + + +bar = 2; + + \ No newline at end of file diff --git a/libconfig-1.4.9/tests/testdata/input_5.cfg b/libconfig-1.4.9/tests/testdata/input_5.cfg new file mode 100644 index 0000000000000000000000000000000000000000..777a4249dc7d89e3411fe08148038a9c5786cfa3 --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/input_5.cfg @@ -0,0 +1 @@ +@include "more.cfg" diff --git a/libconfig-1.4.9/tests/testdata/more.cfg b/libconfig-1.4.9/tests/testdata/more.cfg new file mode 100644 index 0000000000000000000000000000000000000000..dad36e1d247bcfd06ac38e979a2213fa76be2dc1 --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/more.cfg @@ -0,0 +1,2 @@ + +message = "Hello, world!"; diff --git a/libconfig-1.4.9/tests/testdata/output_0.cfg b/libconfig-1.4.9/tests/testdata/output_0.cfg new file mode 100644 index 0000000000000000000000000000000000000000..e69de29bb2d1d6434b8b29ae775ad8c2e48c5391 diff --git a/libconfig-1.4.9/tests/testdata/output_1.cfg b/libconfig-1.4.9/tests/testdata/output_1.cfg new file mode 100644 index 0000000000000000000000000000000000000000..e69de29bb2d1d6434b8b29ae775ad8c2e48c5391 diff --git a/libconfig-1.4.9/tests/testdata/output_2.cfg b/libconfig-1.4.9/tests/testdata/output_2.cfg new file mode 100644 index 0000000000000000000000000000000000000000..80db4ae7e8ed5c0b7cf30b2a93e15e2b81f99882 --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/output_2.cfg @@ -0,0 +1,3 @@ +foo = 1; +bar = "Hello, world!"; +baz = 2; diff --git a/libconfig-1.4.9/tests/testdata/output_3.cfg b/libconfig-1.4.9/tests/testdata/output_3.cfg new file mode 100644 index 0000000000000000000000000000000000000000..6a3d00370b939f3cd2fa62776b00a6cb2c32899b --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/output_3.cfg @@ -0,0 +1,3 @@ +foo = 1; +bar = 2; +baz = 3; diff --git a/libconfig-1.4.9/tests/testdata/output_4.cfg b/libconfig-1.4.9/tests/testdata/output_4.cfg new file mode 100644 index 0000000000000000000000000000000000000000..78abe902b65f3a1f658f8d616b962fbfaac2c24e --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/output_4.cfg @@ -0,0 +1,2 @@ +foo = 1; +bar = 2; diff --git a/libconfig-1.4.9/tests/testdata/output_5.cfg b/libconfig-1.4.9/tests/testdata/output_5.cfg new file mode 100644 index 0000000000000000000000000000000000000000..25817c4f6c6b36c59a40d2334e9b03e1134f4b29 --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/output_5.cfg @@ -0,0 +1 @@ +message = "Hello, world!"; diff --git a/libconfig-1.4.9/tests/testdata/parse_error_0.txt b/libconfig-1.4.9/tests/testdata/parse_error_0.txt new file mode 100644 index 0000000000000000000000000000000000000000..dd4f68c5ea4e76d5e7d8e897b1631d29f7b2285c --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/parse_error_0.txt @@ -0,0 +1 @@ +2 syntax error diff --git a/libconfig-1.4.9/tests/testdata/parse_error_1.txt b/libconfig-1.4.9/tests/testdata/parse_error_1.txt new file mode 100644 index 0000000000000000000000000000000000000000..ce70b88a87b1e269c53a671290db5091aeff05cf --- /dev/null +++ b/libconfig-1.4.9/tests/testdata/parse_error_1.txt @@ -0,0 +1 @@ +6 duplicate setting name diff --git a/libconfig-1.4.9/tests/tests.c b/libconfig-1.4.9/tests/tests.c new file mode 100644 index 0000000000000000000000000000000000000000..e13e67f1722e72f668cb652a37f44277c8371f9d --- /dev/null +++ b/libconfig-1.4.9/tests/tests.c @@ -0,0 +1,220 @@ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include +#include +#include + +#ifdef _MSC_VER +#define snprintf _snprintf +#endif + +#include +#include + +/* ------------------------------------------------------------------------- */ + +static void parse_and_compare(const char *input_file, const char *output_file) +{ + config_t cfg; + int ok; + + config_init(&cfg); + config_set_include_dir(&cfg, "./testdata"); + + ok = config_read_file(&cfg, input_file); + if(!ok) + { + printf("error: %s:%d\n", config_error_text(&cfg), + config_error_line(&cfg)); + } + TT_ASSERT_TRUE(ok); + + remove("temp.cfg"); + TT_ASSERT_TRUE(config_write_file(&cfg, "temp.cfg")); + + TT_ASSERT_TXTFILE_EQ("temp.cfg", output_file); + remove("temp.cfg"); + + config_destroy(&cfg); +} + +static void parse_file_and_compare_error(const char *input_file, + const char *parse_error) +{ + config_t cfg; + char actual_error[128]; + char expected_error[128]; + + config_init(&cfg); + TT_ASSERT_FALSE(config_read_file(&cfg, input_file)); + + snprintf(expected_error, sizeof(expected_error), "%s:%s", + input_file, parse_error); + + snprintf(actual_error, sizeof(actual_error), "%s:%d %s\n", + config_error_file(&cfg), config_error_line(&cfg), + config_error_text(&cfg)); + + config_destroy(&cfg); + + TT_ASSERT_STR_EQ(actual_error, expected_error); +} + +static void parse_string_and_compare_error(const char *input_text, + const char *parse_error) +{ + config_t cfg; + char actual_error[128]; + char expected_error[128]; + + config_init(&cfg); + TT_ASSERT_FALSE(config_read_string(&cfg, input_text)); + + snprintf(expected_error, sizeof(expected_error), "(null):%s", parse_error); + + snprintf(actual_error, sizeof(actual_error), "%s:%d %s\n", + config_error_file(&cfg), config_error_line(&cfg), + config_error_text(&cfg)); + + config_destroy(&cfg); + + TT_ASSERT_STR_EQ(actual_error, expected_error); +} + +static const char *read_file_to_string(const char *file) +{ + struct stat stbuf; + FILE *fp; + int size; + char *buf; + size_t r; + + TT_ASSERT_INT_EQ(0, stat(file, &stbuf)); + + size = stbuf.st_size; + buf = (char *)malloc(size + 1); + + fp = fopen(file, "rt"); + TT_ASSERT_PTR_NOTNULL(fp); + + r = fread(buf, 1, size, fp); + fclose(fp); + + TT_ASSERT_INT_EQ(size, r); + + *(buf + size) = 0; + return(buf); +} + +/* ------------------------------------------------------------------------- */ + +TT_TEST(ParsingAndFormatting) +{ + int i; + + for(i = 0;; ++i) + { + char input_file[128], output_file[128]; + sprintf(input_file, "testdata/input_%d.cfg", i); + sprintf(output_file, "testdata/output_%d.cfg", i); + printf("parsing %s\n", input_file); + + if(!tt_file_exists(input_file) || !tt_file_exists(output_file)) + break; + + parse_and_compare(input_file, output_file); + } +} + +/* ------------------------------------------------------------------------- */ + +TT_TEST(ParseInvalidFiles) +{ + int i; + + for(i = 0;; ++i) + { + char input_file[128], error_file[128]; + char error_text[128]; + FILE *fp; + + sprintf(input_file, "testdata/bad_input_%d.cfg", i); + sprintf(error_file, "testdata/parse_error_%d.txt", i); + + if(!tt_file_exists(input_file) || !tt_file_exists(error_file)) + break; + + fp = fopen(error_file, "rt"); + TT_ASSERT_PTR_NOTNULL(fp); + TT_ASSERT_PTR_NOTNULL(fgets(error_text, sizeof(error_text), fp)); + fclose(fp); + + parse_file_and_compare_error(input_file, error_text); + } +} + +/* ------------------------------------------------------------------------- */ + +TT_TEST(ParseInvalidStrings) +{ + int i; + + for(i = 0;; ++i) + { + char input_file[128], error_file[128]; + const char *input_text; + char error_text[128]; + FILE *fp; + + sprintf(input_file, "testdata/bad_input_%d.cfg", i); + sprintf(error_file, "testdata/parse_error_%d.txt", i); + + if(!tt_file_exists(input_file) || !tt_file_exists(error_file)) + break; + + input_text = read_file_to_string(input_file); + + fp = fopen(error_file, "rt"); + TT_ASSERT_PTR_NOTNULL(fp); + TT_ASSERT_PTR_NOTNULL(fgets(error_text, sizeof(error_text), fp)); + fclose(fp); + + parse_string_and_compare_error(input_text, error_text); + + free((void *)input_text); + } +} + +/* ------------------------------------------------------------------------- */ + +int main(int argc, char **argv) +{ + TT_SUITE_START(LibConfigTests); + TT_SUITE_TEST(LibConfigTests, ParsingAndFormatting); + TT_SUITE_TEST(LibConfigTests, ParseInvalidFiles); + TT_SUITE_TEST(LibConfigTests, ParseInvalidStrings); + TT_SUITE_RUN(LibConfigTests); + TT_SUITE_END(LibConfigTests); + + return(0); +} diff --git a/libconfig-1.4.9/tests/tests.vcproj b/libconfig-1.4.9/tests/tests.vcproj new file mode 100644 index 0000000000000000000000000000000000000000..545caef50db5d88b9c1e28170026f10aa8777070 --- /dev/null +++ b/libconfig-1.4.9/tests/tests.vcproj @@ -0,0 +1,237 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/libconfig-1.4.9/tinytest/.deps/tinytest.Po b/libconfig-1.4.9/tinytest/.deps/tinytest.Po new file mode 100644 index 0000000000000000000000000000000000000000..9ce06a81ea45b2883a6faf07a0d2136bb2a4e647 --- /dev/null +++ b/libconfig-1.4.9/tinytest/.deps/tinytest.Po @@ -0,0 +1 @@ +# dummy diff --git a/libconfig-1.4.9/tinytest/Makefile b/libconfig-1.4.9/tinytest/Makefile new file mode 100644 index 0000000000000000000000000000000000000000..80bd57564b4e1cf715e47f550011f54a8addbd88 --- /dev/null +++ b/libconfig-1.4.9/tinytest/Makefile @@ -0,0 +1,480 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# tinytest/Makefile. Generated from Makefile.in by configure. + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + + + + +pkgdatadir = $(datadir)/libconfig +pkgincludedir = $(includedir)/libconfig +pkglibdir = $(libdir)/libconfig +pkglibexecdir = $(libexecdir)/libconfig +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = x86_64-unknown-linux-gnu +host_triplet = x86_64-unknown-linux-gnu +target_triplet = x86_64-unknown-linux-gnu +subdir = tinytest +DIST_COMMON = $(srcdir)/Makefile.am $(srcdir)/Makefile.in +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = +CONFIG_CLEAN_VPATH_FILES = +LIBRARIES = $(noinst_LIBRARIES) +ARFLAGS = cru +libtinytest_a_AR = $(AR) $(ARFLAGS) +libtinytest_a_LIBADD = +am_libtinytest_a_OBJECTS = tinytest.$(OBJEXT) +libtinytest_a_OBJECTS = $(am_libtinytest_a_OBJECTS) +DEFAULT_INCLUDES = -I. -I$(top_builddir) +depcomp = $(SHELL) $(top_srcdir)/aux-build/depcomp +am__depfiles_maybe = depfiles +am__mv = mv -f +COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +LTCOMPILE = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +CCLD = $(CC) +LINK = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) $(AM_LDFLAGS) \ + $(LDFLAGS) -o $@ +SOURCES = $(libtinytest_a_SOURCES) +DIST_SOURCES = $(libtinytest_a_SOURCES) +ETAGS = etags +CTAGS = ctags +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +ACLOCAL = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run aclocal-1.11 +AMTAR = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run tar +AR = ar +AS = as +AUTOCONF = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoconf +AUTOHEADER = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run autoheader +AUTOMAKE = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run automake-1.11 +AWK = gawk +CC = gcc +CCDEPMODE = depmode=gcc3 +CFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wdeclaration-after-statement -Wno-unused-parameter +CPP = gcc -E +CPPFLAGS = +CXX = g++ +CXXCPP = g++ -E +CXXDEPMODE = depmode=gcc3 +CXXFLAGS = -g -O2 -Wall -Wshadow -Wextra -Wno-unused-parameter +CYGPATH_W = echo +DEFS = -DHAVE_CONFIG_H +DEPDIR = .deps +DLLTOOL = false +DSYMUTIL = +DUMPBIN = +ECHO_C = +ECHO_N = -n +ECHO_T = +EGREP = /usr/bin/grep -E +EXEEXT = +FGREP = /usr/bin/grep -F +GREP = /usr/bin/grep +INSTALL = /usr/bin/install -c +INSTALL_DATA = ${INSTALL} -m 644 +INSTALL_PROGRAM = ${INSTALL} +INSTALL_SCRIPT = ${INSTALL} +INSTALL_STRIP_PROGRAM = $(install_sh) -c -s +LD = /usr/bin/ld -m elf_x86_64 +LDFLAGS = +LEX = flex +LEXLIB = +LEX_OUTPUT_ROOT = lex.yy +LIBOBJS = +LIBS = +LIBTOOL = $(SHELL) $(top_builddir)/libtool +LIPO = +LN_S = ln -s +LTLIBOBJS = +MAKEINFO = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/missing --run makeinfo +MANIFEST_TOOL = : +MKDIR_P = /usr/bin/mkdir -p +NM = /usr/bin/nm -B +NMEDIT = +OBJDUMP = objdump +OBJEXT = o +OTOOL = +OTOOL64 = +PACKAGE = libconfig +PACKAGE_BUGREPORT = hyperrealm@gmail.com +PACKAGE_NAME = libconfig +PACKAGE_STRING = libconfig 1.4.9 +PACKAGE_TARNAME = libconfig +PACKAGE_URL = http://www.hyperrealm.com/main.php?s=libconfig +PACKAGE_VERSION = 1.4.9 +PATH_SEPARATOR = : +RANLIB = ranlib +SED = /usr/bin/sed +SET_MAKE = +SHELL = /bin/sh +STRIP = strip +VERSION = 1.4.9 +YACC = bison -y +YFLAGS = +abs_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/tinytest +abs_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9/tinytest +abs_top_builddir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +abs_top_srcdir = /ufs/greta/zomer/pharcos/libconfig-1.4.9 +ac_ct_AR = ar +ac_ct_CC = gcc +ac_ct_CXX = g++ +ac_ct_DUMPBIN = +am__include = include +am__leading_dot = . +am__quote = +am__tar = ${AMTAR} chof - "$$tardir" +am__untar = ${AMTAR} xf - +bindir = ${exec_prefix}/bin +build = x86_64-unknown-linux-gnu +build_alias = +build_cpu = x86_64 +build_os = linux-gnu +build_vendor = unknown +builddir = . +datadir = ${datarootdir} +datarootdir = ${prefix}/share +docdir = ${datarootdir}/doc/${PACKAGE_TARNAME} +dvidir = ${docdir} +exec_prefix = ${prefix} +host = x86_64-unknown-linux-gnu +host_alias = +host_cpu = x86_64 +host_os = linux-gnu +host_vendor = unknown +htmldir = ${docdir} +includedir = ${prefix}/include +infodir = ${datarootdir}/info +install_sh = ${SHELL} /ufs/greta/zomer/pharcos/libconfig-1.4.9/aux-build/install-sh +libdir = ${exec_prefix}/lib +libexecdir = ${exec_prefix}/libexec +localedir = ${datarootdir}/locale +localstatedir = ${prefix}/var +mandir = ${datarootdir}/man +mkdir_p = /usr/bin/mkdir -p +oldincludedir = /usr/include +pdfdir = ${docdir} +prefix = /usr/local +program_transform_name = s,x,x, +psdir = ${docdir} +sbindir = ${exec_prefix}/sbin +sharedstatedir = ${prefix}/com +srcdir = . +sysconfdir = ${prefix}/etc +target = x86_64-unknown-linux-gnu +target_alias = +target_cpu = x86_64 +target_os = linux-gnu +target_vendor = unknown +top_build_prefix = ../ +top_builddir = .. +top_srcdir = .. +noinst_LIBRARIES = libtinytest.a +libtinytest_a_SOURCES = tinytest.c tinytest.h +EXTRA_DIST = tinytest.vcproj +all: all-am + +.SUFFIXES: +.SUFFIXES: .c .lo .o .obj +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu tinytest/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu tinytest/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): + +clean-noinstLIBRARIES: + -test -z "$(noinst_LIBRARIES)" || rm -f $(noinst_LIBRARIES) +libtinytest.a: $(libtinytest_a_OBJECTS) $(libtinytest_a_DEPENDENCIES) + -rm -f libtinytest.a + $(libtinytest_a_AR) libtinytest.a $(libtinytest_a_OBJECTS) $(libtinytest_a_LIBADD) + $(RANLIB) libtinytest.a + +mostlyclean-compile: + -rm -f *.$(OBJEXT) + +distclean-compile: + -rm -f *.tab.c + +include ./$(DEPDIR)/tinytest.Po + +.c.o: + $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +# source='$<' object='$@' libtool=no \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(COMPILE) -c $< + +.c.obj: + $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'` + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +# source='$<' object='$@' libtool=no \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(COMPILE) -c `$(CYGPATH_W) '$<'` + +.c.lo: + $(LTCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< + $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo +# source='$<' object='$@' libtool=yes \ +# DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) \ +# $(LTCOMPILE) -c -o $@ $< + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done +check-am: all-am +check: check-am +all-am: Makefile $(LIBRARIES) +installdirs: +install: install-am +install-exec: install-exec-am +install-data: install-data-am +uninstall: uninstall-am + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-am +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-am + +clean-am: clean-generic clean-libtool clean-noinstLIBRARIES \ + mostlyclean-am + +distclean: distclean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +distclean-am: clean-am distclean-compile distclean-generic \ + distclean-tags + +dvi: dvi-am + +dvi-am: + +html: html-am + +html-am: + +info: info-am + +info-am: + +install-data-am: + +install-dvi: install-dvi-am + +install-dvi-am: + +install-exec-am: + +install-html: install-html-am + +install-html-am: + +install-info: install-info-am + +install-info-am: + +install-man: + +install-pdf: install-pdf-am + +install-pdf-am: + +install-ps: install-ps-am + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-am + +mostlyclean-am: mostlyclean-compile mostlyclean-generic \ + mostlyclean-libtool + +pdf: pdf-am + +pdf-am: + +ps: ps-am + +ps-am: + +uninstall-am: + +.MAKE: install-am install-strip + +.PHONY: CTAGS GTAGS all all-am check check-am clean clean-generic \ + clean-libtool clean-noinstLIBRARIES ctags distclean \ + distclean-compile distclean-generic distclean-libtool \ + distclean-tags distdir dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-info install-info-am install-man \ + install-pdf install-pdf-am install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + maintainer-clean maintainer-clean-generic mostlyclean \ + mostlyclean-compile mostlyclean-generic mostlyclean-libtool \ + pdf pdf-am ps ps-am tags uninstall uninstall-am + + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/tinytest/Makefile.am b/libconfig-1.4.9/tinytest/Makefile.am new file mode 100644 index 0000000000000000000000000000000000000000..b49750dfd6523a91d2fdb0b53f264f439d2df033 --- /dev/null +++ b/libconfig-1.4.9/tinytest/Makefile.am @@ -0,0 +1,6 @@ + +noinst_LIBRARIES = libtinytest.a + +libtinytest_a_SOURCES = tinytest.c tinytest.h + +EXTRA_DIST = tinytest.vcproj diff --git a/libconfig-1.4.9/tinytest/Makefile.in b/libconfig-1.4.9/tinytest/Makefile.in new file mode 100644 index 0000000000000000000000000000000000000000..72432860524b7548e241f4b6a16d30e498445e59 --- /dev/null +++ b/libconfig-1.4.9/tinytest/Makefile.in @@ -0,0 +1,480 @@ +# Makefile.in generated by automake 1.11.1 from Makefile.am. +# @configure_input@ + +# Copyright (C) 1994, 1995, 1996, 1997, 1998, 1999, 2000, 2001, 2002, +# 2003, 2004, 2005, 2006, 2007, 2008, 2009 Free Software Foundation, +# Inc. +# This Makefile.in is free software; the Free Software Foundation +# gives unlimited permission to copy and/or distribute it, +# with or without modifications, as long as this notice is preserved. + +# This program is distributed in the hope that it will be useful, +# but WITHOUT ANY WARRANTY, to the extent permitted by law; without +# even the implied warranty of MERCHANTABILITY or FITNESS FOR A +# PARTICULAR PURPOSE. + +@SET_MAKE@ + +VPATH = @srcdir@ +pkgdatadir = $(datadir)/@PACKAGE@ +pkgincludedir = $(includedir)/@PACKAGE@ +pkglibdir = $(libdir)/@PACKAGE@ +pkglibexecdir = $(libexecdir)/@PACKAGE@ +am__cd = CDPATH="$${ZSH_VERSION+.}$(PATH_SEPARATOR)" && cd +install_sh_DATA = $(install_sh) -c -m 644 +install_sh_PROGRAM = $(install_sh) -c +install_sh_SCRIPT = $(install_sh) -c +INSTALL_HEADER = $(INSTALL_DATA) +transform = $(program_transform_name) +NORMAL_INSTALL = : +PRE_INSTALL = : +POST_INSTALL = : +NORMAL_UNINSTALL = : +PRE_UNINSTALL = : +POST_UNINSTALL = : +build_triplet = @build@ +host_triplet = @host@ +target_triplet = @target@ +subdir = tinytest +DIST_COMMON = $(srcdir)/Makefile.am $(srcdir)/Makefile.in +ACLOCAL_M4 = $(top_srcdir)/aclocal.m4 +am__aclocal_m4_deps = $(top_srcdir)/configure.ac +am__configure_deps = $(am__aclocal_m4_deps) $(CONFIGURE_DEPENDENCIES) \ + $(ACLOCAL_M4) +mkinstalldirs = $(SHELL) $(top_srcdir)/aux-build/mkinstalldirs +CONFIG_HEADER = $(top_builddir)/ac_config.h +CONFIG_CLEAN_FILES = +CONFIG_CLEAN_VPATH_FILES = +LIBRARIES = $(noinst_LIBRARIES) +ARFLAGS = cru +libtinytest_a_AR = $(AR) $(ARFLAGS) +libtinytest_a_LIBADD = +am_libtinytest_a_OBJECTS = tinytest.$(OBJEXT) +libtinytest_a_OBJECTS = $(am_libtinytest_a_OBJECTS) +DEFAULT_INCLUDES = -I.@am__isrc@ -I$(top_builddir) +depcomp = $(SHELL) $(top_srcdir)/aux-build/depcomp +am__depfiles_maybe = depfiles +am__mv = mv -f +COMPILE = $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) $(AM_CPPFLAGS) \ + $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +LTCOMPILE = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=compile $(CC) $(DEFS) $(DEFAULT_INCLUDES) $(INCLUDES) \ + $(AM_CPPFLAGS) $(CPPFLAGS) $(AM_CFLAGS) $(CFLAGS) +CCLD = $(CC) +LINK = $(LIBTOOL) --tag=CC $(AM_LIBTOOLFLAGS) $(LIBTOOLFLAGS) \ + --mode=link $(CCLD) $(AM_CFLAGS) $(CFLAGS) $(AM_LDFLAGS) \ + $(LDFLAGS) -o $@ +SOURCES = $(libtinytest_a_SOURCES) +DIST_SOURCES = $(libtinytest_a_SOURCES) +ETAGS = etags +CTAGS = ctags +DISTFILES = $(DIST_COMMON) $(DIST_SOURCES) $(TEXINFOS) $(EXTRA_DIST) +ACLOCAL = @ACLOCAL@ +AMTAR = @AMTAR@ +AR = @AR@ +AS = @AS@ +AUTOCONF = @AUTOCONF@ +AUTOHEADER = @AUTOHEADER@ +AUTOMAKE = @AUTOMAKE@ +AWK = @AWK@ +CC = @CC@ +CCDEPMODE = @CCDEPMODE@ +CFLAGS = @CFLAGS@ +CPP = @CPP@ +CPPFLAGS = @CPPFLAGS@ +CXX = @CXX@ +CXXCPP = @CXXCPP@ +CXXDEPMODE = @CXXDEPMODE@ +CXXFLAGS = @CXXFLAGS@ +CYGPATH_W = @CYGPATH_W@ +DEFS = @DEFS@ +DEPDIR = @DEPDIR@ +DLLTOOL = @DLLTOOL@ +DSYMUTIL = @DSYMUTIL@ +DUMPBIN = @DUMPBIN@ +ECHO_C = @ECHO_C@ +ECHO_N = @ECHO_N@ +ECHO_T = @ECHO_T@ +EGREP = @EGREP@ +EXEEXT = @EXEEXT@ +FGREP = @FGREP@ +GREP = @GREP@ +INSTALL = @INSTALL@ +INSTALL_DATA = @INSTALL_DATA@ +INSTALL_PROGRAM = @INSTALL_PROGRAM@ +INSTALL_SCRIPT = @INSTALL_SCRIPT@ +INSTALL_STRIP_PROGRAM = @INSTALL_STRIP_PROGRAM@ +LD = @LD@ +LDFLAGS = @LDFLAGS@ +LEX = @LEX@ +LEXLIB = @LEXLIB@ +LEX_OUTPUT_ROOT = @LEX_OUTPUT_ROOT@ +LIBOBJS = @LIBOBJS@ +LIBS = @LIBS@ +LIBTOOL = @LIBTOOL@ +LIPO = @LIPO@ +LN_S = @LN_S@ +LTLIBOBJS = @LTLIBOBJS@ +MAKEINFO = @MAKEINFO@ +MANIFEST_TOOL = @MANIFEST_TOOL@ +MKDIR_P = @MKDIR_P@ +NM = @NM@ +NMEDIT = @NMEDIT@ +OBJDUMP = @OBJDUMP@ +OBJEXT = @OBJEXT@ +OTOOL = @OTOOL@ +OTOOL64 = @OTOOL64@ +PACKAGE = @PACKAGE@ +PACKAGE_BUGREPORT = @PACKAGE_BUGREPORT@ +PACKAGE_NAME = @PACKAGE_NAME@ +PACKAGE_STRING = @PACKAGE_STRING@ +PACKAGE_TARNAME = @PACKAGE_TARNAME@ +PACKAGE_URL = @PACKAGE_URL@ +PACKAGE_VERSION = @PACKAGE_VERSION@ +PATH_SEPARATOR = @PATH_SEPARATOR@ +RANLIB = @RANLIB@ +SED = @SED@ +SET_MAKE = @SET_MAKE@ +SHELL = @SHELL@ +STRIP = @STRIP@ +VERSION = @VERSION@ +YACC = @YACC@ +YFLAGS = @YFLAGS@ +abs_builddir = @abs_builddir@ +abs_srcdir = @abs_srcdir@ +abs_top_builddir = @abs_top_builddir@ +abs_top_srcdir = @abs_top_srcdir@ +ac_ct_AR = @ac_ct_AR@ +ac_ct_CC = @ac_ct_CC@ +ac_ct_CXX = @ac_ct_CXX@ +ac_ct_DUMPBIN = @ac_ct_DUMPBIN@ +am__include = @am__include@ +am__leading_dot = @am__leading_dot@ +am__quote = @am__quote@ +am__tar = @am__tar@ +am__untar = @am__untar@ +bindir = @bindir@ +build = @build@ +build_alias = @build_alias@ +build_cpu = @build_cpu@ +build_os = @build_os@ +build_vendor = @build_vendor@ +builddir = @builddir@ +datadir = @datadir@ +datarootdir = @datarootdir@ +docdir = @docdir@ +dvidir = @dvidir@ +exec_prefix = @exec_prefix@ +host = @host@ +host_alias = @host_alias@ +host_cpu = @host_cpu@ +host_os = @host_os@ +host_vendor = @host_vendor@ +htmldir = @htmldir@ +includedir = @includedir@ +infodir = @infodir@ +install_sh = @install_sh@ +libdir = @libdir@ +libexecdir = @libexecdir@ +localedir = @localedir@ +localstatedir = @localstatedir@ +mandir = @mandir@ +mkdir_p = @mkdir_p@ +oldincludedir = @oldincludedir@ +pdfdir = @pdfdir@ +prefix = @prefix@ +program_transform_name = @program_transform_name@ +psdir = @psdir@ +sbindir = @sbindir@ +sharedstatedir = @sharedstatedir@ +srcdir = @srcdir@ +sysconfdir = @sysconfdir@ +target = @target@ +target_alias = @target_alias@ +target_cpu = @target_cpu@ +target_os = @target_os@ +target_vendor = @target_vendor@ +top_build_prefix = @top_build_prefix@ +top_builddir = @top_builddir@ +top_srcdir = @top_srcdir@ +noinst_LIBRARIES = libtinytest.a +libtinytest_a_SOURCES = tinytest.c tinytest.h +EXTRA_DIST = tinytest.vcproj +all: all-am + +.SUFFIXES: +.SUFFIXES: .c .lo .o .obj +$(srcdir)/Makefile.in: $(srcdir)/Makefile.am $(am__configure_deps) + @for dep in $?; do \ + case '$(am__configure_deps)' in \ + *$$dep*) \ + ( cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh ) \ + && { if test -f $@; then exit 0; else break; fi; }; \ + exit 1;; \ + esac; \ + done; \ + echo ' cd $(top_srcdir) && $(AUTOMAKE) --gnu tinytest/Makefile'; \ + $(am__cd) $(top_srcdir) && \ + $(AUTOMAKE) --gnu tinytest/Makefile +.PRECIOUS: Makefile +Makefile: $(srcdir)/Makefile.in $(top_builddir)/config.status + @case '$?' in \ + *config.status*) \ + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh;; \ + *) \ + echo ' cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe)'; \ + cd $(top_builddir) && $(SHELL) ./config.status $(subdir)/$@ $(am__depfiles_maybe);; \ + esac; + +$(top_builddir)/config.status: $(top_srcdir)/configure $(CONFIG_STATUS_DEPENDENCIES) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh + +$(top_srcdir)/configure: $(am__configure_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(ACLOCAL_M4): $(am__aclocal_m4_deps) + cd $(top_builddir) && $(MAKE) $(AM_MAKEFLAGS) am--refresh +$(am__aclocal_m4_deps): + +clean-noinstLIBRARIES: + -test -z "$(noinst_LIBRARIES)" || rm -f $(noinst_LIBRARIES) +libtinytest.a: $(libtinytest_a_OBJECTS) $(libtinytest_a_DEPENDENCIES) + -rm -f libtinytest.a + $(libtinytest_a_AR) libtinytest.a $(libtinytest_a_OBJECTS) $(libtinytest_a_LIBADD) + $(RANLIB) libtinytest.a + +mostlyclean-compile: + -rm -f *.$(OBJEXT) + +distclean-compile: + -rm -f *.tab.c + +@AMDEP_TRUE@@am__include@ @am__quote@./$(DEPDIR)/tinytest.Po@am__quote@ + +.c.o: +@am__fastdepCC_TRUE@ $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='$<' object='$@' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(COMPILE) -c $< + +.c.obj: +@am__fastdepCC_TRUE@ $(COMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ `$(CYGPATH_W) '$<'` +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Po +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='$<' object='$@' libtool=no @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(COMPILE) -c `$(CYGPATH_W) '$<'` + +.c.lo: +@am__fastdepCC_TRUE@ $(LTCOMPILE) -MT $@ -MD -MP -MF $(DEPDIR)/$*.Tpo -c -o $@ $< +@am__fastdepCC_TRUE@ $(am__mv) $(DEPDIR)/$*.Tpo $(DEPDIR)/$*.Plo +@AMDEP_TRUE@@am__fastdepCC_FALSE@ source='$<' object='$@' libtool=yes @AMDEPBACKSLASH@ +@AMDEP_TRUE@@am__fastdepCC_FALSE@ DEPDIR=$(DEPDIR) $(CCDEPMODE) $(depcomp) @AMDEPBACKSLASH@ +@am__fastdepCC_FALSE@ $(LTCOMPILE) -c -o $@ $< + +mostlyclean-libtool: + -rm -f *.lo + +clean-libtool: + -rm -rf .libs _libs + +ID: $(HEADERS) $(SOURCES) $(LISP) $(TAGS_FILES) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + mkid -fID $$unique +tags: TAGS + +TAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + set x; \ + here=`pwd`; \ + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + shift; \ + if test -z "$(ETAGS_ARGS)$$*$$unique"; then :; else \ + test -n "$$unique" || unique=$$empty_fix; \ + if test $$# -gt 0; then \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + "$$@" $$unique; \ + else \ + $(ETAGS) $(ETAGSFLAGS) $(AM_ETAGSFLAGS) $(ETAGS_ARGS) \ + $$unique; \ + fi; \ + fi +ctags: CTAGS +CTAGS: $(HEADERS) $(SOURCES) $(TAGS_DEPENDENCIES) \ + $(TAGS_FILES) $(LISP) + list='$(SOURCES) $(HEADERS) $(LISP) $(TAGS_FILES)'; \ + unique=`for i in $$list; do \ + if test -f "$$i"; then echo $$i; else echo $(srcdir)/$$i; fi; \ + done | \ + $(AWK) '{ files[$$0] = 1; nonempty = 1; } \ + END { if (nonempty) { for (i in files) print i; }; }'`; \ + test -z "$(CTAGS_ARGS)$$unique" \ + || $(CTAGS) $(CTAGSFLAGS) $(AM_CTAGSFLAGS) $(CTAGS_ARGS) \ + $$unique + +GTAGS: + here=`$(am__cd) $(top_builddir) && pwd` \ + && $(am__cd) $(top_srcdir) \ + && gtags -i $(GTAGS_ARGS) "$$here" + +distclean-tags: + -rm -f TAGS ID GTAGS GRTAGS GSYMS GPATH tags + +distdir: $(DISTFILES) + @srcdirstrip=`echo "$(srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + topsrcdirstrip=`echo "$(top_srcdir)" | sed 's/[].[^$$\\*]/\\\\&/g'`; \ + list='$(DISTFILES)'; \ + dist_files=`for file in $$list; do echo $$file; done | \ + sed -e "s|^$$srcdirstrip/||;t" \ + -e "s|^$$topsrcdirstrip/|$(top_builddir)/|;t"`; \ + case $$dist_files in \ + */*) $(MKDIR_P) `echo "$$dist_files" | \ + sed '/\//!d;s|^|$(distdir)/|;s,/[^/]*$$,,' | \ + sort -u` ;; \ + esac; \ + for file in $$dist_files; do \ + if test -f $$file || test -d $$file; then d=.; else d=$(srcdir); fi; \ + if test -d $$d/$$file; then \ + dir=`echo "/$$file" | sed -e 's,/[^/]*$$,,'`; \ + if test -d "$(distdir)/$$file"; then \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + if test -d $(srcdir)/$$file && test $$d != $(srcdir); then \ + cp -fpR $(srcdir)/$$file "$(distdir)$$dir" || exit 1; \ + find "$(distdir)/$$file" -type d ! -perm -700 -exec chmod u+rwx {} \;; \ + fi; \ + cp -fpR $$d/$$file "$(distdir)$$dir" || exit 1; \ + else \ + test -f "$(distdir)/$$file" \ + || cp -p $$d/$$file "$(distdir)/$$file" \ + || exit 1; \ + fi; \ + done +check-am: all-am +check: check-am +all-am: Makefile $(LIBRARIES) +installdirs: +install: install-am +install-exec: install-exec-am +install-data: install-data-am +uninstall: uninstall-am + +install-am: all-am + @$(MAKE) $(AM_MAKEFLAGS) install-exec-am install-data-am + +installcheck: installcheck-am +install-strip: + $(MAKE) $(AM_MAKEFLAGS) INSTALL_PROGRAM="$(INSTALL_STRIP_PROGRAM)" \ + install_sh_PROGRAM="$(INSTALL_STRIP_PROGRAM)" INSTALL_STRIP_FLAG=-s \ + `test -z '$(STRIP)' || \ + echo "INSTALL_PROGRAM_ENV=STRIPPROG='$(STRIP)'"` install +mostlyclean-generic: + +clean-generic: + +distclean-generic: + -test -z "$(CONFIG_CLEAN_FILES)" || rm -f $(CONFIG_CLEAN_FILES) + -test . = "$(srcdir)" || test -z "$(CONFIG_CLEAN_VPATH_FILES)" || rm -f $(CONFIG_CLEAN_VPATH_FILES) + +maintainer-clean-generic: + @echo "This command is intended for maintainers to use" + @echo "it deletes files that may require special tools to rebuild." +clean: clean-am + +clean-am: clean-generic clean-libtool clean-noinstLIBRARIES \ + mostlyclean-am + +distclean: distclean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +distclean-am: clean-am distclean-compile distclean-generic \ + distclean-tags + +dvi: dvi-am + +dvi-am: + +html: html-am + +html-am: + +info: info-am + +info-am: + +install-data-am: + +install-dvi: install-dvi-am + +install-dvi-am: + +install-exec-am: + +install-html: install-html-am + +install-html-am: + +install-info: install-info-am + +install-info-am: + +install-man: + +install-pdf: install-pdf-am + +install-pdf-am: + +install-ps: install-ps-am + +install-ps-am: + +installcheck-am: + +maintainer-clean: maintainer-clean-am + -rm -rf ./$(DEPDIR) + -rm -f Makefile +maintainer-clean-am: distclean-am maintainer-clean-generic + +mostlyclean: mostlyclean-am + +mostlyclean-am: mostlyclean-compile mostlyclean-generic \ + mostlyclean-libtool + +pdf: pdf-am + +pdf-am: + +ps: ps-am + +ps-am: + +uninstall-am: + +.MAKE: install-am install-strip + +.PHONY: CTAGS GTAGS all all-am check check-am clean clean-generic \ + clean-libtool clean-noinstLIBRARIES ctags distclean \ + distclean-compile distclean-generic distclean-libtool \ + distclean-tags distdir dvi dvi-am html html-am info info-am \ + install install-am install-data install-data-am install-dvi \ + install-dvi-am install-exec install-exec-am install-html \ + install-html-am install-info install-info-am install-man \ + install-pdf install-pdf-am install-ps install-ps-am \ + install-strip installcheck installcheck-am installdirs \ + maintainer-clean maintainer-clean-generic mostlyclean \ + mostlyclean-compile mostlyclean-generic mostlyclean-libtool \ + pdf pdf-am ps ps-am tags uninstall uninstall-am + + +# Tell versions [3.59,3.63) of GNU make to not export all variables. +# Otherwise a system limit (for SysV at least) may be exceeded. +.NOEXPORT: diff --git a/libconfig-1.4.9/tinytest/tinytest.c b/libconfig-1.4.9/tinytest/tinytest.c new file mode 100644 index 0000000000000000000000000000000000000000..2c00d5da6c190905c2b663a17b2c6abbd13e9305 --- /dev/null +++ b/libconfig-1.4.9/tinytest/tinytest.c @@ -0,0 +1,730 @@ +/* ---------------------------------------------------------------------------- + tinytest - A tiny C unit-testing library + Copyright (C) 2010 Mark A Lindner + + This file is part of tinytest. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include "tinytest.h" + +#include +#include + +#ifdef WIN32 +#include +#define F_OK 4 // Windows doesn't have F_OK +#else +#include +#endif + +/* + */ + +static tt_testsuite_t *__tt_current_suite = NULL; + +static const char *__tt_op_strings[] = { "==", "!=", "<", "<=", ">", ">=", + "==", "!=", "<", "<=", ">", ">=", + "==", "!=", "<", "<=", ">", ">=", + "==", "!=", "<", "<=", ">", ">=", + "==", "!=", "<", "<=", ">", ">=", + "==", "!=", "<", "<=", ">", ">=", + "==", "!=", "", "!", + "==file", "!=file", + "==txtfile", "!=txtfile" }; + +/* + */ + +static tt_bool_t __tt_chop(char *s) +{ + size_t len = strlen(s); + char *p; + tt_bool_t eol = TT_FALSE; + + for(p = s + len - 1; p > s; --p) { + if ((*p == '\r') || (*p == '\n')) { + eol = TT_TRUE; + *p = 0; + } + } + + return(eol); +} + +static tt_bool_t __tt_compare_files_text(const char *file1, const char *file2, + tt_bool_t verbose) +{ + FILE *fp1, *fp2; + char buf1[4096], buf2[4096]; + int line = 1; + int character = 0; + tt_bool_t matched = TT_TRUE, eof1, eof2; + + if(!(fp1 = fopen(file1, "rt"))) + { + printf("cannot open file: %s\n", file1); + return(TT_FALSE); + } + + if(!(fp2 = fopen(file2, "rt"))) + { + fclose(fp1); + printf("cannot open file: %s\n", file2); + return(TT_FALSE); + } + + for(;;) + { + char *r1, *r2, *p, *q; + + r1 = fgets(buf1, sizeof(buf1), fp1); + r2 = fgets(buf2, sizeof(buf2), fp2); + + if((r1 == NULL) || (r2 == NULL)) + { + matched = (r1 == r2) ? TT_TRUE : TT_FALSE; + break; + } + + eof1 = __tt_chop(r1); + eof2 = __tt_chop(r2); + + p = r1; + q = r2; + + while(*p && *q) + { + if(*p != *q) + { + matched = TT_FALSE; + break; + } + + ++character; + ++p; + ++q; + } + + if(eof1 != eof2) + matched = TT_FALSE; + + if(matched == TT_FALSE) + break; + + if(eof1 && eof2) + { + ++line; + character = 0; + } + } + + fclose(fp1); + fclose(fp2); + + if(!matched && verbose) + printf("files \"%s\" and \"%s\" differ starting at line %d, char %d\n", + file1, file2, line, character); + + return(matched); +} + +static tt_bool_t __tt_compare_files(const char *file1, const char *file2, + tt_bool_t verbose) +{ + FILE *fp1, *fp2; + char buf1[4096], buf2[4096]; + int line = 1; + int character = 0; + size_t r1, r2; + tt_bool_t done = TT_FALSE, matched = TT_TRUE; + + if(!(fp1 = fopen(file1, "rb"))) + { + printf("cannot open file: %s\n", file1); + return(TT_FALSE); + } + + if(!(fp2 = fopen(file2, "rb"))) + { + fclose(fp1); + printf("cannot open file: %s\n", file2); + return(TT_FALSE); + } + + while(!done) + { + char *p, *q, *pe, *qe; + + r1 = fread(buf1, 1, sizeof(buf1), fp1); + r2 = fread(buf2, 1, sizeof(buf2), fp2); + + p = buf1; + q = buf2; + pe = buf1 + r1; + qe = buf2 + r2; + + while(p < pe && q < qe) + { + if(*p != *q) + { + matched = TT_FALSE; + done = TT_TRUE; + break; + } + + if(*p == '\n') + { + ++line; + character = 0; + } + else + ++character; + + ++p; + ++q; + } + + if(p < pe || q < qe) + { + matched = TT_FALSE; + break; + } + + if(feof(fp1) || feof(fp2)) + break; + } + + fclose(fp1); + fclose(fp2); + + if(!matched && verbose) + printf("files \"%s\" and \"%s\" differ starting at line %d, char %d\n", + file1, file2, line, character); + + return(matched); +} + +/* + */ + +tt_testsuite_t *tt_suite_create(const char *name) +{ + tt_testsuite_t *suite = calloc(1, sizeof(tt_testsuite_t)); + suite->name = strdup(name); + return(suite); +} + +/* + */ + +void tt_suite_destroy(tt_testsuite_t *suite) +{ + tt_test_t *test = suite->first_test; + + while(test) + { + tt_test_t *tmp = test->next; + free((void *)test->name); + free(test); + test = tmp; + } + + free((void *)suite->name); + free(suite); +} + +/* + */ + +void tt_suite_add_test(tt_testsuite_t *suite, const char *name, + void (*function)(void)) +{ + tt_test_t *test = calloc(1, sizeof(tt_test_t)); + test->name = strdup(name); + test->function = function; + + if(suite->last_test != NULL) + suite->last_test->next = test; + + suite->last_test = test; + + if(suite->first_test == NULL) + suite->first_test = test; + + ++suite->num_tests; +} + +/* + */ + +void tt_suite_run(tt_testsuite_t *suite) +{ + __tt_current_suite = suite; + + suite->num_failures = 0; + + for(suite->current_test = suite->first_test; + suite->current_test; + suite->current_test = suite->current_test->next) + { + printf("[TEST] %s\n", suite->current_test->name); + + if(setjmp(suite->jump_buf) == 0) + { + suite->current_test->function(); + } + + if(suite->current_test->failed) + { + printf("[FAIL] %s\n", suite->current_test->name); + ++suite->num_failures; + } + else + { + printf("[ OK ] %s\n", suite->current_test->name); + } + } + + if(suite->num_failures > 0) + puts("*** FAILURES! ***"); + + printf("%d tests; %d passed, %d failed\n", + suite->num_tests, suite->num_tests - suite->num_failures, + suite->num_failures); + + suite->current_test = NULL; + __tt_current_suite = NULL; +} + +/* + */ + +void tt_output_val(FILE *stream, const tt_val_t *val) +{ + switch(val->type) + { + case TT_VAL_INT: + fprintf(stream, "%d", val->value.int_val); + break; + + case TT_VAL_UINT: + fprintf(stream, "%u", val->value.uint_val); + break; + + case TT_VAL_INT64: + fprintf(stream, "%lld", val->value.int64_val); + break; + + case TT_VAL_UINT64: + fprintf(stream, "%llu", val->value.uint64_val); + break; + + case TT_VAL_DOUBLE: + fprintf(stream, "%f", val->value.double_val); + break; + + case TT_VAL_STR: + { + const char *p; + + fputc('\"', stream); + for(p = val->value.str_val; *p; ++p) + { + if(*p == '\n') + fputs("\\n", stream); + else if(*p == '\r') + fputs("\\r", stream); + else if(*p == '\t') + fputs("\\t", stream); + else if(*p == '\f') + fputs("\\f", stream); + else if(*p < ' ') + fprintf(stream, "\\0x%02X", *p); + else + fputc(*p, stream); + } + fputc('\"', stream); + break; + } + + case TT_VAL_PTR: + fprintf(stream, "%p", val->value.ptr_val); + break; + + default: + fputs("???", stream); + break; + } +} + +/* + */ + +void tt_expect(const char *file, int line, const char *aexpr, + tt_op_t op, const char *bexpr, const tt_val_t a, + const tt_val_t b, tt_bool_t fatal) +{ + tt_bool_t result = TT_FALSE; + + switch(op) + { + case TT_OP_INT_EQ: + result = (a.value.int_val == b.value.int_val); + break; + + case TT_OP_INT_NE: + result = (a.value.int_val != b.value.int_val); + break; + + case TT_OP_INT_LT: + result = (a.value.int_val < b.value.int_val); + break; + + case TT_OP_INT_LE: + result = (a.value.int_val <= b.value.int_val); + break; + + case TT_OP_INT_GT: + result = (a.value.int_val > b.value.int_val); + break; + + case TT_OP_INT_GE: + result = (a.value.int_val >= b.value.int_val); + break; + + case TT_OP_UINT_EQ: + result = (a.value.uint_val == b.value.uint_val); + break; + + case TT_OP_UINT_NE: + result = (a.value.uint_val != b.value.uint_val); + break; + + case TT_OP_UINT_LT: + result = (a.value.uint_val < b.value.uint_val); + break; + + case TT_OP_UINT_LE: + result = (a.value.uint_val <= b.value.uint_val); + break; + + case TT_OP_UINT_GT: + result = (a.value.uint_val > b.value.uint_val); + break; + + case TT_OP_UINT_GE: + result = (a.value.uint_val >= b.value.uint_val); + break; + + case TT_OP_INT64_EQ: + result = (a.value.int64_val == b.value.int64_val); + break; + + case TT_OP_INT64_NE: + result = (a.value.int64_val != b.value.int64_val); + break; + + case TT_OP_INT64_LT: + result = (a.value.int64_val < b.value.int64_val); + break; + + case TT_OP_INT64_LE: + result = (a.value.int64_val <= b.value.int64_val); + break; + + case TT_OP_INT64_GT: + result = (a.value.int64_val > b.value.int64_val); + break; + + case TT_OP_INT64_GE: + result = (a.value.int64_val >= b.value.int64_val); + break; + + case TT_OP_UINT64_EQ: + result = (a.value.uint64_val == b.value.uint64_val); + break; + + case TT_OP_UINT64_NE: + result = (a.value.uint64_val != b.value.uint64_val); + break; + + case TT_OP_UINT64_LT: + result = (a.value.uint64_val < b.value.uint64_val); + break; + + case TT_OP_UINT64_LE: + result = (a.value.uint64_val <= b.value.uint64_val); + break; + + case TT_OP_UINT64_GT: + result = (a.value.uint64_val > b.value.uint64_val); + break; + + case TT_OP_UINT64_GE: + result = (a.value.uint64_val >= b.value.uint64_val); + break; + + case TT_OP_DOUBLE_EQ: + result = (a.value.double_val == b.value.double_val); + break; + + case TT_OP_DOUBLE_NE: + { + double diff = (a.value.double_val - b.value.double_val); + result = ((diff < -.0001) || (diff > .0001)); + break; + } + + case TT_OP_DOUBLE_LT: + result = (a.value.double_val < b.value.double_val); + break; + + case TT_OP_DOUBLE_LE: + result = (a.value.double_val <= b.value.double_val); + break; + + case TT_OP_DOUBLE_GT: + result = (a.value.double_val > b.value.double_val); + break; + + case TT_OP_DOUBLE_GE: + result = (a.value.double_val >= b.value.double_val); + break; + + case TT_OP_STR_EQ: + result = !strcmp(a.value.str_val, b.value.str_val); + break; + + case TT_OP_STR_NE: + result = strcmp(a.value.str_val, b.value.str_val); + break; + + case TT_OP_STR_LT: + result = (strcmp(a.value.str_val, b.value.str_val) < 0); + break; + + case TT_OP_STR_LE: + result = (strcmp(a.value.str_val, b.value.str_val) <= 0); + break; + + case TT_OP_STR_GT: + result = (strcmp(a.value.str_val, b.value.str_val) > 0); + break; + + case TT_OP_STR_GE: + result = (strcmp(a.value.str_val, b.value.str_val) >= 0); + break; + + case TT_OP_PTR_EQ: + result = (a.value.ptr_val == b.value.ptr_val); + break; + + case TT_OP_PTR_NE: + result = (a.value.ptr_val != b.value.ptr_val); + break; + + case TT_OP_FILE_EQ: + result = __tt_compare_files(a.value.str_val, b.value.str_val, TT_TRUE); + break; + + case TT_OP_FILE_NE: + result = !__tt_compare_files(a.value.str_val, b.value.str_val, TT_TRUE); + break; + + case TT_OP_TXTFILE_EQ: + result = __tt_compare_files_text(a.value.str_val, b.value.str_val, + TT_TRUE); + break; + + case TT_OP_TXTFILE_NE: + result = !__tt_compare_files_text(a.value.str_val, b.value.str_val, + TT_TRUE); + break; + + default: + break; + } + + if(!result) + { + __tt_current_suite->current_test->failed = TT_TRUE; + + printf("%s:%d: failed %s: %s [", file, line, (fatal ? "assert" : "expect"), + aexpr); + tt_output_val(stdout, &a); + printf("] %s %s [", __tt_op_strings[op], bexpr); + tt_output_val(stdout, &b); + puts("]"); + + if(fatal) + longjmp(__tt_current_suite->jump_buf, 0); + } +} + +/* + */ + +void tt_expect_bool(const char *file, int line, const char *expr, tt_op_t op, + int val, tt_bool_t fatal) +{ + tt_bool_t result = TT_FALSE; + + switch(op) + { + case TT_OP_TRUE: + result = (val != 0); + break; + + case TT_OP_FALSE: + result = (val == 0); + break; + + default: + break; + } + + if(!result) + { + __tt_current_suite->current_test->failed = TT_TRUE; + + printf("%s:%d: failed %s: %s(%s)\n", file, line, + (fatal ? "assert" : "expect"), __tt_op_strings[op], expr); + + if(fatal) + longjmp(__tt_current_suite->jump_buf, 0); + } +} + +/* + */ + +void tt_fail(const char *file, int line, const char *message, ...) +{ + va_list vp; + va_start(vp, message); + printf("%s:%d: failed: ", file, line); + vprintf(message, vp); + va_end(vp); + putchar('\n'); +} + +/* + */ + +tt_bool_t tt_file_exists(const char *file) +{ + return(access(file, F_OK) == 0); +} + +#ifdef _MSC_VER + +// All of this extra code is because MSVC doesn't support the C99 standard. +// Sigh. + +/* + */ + +void tt_test_int(const char *file, int line, const char *aexpr, tt_op_t op, + const char *bexpr, int a, int b, tt_bool_t fatal) +{ + tt_val_t aval = { TT_VAL_INT }, bval = { TT_VAL_INT }; + aval.value.int_val = a; + bval.value.int_val = b; + tt_expect(file, line, aexpr, op, bexpr, aval, bval, fatal); +} + +/* + */ + +void tt_test_uint(const char *file, int line, const char *aexpr, tt_op_t op, + const char *bexpr, unsigned int a, unsigned int b, + tt_bool_t fatal) +{ + tt_val_t aval = { TT_VAL_UINT }, bval = { TT_VAL_UINT }; + aval.value.uint_val = a; + bval.value.uint_val = b; + tt_expect(file, line, aexpr, op, bexpr, aval, bval, fatal); +} + +/* + */ + +void tt_test_int64(const char *file, int line, const char *aexpr, tt_op_t op, + const char *bexpr, long long a, long long b, + tt_bool_t fatal) +{ + tt_val_t aval = { TT_VAL_INT64 }, bval = { TT_VAL_INT64 }; + aval.value.int64_val = a; + bval.value.int64_val = b; + tt_expect(file, line, aexpr, op, bexpr, aval, bval, fatal); +} + +/* + */ + +void tt_test_uint64(const char *file, int line, const char *aexpr, + tt_op_t op, const char *bexpr, unsigned long long a, + unsigned long long b, tt_bool_t fatal) +{ + tt_val_t aval = { TT_VAL_UINT64 }, bval = { TT_VAL_UINT64 }; + aval.value.uint64_val = a; + bval.value.uint64_val = b; + tt_expect(file, line, aexpr, op, bexpr, aval, bval, fatal); +} + +/* + */ + +void tt_test_double(const char *file, int line, const char *aexpr, tt_op_t op, + const char *bexpr, double a, double b, tt_bool_t fatal) +{ + tt_val_t aval = { TT_VAL_DOUBLE }, bval = { TT_VAL_DOUBLE }; + aval.value.double_val = a; + bval.value.double_val = b; + tt_expect(file, line, aexpr, op, bexpr, aval, bval, fatal); +} + +/* + */ + +void tt_test_str(const char *file, int line, const char *aexpr, tt_op_t op, + const char *bexpr, const char *a, const char *b, + tt_bool_t fatal) +{ + tt_val_t aval = { TT_VAL_STR }, bval = { TT_VAL_STR }; + aval.value.str_val = a; + bval.value.str_val = b; + tt_expect(file, line, aexpr, op, bexpr, aval, bval, fatal); +} + +/* + */ + +void tt_test_ptr(const char *file, int line, const char *aexpr, tt_op_t op, + const char *bexpr, const void *a, const void *b, + tt_bool_t fatal) +{ + tt_val_t aval = { TT_VAL_PTR }, bval = { TT_VAL_PTR }; + aval.value.ptr_val = a; + bval.value.ptr_val = b; + tt_expect(file, line, aexpr, op, bexpr, aval, bval, fatal); +} + +#endif // WIN32 + +/* end of source file */ diff --git a/libconfig-1.4.9/tinytest/tinytest.h b/libconfig-1.4.9/tinytest/tinytest.h new file mode 100644 index 0000000000000000000000000000000000000000..dd6e32a6d9556e07ec83299faad8a79ebf565337 --- /dev/null +++ b/libconfig-1.4.9/tinytest/tinytest.h @@ -0,0 +1,536 @@ +/* ---------------------------------------------------------------------------- + tinytest - A tiny C unit-testing library + Copyright (C) 2010 Mark A Lindner + + This file is part of tinytest. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#ifndef __tinytest_h +#define __tinytest_h + +#include +#include +#include + +typedef int tt_bool_t; + +#define TT_TRUE (1) +#define TT_FALSE (0) + +typedef struct tt_test_t +{ + const char *name; + void (*function)(void); + tt_bool_t failed; + struct tt_test_t *next; +} tt_test_t; + +typedef struct tt_testsuite_t +{ + const char *name; + tt_test_t *first_test; + tt_test_t *last_test; + tt_test_t *current_test; + int num_tests; + int num_failures; + jmp_buf jump_buf; +} tt_testsuite_t; + +typedef enum { TT_VAL_INT, TT_VAL_UINT, TT_VAL_INT64, TT_VAL_UINT64, + TT_VAL_DOUBLE, TT_VAL_STR, TT_VAL_PTR } tt_valtype_t; + +typedef enum { TT_OP_INT_EQ, TT_OP_INT_NE, TT_OP_INT_LT, TT_OP_INT_LE, + TT_OP_INT_GT, TT_OP_INT_GE, TT_OP_UINT_EQ, TT_OP_UINT_NE, + TT_OP_UINT_LT, TT_OP_UINT_LE, TT_OP_UINT_GT, TT_OP_UINT_GE, + TT_OP_INT64_EQ, TT_OP_INT64_NE, TT_OP_INT64_LT, TT_OP_INT64_LE, + TT_OP_INT64_GT, TT_OP_INT64_GE, TT_OP_UINT64_EQ, + TT_OP_UINT64_NE, TT_OP_UINT64_LT, TT_OP_UINT64_LE, + TT_OP_UINT64_GT, TT_OP_UINT64_GE, TT_OP_DOUBLE_EQ, + TT_OP_DOUBLE_NE, TT_OP_DOUBLE_LT, TT_OP_DOUBLE_LE, + TT_OP_DOUBLE_GT, TT_OP_DOUBLE_GE, TT_OP_STR_EQ, TT_OP_STR_NE, + TT_OP_STR_LT, TT_OP_STR_LE, TT_OP_STR_GT, TT_OP_STR_GE, + TT_OP_PTR_EQ, TT_OP_PTR_NE, TT_OP_TRUE, TT_OP_FALSE, + TT_OP_FILE_EQ, TT_OP_FILE_NE, TT_OP_TXTFILE_EQ, + TT_OP_TXTFILE_NE } tt_op_t; + +typedef struct tt_val_t +{ + tt_valtype_t type; + union { + int int_val; + unsigned int uint_val; + long long int64_val; + unsigned long long uint64_val; + double double_val; + const char *str_val; + const void *ptr_val; + } value; +} tt_val_t; + + +extern tt_testsuite_t *tt_suite_create(const char *name); + +extern void tt_suite_destroy(tt_testsuite_t *suite); + +extern void tt_suite_add_test(tt_testsuite_t *suite, const char *name, + void (*function)(void)); + +extern void tt_suite_run(tt_testsuite_t *suite); + +extern void tt_expect(const char *file, int line, const char *aexpr, + tt_op_t op, const char *bexpr, + const tt_val_t a, const tt_val_t b, + tt_bool_t fatal); + +extern void tt_expect_bool(const char *file, int line, const char *expr, + tt_op_t op, int val, tt_bool_t fatal); + +extern void tt_fail(const char *file, int line, const char *message, ...); + +extern tt_bool_t tt_file_exists(const char *file); + +#ifdef _MSC_VER + +extern void tt_test_int(const char *file, int line, const char *aexpr, + tt_op_t op, const char *bexpr, int a, int b, + tt_bool_t fatal); + +#define TT_TEST_INT_(A, OP, B, F) \ + tt_test_int(__FILE__, __LINE__, #A, (OP), #B, (A), (B), (F)) + +#else + +#define TT_TEST_INT_(A, OP, B, F) \ + tt_expect(__FILE__, __LINE__, #A, (OP), #B, \ + (tt_val_t){ TT_VAL_INT, .value.int_val = (A) }, \ + (tt_val_t){ TT_VAL_INT, .value.int_val = (B) }, \ + (F)) + +#endif + +#define TT_EXPECT_INT_EQ(A, B) \ + TT_TEST_INT_((A), TT_OP_INT_EQ, (B), TT_FALSE) + +#define TT_ASSERT_INT_EQ(A, B) \ + TT_TEST_INT_((A), TT_OP_INT_EQ, (B), TT_TRUE) + +#define TT_EXPECT_INT_NE(A, B) \ + TT_TEST_INT_((A), TT_OP_INT_NE, (B), TT_FALSE) + +#define TT_ASSERT_INT_NE(A, B) \ + TT_TEST_INT_((A), TT_OP_INT_NE, (B), TT_TRUE) + +#define TT_EXPECT_INT_LT(A, B) \ + TT_TEST_INT_((A), TT_OP_INT_LT, (B), TT_FALSE) + +#define TT_ASSERT_INT_LT(A, B) \ + TT_TEST_INT_((A), TT_OP_INT_LT, (B), TT_TRUE) + +#define TT_EXPECT_INT_LE(A, B) \ + TT_TEST_INT_((A), TT_OP_INT_LE, (B), TT_FALSE) + +#define TT_ASSERT_INT_LE(A, B) \ + TT_TEST_INT_((A), TT_OP_INT_LE, (B), TT_TRUE) + +#define TT_EXPECT_INT_GT(A, B) \ + TT_TEST_INT_((A), TT_OP_INT_GT, (B), TT_FALSE) + +#define TT_ASSERT_INT_GT(A, B) \ + TT_TEST_INT_((A), TT_OP_INT_GT, (B), TT_TRUE) + +#define TT_EXPECT_INT_GE(A, B) \ + TT_TEST_INT_((A), TT_OP_INT_GE, (B), TT_FALSE) + +#define TT_ASSERT_INT_GE(A, B) \ + TT_TEST_INT_((A), TT_OP_INT_GE, (B), TT_TRUE) + +#ifdef _MSC_VER + +extern void tt_test_uint(const char *file, int line, const char *aexpr, + tt_op_t op, const char *bexpr, unsigned int a, + unsigned int b, tt_bool_t fatal); + +#define TT_TEST_UINT_(A, OP, B, F) \ + tt_test_uint(__FILE__, __LINE__, #A, (OP), #B, (A), (B), (F)) + +#else + +#define TT_TEST_UINT_(A, OP, B, F) \ + tt_expect(__FILE__, __LINE__, #A, OP, #B, \ + (tt_val_t){ TT_VAL_UINT, .value.uint_val = (A) }, \ + (tt_val_t){ TT_VAL_UINT, .value.uint_val = (B) }, \ + (F)) + +#endif + +#define TT_EXPECT_UINT_EQ(A, B) \ + TT_TEST_UINT_((A), TT_OP_UINT_EQ, (B), TT_FALSE) + +#define TT_ASSERT_UINT_EQ(A, B) \ + TT_TEST_UINT_((A), TT_OP_UINT_EQ, (B), TT_TRUE) + +#define TT_EXPECT_UINT_NE(A, B) \ + TT_TEST_UINT_((A), TT_OP_UINT_NE, (B), TT_FALSE) + +#define TT_ASSERT_UINT_NE(A, B) \ + TT_TEST_UINT_((A), TT_OP_UINT_NE, (B), TT_TRUE) + +#define TT_EXPECT_UINT_LT(A, B) \ + TT_TEST_UINT_((A), TT_OP_UINT_LT, (B), TT_FALSE) + +#define TT_ASSERT_UINT_LT(A, B) \ + TT_TEST_UINT_((A), TT_OP_UINT_LT, (B), TT_TRUE) + +#define TT_EXPECT_UINT_LE(A, B) \ + TT_TEST_UINT_((A), TT_OP_UINT_LE, (B), TT_FALSE) + +#define TT_ASSERT_UINT_LE(A, B) \ + TT_TEST_UINT_((A), TT_OP_UINT_LE, (B), TT_TRUE) + +#define TT_EXPECT_UINT_GT(A, B) \ + TT_TEST_UINT_((A), TT_OP_UINT_GT, (B), TT_FALSE) + +#define TT_ASSERT_UINT_GT(A, B) \ + TT_TEST_UINT_((A), TT_OP_UINT_GT, (B), TT_TRUE) + +#define TT_EXPECT_UINT_GE(A, B) \ + TT_TEST_UINT_((A), TT_OP_UINT_GE, (B), TT_FALSE) + +#define TT_ASSERT_UINT_GE(A, B) \ + TT_TEST_UINT_((A), TT_OP_UINT_GE, (B), TT_TRUE) + +#ifdef _MSC_VER + +extern void tt_test_int64(const char *file, int line, const char *aexpr, + tt_op_t op, const char *bexpr, long long a, + long long b, tt_bool_t fatal); + +#define TT_TEST_INT64_(A, OP, B, F) \ + tt_test_int64(__FILE__, __LINE__, #A, (OP), #B, (A), (B), (F)) + +#else + +#define TT_TEST_INT64_(A, OP, B, F) \ + tt_expect(__FILE__, __LINE__, #A, OP, #B, \ + (tt_val_t){ TT_VAL_INT64, .value.int64_val = (A) }, \ + (tt_val_t){ TT_VAL_INT64, .value.int64_val = (B) }, \ + (F)) + +#endif + +#define TT_EXPECT_INT64_EQ(A, B) \ + TT_TEST_INT64_((A), TT_OP_INT64_EQ, (B), TT_FALSE) + +#define TT_ASSERT_INT64_EQ(A, B) \ + TT_TEST_INT64_((A), TT_OP_INT64_EQ, (B), TT_TRUE) + +#define TT_EXPECT_INT64_NE(A, B) \ + TT_TEST_INT64_((A), TT_OP_INT64_NE, (B), TT_FALSE) + +#define TT_ASSERT_INT64_NE(A, B) \ + TT_TEST_INT64_((A), TT_OP_INT64_NE, (B), TT_TRUE) + +#define TT_EXPECT_INT64_LT(A, B) \ + TT_TEST_INT64_((A), TT_OP_INT64_LT, (B), TT_FALSE) + +#define TT_ASSERT_INT64_LT(A, B) \ + TT_TEST_INT64_((A), TT_OP_INT64_LT, (B), TT_TRUE) + +#define TT_EXPECT_INT64_LE(A, B) \ + TT_TEST_INT64_((A), TT_OP_INT64_LE, (B), TT_FALSE) + +#define TT_ASSERT_INT64_LE(A, B) \ + TT_TEST_INT64_((A), TT_OP_INT64_LE, (B), TT_TRUE) + +#define TT_EXPECT_INT64_GT(A, B) \ + TT_TEST_INT64_((A), TT_OP_INT64_GT, (B), TT_FALSE) + +#define TT_ASSERT_INT64_GT(A, B) \ + TT_TEST_INT64_((A), TT_OP_INT64_GT, (B), TT_TRUE) + +#define TT_EXPECT_INT64_GE(A, B) \ + TT_TEST_INT64_((A), TT_OP_INT64_GE, (B), TT_FALSE) + +#define TT_ASSERT_INT64_GE(A, B) \ + TT_TEST_INT64_((A), TT_OP_INT64_GE, (B), TT_TRUE) + +#ifdef _MSC_VER + +extern void tt_test_uint64(const char *file, int line, const char *aexpr, + tt_op_t op, const char *bexpr, + unsigned long long a, unsigned long long b, + tt_bool_t fatal); + +#define TT_TEST_UINT64_(A, OP, B, F) \ + tt_test_uint64(__FILE__, __LINE__, #A, (OP), #B, (A), (B), (F)) + +#else + +#define TT_TEST_UINT64_(A, OP, B, F) \ + tt_expect(__FILE__, __LINE__, #A, OP, #B, \ + (tt_val_t){ TT_VAL_UINT64, .value.uint64_val = (A) }, \ + (tt_val_t){ TT_VAL_UINT64, .value.uint64_val = (B) }, \ + (F)) + +#endif + +#define TT_EXPECT_UINT64_EQ(A, B) \ + TT_TEST_UINT64_((A), TT_OP_UINT64_EQ, (B), TT_FALSE) + +#define TT_ASSERT_UINT64_EQ(A, B) \ + TT_TEST_UINT64_((A), TT_OP_UINT64_EQ, (B), TT_TRUE) + +#define TT_EXPECT_UINT64_NE(A, B) \ + TT_TEST_UINT64_((A), TT_OP_UINT64_NE, (B), TT_FALSE) + +#define TT_ASSERT_UINT64_NE(A, B) \ + TT_TEST_UINT64_((A), TT_OP_UINT64_NE, (B), TT_TRUE) + +#define TT_EXPECT_UINT64_LT(A, B) \ + TT_TEST_UINT64_((A), TT_OP_UINT64_LT, (B), TT_FALSE) + +#define TT_ASSERT_UINT64_LT(A, B) \ + TT_TEST_UINT64_((A), TT_OP_UINT64_LT, (B), TT_TRUE) + +#define TT_EXPECT_UINT64_LE(A, B) \ + TT_TEST_UINT64_((A), TT_OP_UINT64_LE, (B), TT_FALSE) + +#define TT_ASSERT_UINT64_LE(A, B) \ + TT_TEST_UINT64_((A), TT_OP_UINT64_LE, (B), TT_TRUE) + +#define TT_EXPECT_UINT64_GT(A, B) \ + TT_TEST_UINT64_((A), TT_OP_UINT64_GT, (B), TT_FALSE) + +#define TT_ASSERT_UINT64_GT(A, B) \ + TT_TEST_UINT64_((A), TT_OP_UINT64_GT, (B), TT_TRUE) + +#define TT_EXPECT_UINT64_GE(A, B) \ + TT_TEST_UINT64_((A), TT_OP_UINT64_GE, (B), TT_FALSE) + +#define TT_ASSERT_UINT64_GE(A, B) \ + TT_TEST_UINT64_((A), TT_OP_UINT64_GE, (B), TT_TRUE) + +#ifdef _MSC_VER + +extern void tt_test_double(const char *file, int line, const char *aexpr, + tt_op_t op, const char *bexpr, double a, + double b, tt_bool_t fatal); + +#define TT_TEST_DOUBLE_(A, OP, B, F) \ + tt_test_double(__FILE__, __LINE__, #A, (OP), #B, (A), (B), (F)) + +#else + +#define TT_TEST_DOUBLE_(A, OP, B, F) \ + tt_expect(__FILE__, __LINE__, #A, OP, #B, \ + (tt_val_t){ TT_VAL_DOUBLE, .value.double_val = (A) }, \ + (tt_val_t){ TT_VAL_DOUBLE, .value.double_val = (B) }, \ + (F)) + +#endif + +#define TT_EXPECT_DOUBLE_EQ(A, B) \ + TT_TEST_DOUBLE_((A), TT_OP_DOUBLE_EQ, (B), TT_FALSE) + +#define TT_ASSERT_DOUBLE_EQ(A, B) \ + TT_TEST_DOUBLE_((A), TT_OP_DOUBLE_EQ, (B), TT_TRUE) + +#define TT_EXPECT_DOUBLE_NE(A, B) \ + TT_TEST_DOUBLE_((A), TT_OP_DOUBLE_NE, (B), TT_FALSE) + +#define TT_ASSERT_DOUBLE_NE(A, B) \ + TT_TEST_DOUBLE_((A), TT_OP_DOUBLE_NE, (B), TT_TRUE) + +#define TT_EXPECT_DOUBLE_LT(A, B) \ + TT_TEST_DOUBLE_((A), TT_OP_DOUBLE_LT, (B), TT_FALSE) + +#define TT_ASSERT_DOUBLE_LT(A, B) \ + TT_TEST_DOUBLE_((A), TT_OP_DOUBLE_LT, (B), TT_TRUE) + +#define TT_EXPECT_DOUBLE_LE(A, B) \ + TT_TEST_DOUBLE_((A), TT_OP_DOUBLE_LE, (B), TT_FALSE) + +#define TT_ASSERT_DOUBLE_LE(A, B) \ + TT_TEST_DOUBLE_((A), TT_OP_DOUBLE_LE, (B), TT_TRUE) + +#define TT_EXPECT_DOUBLE_GT(A, B) \ + TT_TEST_DOUBLE_((A), TT_OP_DOUBLE_GT, (B), TT_FALSE) + +#define TT_ASSERT_DOUBLE_GT(A, B) \ + TT_TEST_DOUBLE_((A), TT_OP_DOUBLE_GT, (B), TT_TRUE) + +#define TT_EXPECT_DOUBLE_GE(A, B) \ + TT_TEST_DOUBLE_((A), TT_OP_DOUBLE_GE, (B), TT_FALSE) + +#define TT_ASSERT_DOUBLE_GE(A, B) \ + TT_TEST_DOUBLE_((A), TT_OP_DOUBLE_GE, (B), TT_TRUE) + +#ifdef _MSC_VER + +extern void tt_test_str(const char *file, int line, const char *aexpr, + tt_op_t op, const char *bexpr, const char *a, + const char *b, tt_bool_t fatal); + +#define TT_TEST_STR_(A, OP, B, F) \ + tt_test_str(__FILE__, __LINE__, #A, (OP), #B, (A), (B), (F)) + +#else + +#define TT_TEST_STR_(A, OP, B, F) \ + tt_expect(__FILE__, __LINE__, #A, OP, #B, \ + (tt_val_t){ TT_VAL_STR, .value.str_val = (A) }, \ + (tt_val_t){ TT_VAL_STR, .value.str_val = (B) }, \ + (F)) + +#endif + +#define TT_EXPECT_STR_EQ(A, B) \ + TT_TEST_STR_((A), TT_OP_STR_EQ, (B), TT_FALSE) + +#define TT_ASSERT_STR_EQ(A, B) \ + TT_TEST_STR_((A), TT_OP_STR_EQ, (B), TT_TRUE) + +#define TT_EXPECT_STR_NE(A, B) \ + TT_TEST_STR_((A), TT_OP_STR_NE, (B), TT_FALSE) + +#define TT_ASSERT_STR_NE(A, B) \ + TT_TEST_STR_((A), TT_OP_STR_NE, (B), TT_TRUE) + +#define TT_EXPECT_STR_LT(A, B) \ + TT_TEST_STR_((A), TT_OP_STR_LT, (B), TT_FALSE) + +#define TT_ASSERT_STR_LT(A, B) \ + TT_TEST_STR_((A), TT_OP_STR_LT, (B), TT_TRUE) + +#define TT_EXPECT_STR_LE(A, B) \ + TT_TEST_STR_((A), TT_OP_STR_LE, (B), TT_FALSE) + +#define TT_ASSERT_STR_LE(A, B) \ + TT_TEST_STR_((A), TT_OP_STR_LE, (B), TT_TRUE) + +#define TT_EXPECT_STR_GT(A, B) \ + TT_TEST_STR_((A), TT_OP_STR_GT, (B), TT_FALSE) + +#define TT_ASSERT_STR_GT(A, B) \ + TT_TEST_STR_((A), TT_OP_STR_GT, (B), TT_TRUE) + +#define TT_EXPECT_STR_GE(A, B) \ + TT_TEST_STR_((A), TT_OP_STR_GE, (B), TT_FALSE) + +#define TT_ASSERT_STR_GE(A, B) \ + TT_TEST_STR_((A), TT_OP_STR_GE, (B), TT_TRUE) + +#ifdef _MSC_VER + +extern void tt_test_ptr(const char *file, int line, const char *aexpr, + tt_op_t op, const char *bexpr, const void *a, + const void *b, tt_bool_t fatal); + +#define TT_TEST_PTR_(A, OP, B, F) \ + tt_test_ptr(__FILE__, __LINE__, #A, (OP), #B, (A), (B), (F)) + +#else + +#define TT_TEST_PTR_(A, OP, B, F) \ + tt_expect(__FILE__, __LINE__, #A, OP, #B, \ + (tt_val_t){ TT_VAL_PTR, .value.ptr_val = (A) }, \ + (tt_val_t){ TT_VAL_PTR, .value.ptr_val = (B) }, \ + (F)) + +#endif + +#define TT_EXPECT_PTR_EQ(A, B) \ + TT_TEST_PTR_((A), TT_OP_PTR_EQ, (B), TT_FALSE) + +#define TT_ASSERT_PTR_EQ(A, B) \ + TT_TEST_PTR_((A), TT_OP_PTR_EQ, (B), TT_TRUE) + +#define TT_EXPECT_PTR_NE(A, B) \ + TT_TEST_PTR_((A), TT_OP_PTR_NE, (B), TT_FALSE) + +#define TT_ASSERT_PTR_NE(A, B) \ + TT_TEST_PTR_((A), TT_OP_PTR_NE, (B), TT_TRUE) + +#define TT_EXPECT_PTR_NOTNULL(A) \ + TT_TEST_PTR_((A), TT_OP_PTR_NE, NULL, TT_FALSE) + +#define TT_ASSERT_PTR_NOTNULL(A) \ + TT_TEST_PTR_((A), TT_OP_PTR_NE, NULL, TT_TRUE) + +#define TT_EXPECT_PTR_NULL(A) \ + TT_TEST_PTR_((A), TT_OP_PTR_EQ, NULL, TT_FALSE) + +#define TT_ASSERT_PTR_NULL(A) \ + TT_TEST_PTR_((A), TT_OP_PTR_EQ, NULL, TT_TRUE) + +#define TT_EXPECT_TRUE(A) \ + tt_expect_bool(__FILE__, __LINE__, #A, TT_OP_TRUE, (A), TT_FALSE) + +#define TT_ASSERT_TRUE(A) \ + tt_expect_bool(__FILE__, __LINE__, #A, TT_OP_TRUE, (A), TT_TRUE) + +#define TT_EXPECT_FALSE(A) \ + tt_expect_bool(__FILE__, __LINE__, #A, TT_OP_FALSE, (A), TT_FALSE) + +#define TT_ASSERT_FALSE(A) \ + tt_expect_bool(__FILE__, __LINE__, #A, TT_OP_FALSE, (A), TT_TRUE) + +#define TT_EXPECT_FILE_EQ(A, B) \ + TT_TEST_STR_((A), TT_OP_FILE_EQ, (B), TT_FALSE) + +#define TT_ASSERT_FILE_EQ(A, B) \ + TT_TEST_STR_((A), TT_OP_FILE_EQ, (B), TT_TRUE) + +#define TT_EXPECT_FILE_NE(A, B) \ + TT_TEST_STR_((A), TT_OP_FILE_NE, (B), TT_FALSE) + +#define TT_ASSERT_FILE_NE(A, B) \ + TT_TEST_STR_((A), TT_OP_FILE_NE, (B), TT_TRUE) + +#define TT_EXPECT_TXTFILE_EQ(A, B) \ + TT_TEST_STR_((A), TT_OP_TXTFILE_EQ, (B), TT_FALSE) + +#define TT_ASSERT_TXTFILE_EQ(A, B) \ + TT_TEST_STR_((A), TT_OP_TXTFILE_EQ, (B), TT_TRUE) + +#define TT_EXPECT_TXTFILE_NE(A, B) \ + TT_TEST_STR_((A), TT_OP_TXTFILE_NE, (B), TT_FALSE) + +#define TT_ASSERT_TXTFILE_NE(A, B) \ + TT_TEST_STR_((A), TT_OP_TXTFILE_NE, (B), TT_TRUE) + +#define TT_FAIL(M, ...) \ + tt_fail(__FILE__, __LINE__, (M), __VA_ARGS__) + +#define TT_SUITE_START(S) \ + tt_testsuite_t *__suite__ ## S = tt_suite_create(#S) + +#define TT_SUITE_TEST(S, F) \ + tt_suite_add_test(__suite__ ## S, #F, F); + +#define TT_TEST(F) \ + static void F(void) + +#define TT_SUITE_END(S) \ + tt_suite_destroy(__suite__ ## S) + +#define TT_SUITE_RUN(S) \ + tt_suite_run(__suite__ ## S) + + +#endif // __tinytest_h diff --git a/libconfig-1.4.9/tinytest/tinytest.vcproj b/libconfig-1.4.9/tinytest/tinytest.vcproj new file mode 100644 index 0000000000000000000000000000000000000000..109089e2b8ec4e04cedb09dd05f642ddd75c841a --- /dev/null +++ b/libconfig-1.4.9/tinytest/tinytest.vcproj @@ -0,0 +1,168 @@ + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + diff --git a/output/tree.C000.dat b/output/tree.C000.dat new file mode 100644 index 0000000000000000000000000000000000000000..5d115f3814a5661a677c3747c92a5eaeb9681b16 --- /dev/null +++ b/output/tree.C000.dat @@ -0,0 +1,45 @@ +time 0 +open C000 0 0 600 600 0 15 0 +open C000a 0 1168 16 1200 1 9 0 +open C000aa 0 2352 16 2400 2 9 0 +open C000aaa 0 4704 16 4800 3 9 0 +close C000aaa +open C000aab 16 4704 32 4800 3 8 0 +close C000aab +close C000aa +open C000ab 16 2352 32 2400 2 8 0 +open C000aba 32 4704 48 4800 3 8 0 +close C000aba +open C000abb 48 4704 64 4800 3 8 0 +close C000abb +close C000ab +close C000a +open C000b 16 1168 32 1200 1 8 0 +open C000ba 32 2352 48 2400 2 8 0 +open C000baa 64 4704 80 4800 3 8 0 +close C000baa +open C000bab 80 4704 96 4800 3 8 0 +close C000bab +close C000ba +open C000bb 48 2352 64 2400 2 8 0 +open C000bba 96 4720 112 4800 3 8 0 +close C000bba +open C000bbb 112 4720 128 4800 3 8 0 +close C000bbb +close C000bb +close C000b +open C000c 32 1184 48 1200 1 8 0 +open C000ca 64 2368 80 2400 2 8 0 +open C000caa 128 4736 144 4800 3 8 0 +close C000caa +open C000cab 144 4752 160 4800 3 8 0 +close C000cab +close C000ca +open C000cb 80 2384 96 2400 2 8 0 +open C000cba 160 4768 176 4800 3 8 0 +close C000cba +open C000cbb 176 4784 192 4800 3 8 0 +close C000cbb +close C000cb +close C000c +close C000 diff --git a/output/tree.C001.dat b/output/tree.C001.dat new file mode 100644 index 0000000000000000000000000000000000000000..b292ca4b8eadb69159216fd4d962129909429b3f --- /dev/null +++ b/output/tree.C001.dat @@ -0,0 +1,45 @@ +time 0.10496 +open C001 0 0 600 600 0 15 0 +open C001a 0 1168 16 1200 1 9 0 +open C001aa 0 2336 16 2400 2 9 0 +open C001aaa 0 4688 16 4800 3 9 0 +close C001aaa +open C001aab 16 4688 32 4800 3 8 0 +close C001aab +close C001aa +open C001ab 16 2336 32 2400 2 8 0 +open C001aba 32 4688 48 4800 3 8 0 +close C001aba +open C001abb 48 4704 64 4800 3 8 0 +close C001abb +close C001ab +close C001a +open C001b 16 1168 32 1200 1 8 0 +open C001ba 32 2352 48 2400 2 8 0 +open C001baa 64 4704 80 4800 3 8 0 +close C001baa +open C001bab 80 4704 96 4800 3 8 0 +close C001bab +close C001ba +open C001bb 48 2352 64 2400 2 8 0 +open C001bba 96 4720 112 4800 3 8 0 +close C001bba +open C001bbb 112 4720 128 4800 3 8 0 +close C001bbb +close C001bb +close C001b +open C001c 32 1184 48 1200 1 8 0 +open C001ca 64 2368 80 2400 2 8 0 +open C001caa 128 4736 144 4800 3 8 0 +close C001caa +open C001cab 144 4752 160 4800 3 8 0 +close C001cab +close C001ca +open C001cb 80 2384 96 2400 2 8 0 +open C001cba 160 4768 176 4800 3 8 0 +close C001cba +open C001cbb 176 4784 192 4800 3 8 0 +close C001cbb +close C001cb +close C001c +close C001 diff --git a/output/tree.C002.dat b/output/tree.C002.dat new file mode 100644 index 0000000000000000000000000000000000000000..21504a90dd9ac01b9a12133000446c2cbd09baab --- /dev/null +++ b/output/tree.C002.dat @@ -0,0 +1,45 @@ +time 0.209445 +open C002 0 0 600 600 0 15 0 +open C002a 0 1168 16 1200 1 9 0 +open C002aa 0 2336 16 2400 2 9 0 +open C002aaa 0 4688 16 4800 3 9 0 +close C002aaa +open C002aab 16 4688 32 4800 3 8 0 +close C002aab +close C002aa +open C002ab 16 2336 32 2400 2 8 0 +open C002aba 32 4688 48 4800 3 8 0 +close C002aba +open C002abb 48 4704 64 4800 3 8 0 +close C002abb +close C002ab +close C002a +open C002b 16 1168 32 1200 1 8 0 +open C002ba 32 2352 48 2400 2 8 0 +open C002baa 64 4704 80 4800 3 8 0 +close C002baa +open C002bab 80 4704 96 4800 3 8 0 +close C002bab +close C002ba +open C002bb 48 2352 64 2400 2 8 0 +open C002bba 96 4720 112 4800 3 8 0 +close C002bba +open C002bbb 112 4720 128 4800 3 8 0 +close C002bbb +close C002bb +close C002b +open C002c 32 1184 48 1200 1 8 0 +open C002ca 64 2368 80 2400 2 8 0 +open C002caa 128 4736 144 4800 3 8 0 +close C002caa +open C002cab 144 4752 160 4800 3 8 0 +close C002cab +close C002ca +open C002cb 80 2384 96 2400 2 8 0 +open C002cba 160 4768 176 4800 3 8 0 +close C002cba +open C002cbb 176 4784 192 4800 3 8 0 +close C002cbb +close C002cb +close C002c +close C002 diff --git a/output/tree.C003.dat b/output/tree.C003.dat new file mode 100644 index 0000000000000000000000000000000000000000..c5302721b93862acaea94ca7e55674d6acd2ff15 --- /dev/null +++ b/output/tree.C003.dat @@ -0,0 +1,45 @@ +time 0.313553 +open C003 0 0 600 600 0 15 0 +open C003a 0 1168 16 1200 1 9 0 +open C003aa 0 2336 16 2400 2 9 0 +open C003aaa 0 4688 16 4800 3 9 0 +close C003aaa +open C003aab 16 4688 32 4800 3 8 0 +close C003aab +close C003aa +open C003ab 16 2336 32 2400 2 8 0 +open C003aba 32 4688 48 4800 3 8 0 +close C003aba +open C003abb 48 4704 64 4800 3 8 0 +close C003abb +close C003ab +close C003a +open C003b 16 1168 32 1200 1 8 0 +open C003ba 32 2352 48 2400 2 8 0 +open C003baa 64 4704 80 4800 3 8 0 +close C003baa +open C003bab 80 4704 96 4800 3 8 0 +close C003bab +close C003ba +open C003bb 48 2352 64 2400 2 8 0 +open C003bba 96 4720 112 4800 3 8 0 +close C003bba +open C003bbb 112 4720 128 4800 3 8 0 +close C003bbb +close C003bb +close C003b +open C003c 32 1184 48 1200 1 8 0 +open C003ca 64 2368 80 2400 2 8 0 +open C003caa 128 4736 144 4800 3 8 0 +close C003caa +open C003cab 144 4752 160 4800 3 8 0 +close C003cab +close C003ca +open C003cb 80 2384 96 2400 2 8 0 +open C003cba 160 4768 176 4800 3 8 0 +close C003cba +open C003cbb 176 4784 192 4800 3 8 0 +close C003cbb +close C003cb +close C003c +close C003 diff --git a/output/tree.C004.dat b/output/tree.C004.dat new file mode 100644 index 0000000000000000000000000000000000000000..5b4193b1b9eaea3d74a5642ea809c880ca843118 --- /dev/null +++ b/output/tree.C004.dat @@ -0,0 +1,45 @@ +time 0.417357 +open C004 0 0 600 600 0 15 0 +open C004a 0 1168 16 1200 1 9 0 +open C004aa 0 2336 16 2400 2 9 0 +open C004aaa 0 4688 16 4800 3 9 0 +close C004aaa +open C004aab 16 4688 32 4800 3 8 0 +close C004aab +close C004aa +open C004ab 16 2336 32 2400 2 8 0 +open C004aba 32 4688 48 4800 3 8 0 +close C004aba +open C004abb 48 4704 64 4800 3 8 0 +close C004abb +close C004ab +close C004a +open C004b 16 1168 32 1200 1 8 0 +open C004ba 32 2352 48 2400 2 8 0 +open C004baa 64 4704 80 4800 3 8 0 +close C004baa +open C004bab 80 4704 96 4800 3 8 0 +close C004bab +close C004ba +open C004bb 48 2352 64 2400 2 8 0 +open C004bba 96 4720 112 4800 3 8 0 +close C004bba +open C004bbb 112 4720 128 4800 3 8 0 +close C004bbb +close C004bb +close C004b +open C004c 32 1184 48 1200 1 8 0 +open C004ca 64 2368 80 2400 2 8 0 +open C004caa 128 4736 144 4800 3 8 0 +close C004caa +open C004cab 144 4752 160 4800 3 8 0 +close C004cab +close C004ca +open C004cb 80 2384 96 2400 2 8 0 +open C004cba 160 4768 176 4800 3 8 0 +close C004cba +open C004cbb 176 4784 192 4800 3 8 0 +close C004cbb +close C004cb +close C004c +close C004 diff --git a/python/analysis.py b/python/analysis.py new file mode 100644 index 0000000000000000000000000000000000000000..eda43c5e4b7c98d3b671b874d82c061e3eb892ea --- /dev/null +++ b/python/analysis.py @@ -0,0 +1,873 @@ +#! /cwi/bin/python + +from csplot import * +import sys + +# Update and use the corresponding SciPy functions +#from Scientific.Functions import Interpolation +import math + +import numpy as num +import scipy as sci +from scipy.optimize.optimize import fmin_powell as fmin +from scipy.optimize.minpack import leastsq +from optparse import OptionParser, Option, OptionValueError + +INFTY = 1e10 + +try: + BASE_PATH = os.environ['CSTREAM_DEFAULT_OUT_PATH'] +except KeyError: + BASE_PATH = '/export/scratch1/luque/cstream/' + +def max_in_axis(lz, m, sign, zmin=None, zmax=None): + """ Calculates and returns the maximum of a var in the axis and + its position. """ + + max_i = -1 + + # No infinity symbol in some old versions of Python + max_v = 0 + min_v = 1e100 + corr = 0 + + dz = lz[1] - lz[0] + + if zmin is None: + zmin = 0 + + if zmax is None: + zmax = INFTY + + for i in range(len(lz)): + if lz[i] < zmin or lz[i] > zmax: + continue + + v = m[i] + if abs(v) > abs(max_v) and sign * v >= 0: + max_i = i + max_v = v + + if abs(v) < abs(min_v) and sign * v >= 0: + min_i = i + min_v = v + + if max_i >= 1: + corr, max_v = quadratic_max(m[max_i - 1: max_i + 2]) + + return lz[max_i] + corr * dz, max_v, min_v + + +def max_off_axis(lr, lz, m, sign): + Z, R = num.meshgrid(lz, lr) + indx = (sign * m).argmax(axis=None) + return R.flat[indx], Z.flat[indx] + + +def find_front(var, grid, path=BASE_PATH, z0=None, ret_z0=False, + fmin=0, fmax=INFTY, rmin=None, rmax=INFTY, + pre_margin=400, post_margin=20, zmin=None, zmax=None, + shift_origin=True, sign=None): + + + if sign is None: + dict_signs = {'charge': -1, 'ez': 0, 'eabs': 0} + sign = dict_signs.get(var, 0) + + data = [] + lr, lz, m = load_var(var, grid, path=path) + + if rmin is None: + rmin = 0.5 * (lr[1] + lr[2]) + + if z0 is None: + z0, max_var, _ = max_in_axis(lz, m[0, :], sign, + zmin=zmin, zmax=zmax) + + fmin, fmax = abs(max_var) * fmin, abs(max_var) * fmax + print fmin, fmax + + + if shift_origin: + z0_shift = z0 + else: + z0_shift = 0 + + for j in xrange(len(lz)): + # This is a small WTF, really + if lz[j] < z0 - pre_margin or lz[j] > z0 + post_margin: + continue + + r, f = find_max_row(lr, sign * m[:, j]) + + if abs(f) >= fmin and abs(f) < fmax and r > rmin and r < rmax: + data.append((lz[j] - z0_shift, r, f)) + #else: + # print ("f out of (%f, %f) or r out of (%f, %f)" % + # (fmin, fmax, rmin, rmax)) + + if ret_z0: + return data, z0 + else: + return data + +class ThresholdNotFound(ValueError): + pass + +def find_envelope(grid, path=BASE_PATH, eps=0.0005, tail=350.0): + var = 'charge' + lr, lz, m = [num.array(a) for a in load_var(var, grid, path=path)] + + m = -m + front = num.zeros((len(lz), 2), 'd') + found = num.array([False for i in xrange(len(lz))]) + + dz = lz[1] - lz[0] + ntail = int(tail / dz) + + lr_inv = lr[-1::-1] + + for i in xrange(len(lz)): + try: + a, rmax = find_threshold(eps, m[-1::-1, i], lr_inv) + front[i, 0:2] = lz[i], rmax + found[i] = True + except ThresholdNotFound: + pass + + front = front.compress(found, axis=0) + zlen, _ = front.shape + if zlen > ntail: + zlen = ntail + + return front[-zlen:, :] + +def find_threshold(threshold, a, r): + for ia, ir in zip(a, r): + if ia >= threshold: + return ia, ir + + raise ThresholdNotFound + +def simple_find_front(var, grid, path=BASE_PATH, tail=350.0, eps=1e-4): + var = 'charge' + lr, lz, m = [num.array(a) for a in load_var(var, grid, path=path)] + m = num.abs(m) + + maxes = m.argmax(0).squeeze() + front = num.array([(lz[i], lr[maxes[i]]) + for i in xrange(len(lz)) + if maxes[i] > 0 and m[maxes[1], i] > eps]) + + zlen, _ = front.shape + if zlen > ntail: + zlen = ntail + + return front[-zlen:, :] + + +def fit_radius(var, grid, sign, path=BASE_PATH, zmax=None): + front, z0 = find_front(var, grid, path=path, pre_margin=400.0, sign=sign, + post_margin=400.0, ret_z0=True, + fmax=1.0, fmin=0.5, zmax=zmax) + + if not front: + return num.NAN + + front = num.array(front) + + def errors(R): + return num.sqrt(front[:, 1]**2 + (front[:, 0] - R)**2) - abs(R) + + try: + x, _ = leastsq(errors, 20) + except TypeError: + raise + #ipshell() + + return x + + +def find_max_row(lr, row): + max_f = 0 + min_f = 1e100 + max_i = 0 + + dr = lr[1] - lr[0] + + for i in xrange(len(lr)): + f = row[i] + if abs(f) > abs(max_f): + max_i = i + max_f = f + + if max_i >= 1 and max_i < len(lr) - 1: + corr, max_f = quadratic_max(row[max_i - 1: max_i + 2]) + else: + corr = 0 + + return lr[max_i] + corr * dr, max_f + + + +def inward_norm(nx, ny, y): + """ gets a normal vector from the array we created making sure that + it points always inward""" + + if num.sign(y) == num.sign(ny): + nx, ny = -nx, -ny + + return nx, ny + +def normal_to_curve(m): + """ given an array as [(x0, y1), ...(xN, yN)] returns + [(nx0, ny0), ... (nxN, nyN)] of components of a vector normal to the + curve """ + print m.shape + data = zeros(m.shape, typecode='fd') + n = m.shape[0] + + for i in xrange(1, n - 1): + x, y = m[i, 0], m[i, 1] + + deltas = [(m[j, 0] - m[i, 0], m[j, 1] - m[i, 1]) + for j in (i - 1, i + 1)] + nx, ny = normalize(normal(*deltas)) + nx, ny = inward_norm(nx, ny, y) + + data[i, 0] = nx + data[i, 1] = ny + + nx, ny = normalize((-(m[1, 0] - m[0, 0]), + m[1, 1] - m[0, 1])) + + nx, ny = inward_norm(nx, ny, m[0, 1]) + + data[0, 0] = nx + data[0, 1] = ny + + nx, ny = normalize((m[n - 2, 1] - m[n - 1, 1], + -(m[n - 2, 0] - m[n - 1, 0]))) + + nx, ny = inward_norm(nx, ny, m[n - 1, 1]) + data[n - 1, 0] = nx + data[n - 1, 1] = ny + + print data + return data + +def normal((x0, y0), (x1, y1)): + print x0, y0, x1, y1 + + if y0 == 0 and y1 == 0: + return (0.0, 1.0) + + return ((-(x1**2 * y0) + (x0**2 + y0 * (y0 - y1)) * y1) + / (x1 * y0 - x0 * y1), + (x0**2 * x1 + x1 * y0**2 - x0 * (x1**2 + y1**2)) + / (-(x1 * y0) + x0 * y1)) + + +def normalize((x, y)): + a = sqrt(x**2 + y**2) + return (x / a, y / a) + + +def quadratic_max(y): + """ Finds a parabola defined by the points (dx i, y[i]) {i = 1, 2, 3} + and returns its maximum. """ + + try: + f1 = (y[2] - 2 * y[1] + y[0]) + f2 = (y[2] - y[0]) + except IndexError: + return num.NAN, num.NAN + + if f1 == 0: + # The points are aligned: no parabola fit + return 0, max(*y) + + return (- f2 / (2 * f1)), y[1] - f2**2 / f1 / 8.0 + + +def var_interpolate(var, grid, r_staggered=False, z_staggered=False, **kwargs): + lr, lz, var = load_var(var, grid, **kwargs) + + lr = num.array(lr) + lz = num.array(lz) + + if r_staggered: + lr = lr + 0.5 * (lr[1] - lr[0]) + + if z_staggered: + lz = lz + 0.5 * (lz[1] - lz[0]) + + var = num.array(var) + + lr, var = mirror_var(lr, var) + + f = Interpolation.InterpolatingFunction([lr, lz], var, default=1e20) + return f + +def find_front_iter(var, grid, n, **kwargs): + """ After finding a front, improves it by n iterations. """ + print kwargs + + m = find_front(var, grid, **kwargs) + m = num.array(m) + + interp = var_interpolate(var, grid, path=kwargs.get('path', None)) + + for i in xrange(n): + norm = normal_to_curve(m) + m = iter_front(m, norm, interp) + + return m + + +def iter_front(m, norm, interp, max_step=80, ds=0.05): + mnext = zeros(m.shape, typecode='fd') + + for p in xrange(m.shape[0]): + z0, r0 = m[p, 0], m[p, 1] + nz, nr = norm[p, 0], norm[p, 1] + + zs = [z0 + ds * i * nz for i in xrange(-max_step, max_step)] + rs = [r0 + ds * i * nr for i in xrange(-max_step, max_step)] + + interp_zr = [interp(r, z) for r, z in zip(rs, zs)] + + max_i, max_e = -1, 0 + + for i, e in enumerate(interp_zr): + print i, rs[i], zs[i], e + if e > max_e or max_i < 0: + max_i = i + max_e = e + + mnext[p, 0] = zs[max_i] + mnext[p, 1] = rs[max_i] + + return mnext + +def fit_saffman(id, grid, var='eabs', width=64.0, fix_vertex=False, rmax=300): + path = os.path.join(BASE_PATH, id) + + front = find_front(var, grid, + path=path, fmin=0.0001, rmin=1.1, rmax=rmax, + zmin=0, zmax=4000, shift_origin=False, + pre_margin=100, post_margin=5) + front = num.array(front) + + #front = find_envelope(grid, path=path) + #print front + + vert_x, vert_y, _ = front[num.abs(front).argmax(0)[0]] + #vert_x, vert_y = front[num.abs(front).argmax(0)[0]] + + print "Vertex found at (%f, %f)" % (vert_x, vert_y) + + L = 2 * width + + def chi2((lam, C)): + #A = 2 * width / math.pi + #y = A * num.arccos(num.exp(((front[:, 0] - C) / A)).clip(-10000.0, 1.0)) + x = front[:, 0] + y = (lam * L / (2 * math.pi) + * num.arccos((2 * num.exp(2 * math.pi * x + / (L * (1 - lam)) - C) - 1.0) + .clip(-1.0, 1.0))) + + return ((y - front[:, 1]) ** 2).sum() + + if not fix_vertex: + lam, C = fmin(chi2, (0.5, vert_x), maxfun=100) + else: + def chi2_partial(lam): + return chi2((lam, vert_x)) + + lam, C = fmin(chi2_partial, (0.5,), maxfun=100), vert_x + + + print "\tlambda = %f\n\tx0 = %f" % (lam, C) + return lam, C + + +def find_emax(rid, grid, zinterval=None, path=BASE_PATH): + var = rid + ':eabs' + lr, lz, m = [num.array(a) for a in load_var(var, grid, path=path)] + + z0 = lz[0] + dz = lz[1] - z0 + + if zinterval is not None: + zmin, zmax = zinterval + izmin, izmax = [int((z - z0) / dz) for z in zmin, zmax] + + izmin = max(0, izmin) + izmax = min(m.shape[1] - 1, izmax) + + m = m[:, izmin:izmax] + + return max(m.flat) + +def find_diameters(var, grid, neg_z, pos_z, path=BASE_PATH): + lr, lz, m = load_var(var, grid, path=path) + + m = m * m + diameters = num.dot(lr, m) / num.dot(ones(lr.shape), m) + table = num.concatenate((lz.reshape(len(lz), 1), + diameters.reshape(len(lz), 1)), axis=1) + + table = table.compress(num.logical_and(num.greater(lz, pos_z), + num.less(lz, neg_z)), axis=0) + #ipshell() + dfile = os.path.join(path, 'diameters.%s.tsv' % grid) + try: + neg_diam = num.max(table[-40:, 1]) + except ValueError: + neg_diam = num.NAN + + try: + pos_diam = num.max(table[:40, 1]) + except ValueError: + pos_diam = num.NAN + + num.savetxt(os.path.join(path, 'diameters.%s.tsv' % grid), table) + + return neg_diam, pos_diam + +def posneg_fronts(grid, path=BASE_PATH, var='charge', zmax=None): + lz, m = load_axis(var, grid, path=path) + neg_z, neg_max, neg_min = max_in_axis(lz, m, -1, zmax=zmax) + pos_z, pos_max, pos_min = max_in_axis(lz, m, 1, zmax=zmax) + return [neg_z, pos_z, neg_max, pos_max] + + +def integrate(grid, path=BASE_PATH, var='charge', sign=1.0, threshold=None, + zrange=None): + lr, lz, m = load_var(var, grid, path=path) + if zrange is not None: + z0, z1 = zrange + if not num.isnan(z0) and not num.isnan(z1): + lzmask = num.less(lz, z1) * num.greater(lz, z0) + m = m.compress(lzmask, axis=1) + lz = lz.compress(lzmask) + + if threshold is not None: + if sign > 0: + thres = num.greater + mmax = max(num.ravel(m)) + else: + thres = num.less + mmax = min(num.ravel(m)) + + m = m * thres(m, threshold * mmax) + + dr = lr[1] - lr[0] + dz = lz[1] - lz[0] + + dV = lr.reshape((lr.size, 1)) * dr * dz + m = m * dV + return sum(m.flat) + + +# Commands +def cmd_fields(*args, **kwargs): + try: + path = os.path.join(BASE_PATH, args[0]) + except IndexError: + path = '.' + + ofile = os.path.join(path, 'field.dat') + + fp = open(ofile, "w") + + pattern = kwargs.get('pattern', 'C???') + subs = kwargs.get('subs', '') + last = kwargs.get('last', False) + + get_grids = all_grids + + if last: + get_grids = last_grid + + + for grid in get_grids(pattern=pattern, path=path): + print path, grid + subs + lz, m = load_axis('ez', grid + subs, path=path) + z, field_max, field_min = max_in_axis(lz, m, -1) + if grid != 'C000': + fp.write("%d\t%f\t%.18e\t%.18e\n" % (int(grid[1:]), z, + field_max, field_min)) + + print int(grid[1:]), z, field_max, field_min + fp.flush() + + fp.close() + +def cmd_fields_last(*args, **kwargs): + _d = kwargs.copy() + _d['last'] = True + + cmd_fields(*args, **_d) + +def cmd_posneg(*args, **kwargs): + try: + path = os.path.join(BASE_PATH, args[0]) + except IndexError: + path = '.' + + ofile = os.path.join(path, 'posneg.dat') + + fp = open(ofile, "w") + pattern = kwargs.get('pattern', 'C???') + for grid in all_grids(pattern=pattern, path=path): + print path, grid + try: + neg_z, pos_z, neg_max, pos_max = posneg_fronts(grid, path=path) + + if grid != 'C000': + fp.write("%d\t%f\t%f\t%f\t%f\n" + % (int(grid[1:]), neg_z, pos_z, neg_max, pos_max)) + + print int(grid[1:]), neg_z, pos_z, neg_max, pos_max + fp.flush() + except IOError: + print >> sys.stderr, "IOError exception in %s" % grid + + fp.close() + + +def cmd_complete(*args, **kwargs): + try: + path = os.path.join(BASE_PATH, args[0]) + except IndexError: + path = '.' + + ofile = os.path.join(path, kwargs.get('ofile', 'analysis.dat')) + + fp = open(ofile, "w") + pattern = kwargs.get('pattern', 'C???') + sub = kwargs.get('sub', '') + zmax = kwargs.get('zmax', None) + dt = kwargs.get('dt', 1.0) + + try: + set_def_rescaling(kwargs['rescaling']) + except KeyError: + pass + + + + fmt_str = None + + varnames = ['t', + 'Zc1', 'Zc2', 'Qmin', 'Qmax', + 'Ze1', 'Ze2', 'Emin', 'Emax', + 'V1', 'V2', 'R1', 'R2', + 'Q', 'Q1', 'Q2'] + + fp.write("\t".join(varnames) + "\n") + + old_c_fronts = None + pos_z0, neg_z0 = None, None + + for grid in all_grids(pattern=pattern, path=path): + sgrid = grid + sub + clear_load_var_memoize() + print path, sgrid + try: + it = int(grid[1:]) * dt + itms = [it] + c_fronts = posneg_fronts(sgrid, path=path, + var='charge', zmax=zmax) + + if pos_z0 is None or neg_z0 is None: + neg_z0, pos_z0 = [c_fronts[i] for i in 0, 1] + + c_fronts[0] -= neg_z0 + c_fronts[1] -= pos_z0 + + if old_c_fronts: + vminus, vplus = [(c_fronts[i] - old_c_fronts[i]) / (it - old_it) + for i in 0, 1] + else: + vminus, vplus = num.NAN, num.NAN + + old_it = it + old_c_fronts = c_fronts + + neg_r, pos_r = [fit_radius('charge', sgrid, s, + path=path, zmax=zmax) + for s in -1, 1] + + #neg_diam, pos_diam = find_diameters('electrons', grid, + # c_fronts[0], c_fronts[1], + # path=path) + + itms.extend(c_fronts) + + e_fronts = posneg_fronts(sgrid, path=path, var='ez', zmax=zmax) + e_fronts[0] -= neg_z0 + e_fronts[1] -= pos_z0 + + itms.extend(e_fronts) + itms.extend((vminus, vplus, neg_r, pos_r)) + itms.append(integrate(sgrid, path=path, var='charge')) + + # This was the old way of calculating the integrated charge: + # neg_zrange=(neg_z0 - 2*neg_r, neg_z0 + neg_r) + # pos_zrange=(pos_z0 - 2*pos_r, pos_z0 + pos_r) + # + # itms.append(integrate(sgrid, path=path, var='charge', + # sign=-1.0, threshold=0.5, zrange=neg_zrange)) + # itms.append(integrate(sgrid, path=path, var='charge', + # sign=1.0, threshold=0.5, zrange=pos_zrange)) + + neg_zrange=(neg_z0 - neg_r, neg_z0 + 0.5 * neg_r) + pos_zrange=(pos_z0 - pos_r, pos_z0 + 0.5 * pos_r) + + itms.append(integrate(sgrid, path=path, var='charge', + zrange=neg_zrange)) + itms.append(integrate(sgrid, path=path, var='charge', + zrange=pos_zrange)) + + if fmt_str == None: + fmt_str = "\t".join("%g" for x in itms) + "\n" + + if int(grid[1:4]) >= 2: + fp.write(fmt_str % tuple(itms)) + fp.flush() + + print "\t".join(str(x) for x in itms) + except IOError: + print >> sys.stderr, "IOError exception in %s" % grid + + fp.close() + + + +def cmd_diameters(runid, var, **kwargs): + try: + path = os.path.join(BASE_PATH, runid) + except IndexError: + path = '.' + + ofile = os.path.join(path, 'diameters.dat') + fp = open(ofile, "w") + + pattern = kwargs.get('pattern', 'C???') + for grid in all_grids(pattern=pattern, path=path): + try: + + neg_z, pos_z, neg_max, pos_max = posneg_fronts(grid, path=path) + neg_diam, pos_diam = find_diameters(var, grid, neg_z, pos_z, path=path) + print grid + + if grid != 'C000': + fp.write("%d\t%f\t%f\t%f\t%f\t%f\t%f\n" + % (int(grid[1:]), neg_z, pos_z, + neg_max, pos_max, neg_diam, pos_diam)) + + print int(grid[1:]), neg_z, pos_z, neg_max, pos_max, neg_diam,\ + pos_diam + fp.flush() + except IOError: + print >> sys.stderr, "IOError exception in %s" % grid + + fp.close() + + +def cmd_voltage(*args, **kwargs): + try: + path = os.path.join(BASE_PATH, args[0]) + except IndexError: + path = '.' + + ofile = os.path.join(path, 'voltage.dat') + + fp = open(ofile, "w") + pattern = kwargs.get('pattern', 'C???') + for grid in all_grids(pattern=pattern, path=path): + try: + lz, m = load_axis('ez', grid, path=path) + voltage = - sum(m) * (lz[1] - lz[0]) + s = "%d\t%f\n" % (int(grid[1:]), voltage) + fp.write(s) + fp.flush() + print s + + except IOError: + print >> sys.stderr, "IOError exception in %s" % grid + + +def cmd_front(grid, ofile): + fp = open(ofile, "w") + + id, grid = grid.split(':') + path = os.path.join(BASE_PATH, id) + + print grid, path + + front = find_front('charge', grid, path=path, fmin=0.0001, rmin=2.1, rmax=300, + zmin=0, zmax=2000, shift_origin=False, + pre_margin=200, post_margin=20) + for z, r, f in front: + fp.write("%f\t%f\t%f\n" % (z, r, f)) + + fp.close() + +def cmd_fit_saffman(grid): + id, grid = grid.split(':') + return fit_saffman(id, grid) + +def cmd_envelope(grid, ofile): + id, grid = grid.split(':') + path = os.path.join(BASE_PATH, id) + + front = find_envelope(grid, path=path) + + fp = open(ofile, "w") + for r, z in front: + fp.write("%f\t%f\n" % (r, z)) + fp.close() + + return front + +def cmd_simple_front(var, grid): + id, grid = grid.split(':') + path = os.path.join(BASE_PATH, id) + + front = simple_find_front(var, grid, path=path) + for r, z in front: + print r, z + + return front + +def cmd_iterfront(grid, n, ofile): + id, grid = grid.split(':') + path = os.path.join(BASE_PATH, id) + + fp = open(ofile, "w") + n = int(n) + + front = find_front_iter('eabs', grid, n, path=path, + fmin=0.001, rmin=1, rmax=300, + zmin=300, zmax=600, shift_origin=False, + pre_margin=250, post_margin=20) + for z, r, f in front: + fp.write("%f\t%f\t%f\n" % (z, r, f)) + + fp.close() + + +def cmd_max_off_axis(runid, var, sgn, **kwargs): + try: + path = os.path.join(BASE_PATH, runid) + except IndexError: + path = '.' + + ofile = os.path.join(path, 'max-off-%s.dat' % var) + fp = open(ofile, "w") + + pattern = kwargs.get('pattern', 'C???') + sgn = int(sgn) + for grid in all_grids(pattern=pattern, path=path): + try: + lr, lz, m = load_var(var, grid, path=path) + except IOError: + print >> sys.stderr, "IOError exception in %s" % grid + continue + + r, z = max_off_axis(lr, lz, m, sgn) + if grid != 'C000': + fp.write("%d\t%f\t%f\n" % (int(grid[1:]), r, z)) + + print int(grid[1:]), r, z + fp.flush() + + fp.close() + +def cmd_shell(): + from IPython.Shell import IPShellEmbed + ipshell = IPShellEmbed([]) + ipshell() + +def check_eval_float(option, opt, value): + eval_value = eval(value) + try: + return float(eval_value) + except ValueError: + raise OptionValueError( + "option %s: invalid float value: '%s' -> %r" + % (opt, value, eval_value)) + + + +class ExtOption(Option): + TYPES = Option.TYPES + ("eval_float",) + TYPE_CHECKER = Option.TYPE_CHECKER.copy() + TYPE_CHECKER["eval_float"] = check_eval_float + + + +def main(): + parser = OptionParser("", option_class=ExtOption) + + parser.add_option('--dt', '', action='store', + dest='dt', + type='eval_float', + default=1.0, + help="dt") + + parser.add_option('--with-units', '', action='store', + dest='units', + default=None, + help="Normalize with units") + + + parser.add_option('--pattern', '', action='store', + dest='pattern', type='str', + default='C???', + help='Pattern of the analyzed grids') + + + parser.add_option('--sub', '', action='store', + dest='sub', type='str', + default="", + help='Sub-grid postfix') + + parser.add_option('--ofile', '', action='store', + dest='sub', type='str', + help='Output file') + + + parser.add_option('--zmax', '', action='store', + dest='zmax', type='eval_float', + default=None, + help='Sub-grid postfix') + + parser.add_option('--rescaling', '', action='store', + dest='rescaling', type='str', + default=None, + help='Rescaling to use') + + + main = sys.modules[__name__] + + opts, args = parser.parse_args() + + try: + cmd = sys.argv[1].replace('-', '_') + process_method = getattr(main, 'cmd_%s' % cmd) + except AttributeError: + print "Dont know how to process command `%s`" % args[0] + sys.exit(-1) + + process_method(*args[1:], **opts.__dict__) + + + +if __name__ == "__main__": + main() diff --git a/python/csplot.py b/python/csplot.py new file mode 100644 index 0000000000000000000000000000000000000000..143d85bd9c33bc97ac61267f19fc1d0c8cddd550 --- /dev/null +++ b/python/csplot.py @@ -0,0 +1,790 @@ +import matplotlib +from matplotlib.ticker import Formatter +matplotlib.use('Agg') + +#from matplotlib import rc +#rc('font',**{'family':'sans-serif','sans-serif':['Helvetica']}) +## for Palatino and other serif fonts use: +#rc('font',**{'family':'serif','serif':['Palatino'])) +#rc('text', usetex=True) + +from pylab import * +import os, os.path +import sys +import glob +import tarfile +import math +import scaling +import re +import numpy +from subinterpol import load_fine + +rcParams['contour.negative_linestyle'] = 'solid' + +output_dir = '.' +#try: +# output_dir = os.environ['CSTREAM_OUTPUT_DIR'] +#except KeyError: +# output_dir = '/export/scratch1/luque/cstream/data/' + +try: + BASE_PATH = os.environ['CSTREAM_DEFAULT_OUT_PATH'] +except KeyError: + BASE_PATH = '/export/scratch1/luque/cstream/' + +LOG_EPS = 1e-20 + +# Some rescalings: +nitrogen1atm_cm = {'r': 2.3e-4, 'z': 2.3e-4, + 'electrons': 1.0 / (2.3e-4)**3} + +nitrogen1atm_microm = {'r': 2.3, 'z': 2.3, + 'electrons': 4.7e2, + 'charge': 4.7e2, + 'eabs': 200, + 'ez': 200} + +nitrogen1atm_microm_units = {'r': r'\mu m', 'z': r'\mu m', + 'electrons': r'\mu m^{-3}', + 'charge': r'e/\mu m^{3}', + 'eabs': r'kV/cm'} + +nitrogen1atm_mm = {'r': 2.3e-3, 'z': 2.3e-3, + 'electrons': 4.7e2, + 'charge': 4.7e2, + 'eabs': 200} + +nitrogen1atm_mm_units = {'r': r'mm', 'z': r'mm', + 'electrons': r'\mu m^{-3}', + 'charge': r'e/\mu m^{3}', + 'eabs': r'kV/cm'} + + + +nitrogen5atm_microm = scaling.rescale2(1, 5, nitrogen1atm_microm) +nitrogen5atm_microm_units = nitrogen1atm_microm_units + + +nitrogen15mbar_mm = {'r': 0.153, 'z': 0.153, + 'electrons': 1.0 / (0.153)**3} + +nitrogen15mbar_mm_units = {'x': r'mm', 'y': r'mm', + 'electrons':r'mm^{-3}'} + +air100mbar_mm = {'r': 0.0233, 'z': 0.0233, + 'electrons': 1.0 / (0.0233)**3, + 'ions': 1.0 / (0.0233)**3, + 'charge': 1.0 / (0.0233)**3 + } + +air100mbar_mm_units = {'r': r'mm', 'z': r'mm', + 'electrons':r'mm^{-3}', + 'ions': r'mm^{-3}', + 'charge': r'e/mm^{3}' + } + + +nitrogen005torr_m = {'r': 0.035, 'z': 0.035, + 'electrons': 1.0 / (0.035)**3, + 'charge': 1.0 / (0.035)**3, + } + +nitrogen005torr_m_units = {'r': r'm', 'z': r'm', + 'electrons':r'm^{-3}', + 'charge': r'e/m^{3}', + } + + +micrombar = nitrogen1atm_microm +micrombar_units = {'pr': r'\mu m \cdot bar', + 'px': r'\mu m \cdot bar', + 'pz': r'\mu m \cdot bar', + 'r': r'\mu m \cdot bar', + 'x': r'\mu m \cdot bar', + 'z': r'\mu m \cdot bar', + 'electrons':r'\mu m^{-3} \cdot bar^{-3}'} + +# Rescaling for sprites: +def get_sprite_f(dens_decay_len): + def _f(lz): + return numpy.exp(-lz / dens_decay_len) + return _f + +DENS_DECAY_LENGTH_KM = 7.2 + +def dens_at(h_km): + """ Density at h_km kilometers relative to the density at ground level.""" + return numpy.exp(-h_km / DENS_DECAY_LENGTH_KM) + +def rescale_sprite_at(h_km): + dens = dens_at(h_km) + l0 = 2.3e-9 / dens + f = get_sprite_f(DENS_DECAY_LENGTH_KM / l0) + n0 = dens * 1.0 / (2.3e-4)**3 + return {'r': l0, 'z': -l0, 'z0': h_km, + 'eabs_f': f, 'ez_f': f, 'er_f': f, + 'electrons': n0, 'ions': n0, + 'charge': n0 } + +sprite70km = rescale_sprite_at(70) +sprite70km_units = {'r': 'km', 'z': 'km', 'electrons': 'cm^{-3}', + 'log_electrons': 'cm^{-3}'} +sprite80km = rescale_sprite_at(80) +sprite80km_units = sprite70km_units +sprite82km = rescale_sprite_at(82) +sprite82km_units = sprite70km_units +sprite90km = rescale_sprite_at(90) +sprite90km_units = sprite70km_units + + +PRETTY_VARS = { + 'electrons': 'n_e', + 'ions': 'n_+', + 'eabs': 'E', + 'er': 'E', + '_er': '-E', + '_ez': '$-E_z$', + 'ez': 'E', + 'phi': r'\phi', + 'log_ez': r'$\rm{log}\/ E_z$', + 'log_er': r'$\rm{log}\/ E_r$', + 'log_eabs': r'$\rm{log}\/ E$', + 'log_electrons': 'n_e', + 'charge': r'Charge density', + 'los_impact': r'$I(y,z)$' + #'charge': r'\rho - \sigma' + } + +def pretty_var(var): + return PRETTY_VARS.get(var, var) + +def flex_load(fname, path=''): + try: + # 1. Try with `filename' + return load(os.path.join(path, fname)) + except IOError: + try: + # 2. If not, try with `filename.gz' + return load(os.path.join(path, fname + '.gz')) + except IOError: + # 2. If not, extract it from an all..tgz ' + tar = tarfile.open(os.path.join(path, tar_name(fname)), 'r:gz') + tar.extract(os.path.basename(fname)) + r = load(fname) + os.remove(fname) + return r + +def default_loader(var, grid, path=''): + return flex_load(input_name(var, grid), path=path) + +def charge_loader(var, grid, path=''): + return (default_loader('ions', grid, path=path) + - default_loader('electrons', grid, path=path)) + +def d_charge_loader(var, grid, path=''): + return (default_loader('d_ions', grid, path=path) + - default_loader('d_electrons', grid, path=path)) + +def current_loader(var, grid, path=''): + eabs = default_loader('eabs', grid, path=path) + electrons = default_loader('electrons', grid, path=path) + + return eabs * electrons + +def log_loader(var, grid, path=''): + loader = special_vars.get(var[4:], default_loader); + return log10(abs(loader(var[4:], grid, path=path)) + LOG_EPS) + +def minus_loader(var, grid, path=''): + real_var = var[1:] + loader = special_vars.get(real_var, default_loader); + return -loader(real_var, grid, path=path) + +def townsend(efield, efield0): + return efield * exp(-efield0 / abs(efield)) + +def impact_loader(var, grid, path=''): + eabs = default_loader('eabs', grid, path=path) + electrons = default_loader('electrons', grid, path=path) + + return townsend(eabs, 1.0) * electrons + +def los_loader(var, grid, path=''): + # Only used here: + from losight import losight + real_var = var[var.index('_') + 1:] + #pre_loader = special_vars.get(real_var, default_loader) + + #lr = flex_load(input_name('r', grid), path=path) + #lz = flex_load(input_name('z', grid), path=path) + #m = pre_loader(real_var, grid, path=path) + lr, lz, m = load_fine(real_var, grid, path, uptolevel=2) + + return lr, lz, losight(lr, lz, m) + +special_vars = {'ccharge': charge_loader, + 'd_charge': d_charge_loader, + 'log_electrons': log_loader, + 'log_ions': log_loader, 'log_ccharge': log_loader, + 'log_charge': log_loader, + 'log_phi': log_loader, + 'log_er': log_loader, + '_er': minus_loader, + '_ez': minus_loader, + '_charge': minus_loader, + 'log_ez': log_loader, + 'log_eabs': log_loader, + 'log_error': log_loader, + 'log_d_electrons': log_loader, + 'log_d_ions': log_loader, + 'current': current_loader, + 'impact': impact_loader, + 'los_impact': los_loader, + 'log_los_impact': log_loader + } + +def input_name(var, grid): + return "%s.%s.tsv" % (var, grid) + +def output_name(var, grid, ext='png', what=""): + return "%s%s.%s.%s" % (var, what, grid, ext) + +RE_FNAME = re.compile(r".*\.(\w\d{3}).*\.tsv") +def tar_name(fname): + m = RE_FNAME.match(fname) + if not m: + raise ValueError("File-name format %s not recognized." % fname) + + gid = m.group(1) + return "all.%s.tgz" % gid + +def old_tar_name(fname): + try: + for i in range(fname.index(".C") + 2, len(fname)): + if not fname[i].isdigit(): + return 'all.%s.tgz' % fname[fname.index(".C") + 1:i] + + except ValueError: + indx = fname.index(".P") + return 'all.%s.tgz' % fname[indx + 1:indx + 5] + + return fname + +def get_subgrids(gid, path=output_dir): + try: + # The '.' is a dirty hack to avoid changing tar_name, which expects + # a filename. + tar = tarfile.open(os.path.join(path, tar_name('.' + gid + '.tsv'))) + gridnames = tar.getnames() + tar.close() + except (IOError, ValueError): + gridnames = [os.path.basename(g) for g in + glob.glob(os.path.join(path, "z.%s*.tsv" % gid))] + + grids = [g for z, g, tsv in [nam.split('.') for nam in gridnames] + if z == 'z'] + ret = [g for g in grids if g[0:len(gid)] == gid and g != gid] + + return ret + +def all_grids(pattern="C???", path=output_dir): + i = glob.glob(os.path.join(path, "all.%s.tgz" % pattern)) + if not i: + i = glob.glob(os.path.join(path, "z.%s.tsv" % pattern)) + + i.sort() + for fn in i: + yield fn.split('.')[-2] + +def last_grid(pattern="C???", path=output_dir): + i = glob.glob(os.path.join(path, "all.%s.tgz" % pattern)) + i.sort() + try: + yield i[-1].split('.')[-2] + except IndexError: + # There are no grids + pass + +LOAD_VAR_MEMOIZE = {} + +def clear_load_var_memoize(): + global LOAD_VAR_MEMOIZE + del LOAD_VAR_MEMOIZE + LOAD_VAR_MEMOIZE = {} + +_default_rescaling = {} + +def set_def_rescaling(rescaling): + global _default_rescaling + + if isinstance(rescaling, str): + mainmod = sys.modules[__name__] + rescaling = getattr(mainmod, rescaling) + + if rescaling is None: + rescaling = {} + + _default_rescaling = rescaling + + +def load_var(var, grid, path='', ntheta=None, opposite=False, + rescaling=None, zcross=None): + """ Loads a variable read from a grid inside a matrix. + Returns a tuple formed by lr, lz, m, where lr and lz are 1d vectors + representing the gridpoints in r and z. """ + + global _default_rescaling + + try: + id, var = var.split(':') + path = os.path.join(BASE_PATH, id) + except ValueError: + pass + + if rescaling is None: + rescaling = _default_rescaling + + k = (path, var, grid, rescaling.get(var, 1.0), ntheta, zcross) + if k in LOAD_VAR_MEMOIZE: + return LOAD_VAR_MEMOIZE[k] + + loader = special_vars.get(var, default_loader); + + # Load matrix + m = loader(var, grid, path=path) + + try: + ltheta = flex_load(input_name('theta', grid), path=path) + except: + ltheta = array([0]) + + # Some loaders already provide lr, lz and reshaped m + if isinstance(m, tuple): + lr, lz, m = m + else: + lr = flex_load(input_name('r', grid), path=path) + lz = flex_load(input_name('z', grid), path=path) + + # Reshape + m = reshape(m, (ltheta.shape[0], lr.shape[0], lz.shape[0])) + + + # Remove the theta dimension + if ntheta is None: + ntheta = min(ltheta.shape[0] - 1, 1) + + if zcross is None: + mr = m[ntheta, :, :] + else: + iz = (zcross - lz[0]) / (lz[1] - lz[0]) + mr = m[:, :, iz] + + lz = numpy.outer(numpy.cos(ltheta), lr) + lr = numpy.outer(numpy.sin(ltheta), lr) + + + if opposite: + max_theta = ltheta.shape[0] - 1 + #ntheta2 = (ntheta + max_theta / 2 - 1) % max_theta + ntheta2 = (ntheta + max_theta / 2) % max_theta + 2 + + mr = concatenate((flipud(m[ntheta2, :, :]), mr), axis=0) + lr = concatenate((-lr[::-1], lr)) + + + try: + f = rescaling['%s_f' % var] + mr = f(lz) * mr + except KeyError: + if not var.startswith('log_'): + mr = rescaling.get(var, 1.0) * mr + else: + mr = log10(rescaling.get(var[4:], 1.0)) + mr + + lr = rescaling.get('r', 1.0) * lr + rescaling.get('r0', 0.0) + lz = rescaling.get('z', 1.0) * lz + rescaling.get('z0', 0.0) + + if lz[0] > lz[-1]: + mr = numpy.fliplr(mr) + lz = numpy.flipud(lz) + + LOAD_VAR_MEMOIZE[k] = (lr, lz, mr) + return lr, lz, mr + + +def load_axis(var, grid, path=output_dir, col=0, **kwargs): + """ Reads the values along the minimum r of var""" + lr, lz, m = load_var(var, grid, path=path, **kwargs) + return lz, m[col,:] + +def save_var(var, grid, lr, lz, m): + save(input_name('r', grid), lr) + save(input_name('z', grid), lz) + save(input_name(var, grid), m) + + +# For potential plots, we use a lot more contours +NCONTOURS = {'phi': 100, 'charge': 20} + +def add_to_dict(thedict, key): + def doit(f): + thedict[key] = f + return f + + return doit + +def mirror_var(lr, m): + m = concatenate((flipud(m), m), axis=0) + lr = concatenate((-lr[::-1], lr)) + + return lr, m + +def mirrored_var(lr, m): + m = flipud(m) + lr = -lr[::-1] + + return lr, m + +prev_contours = None + +def plot_var(var, grid, mode='pcolor', aspect=True, mirror=False, + setaxis=True, finish=True, var_range=None, path='', + vector=None, ntheta=None, rescaling={}, units={}, + fontsize=18, rlabel='r', zlabel='z', clabel=None, + rrange=None, zrange=None, + saffman=None, cmap=None, color='black', linewidth=None, + opposite=False, normranges=False, subgrids=[], + touchaxis=True, frame=False, superimpose=None, ncontours=None, + field=None, zcross=None, fine=False, mirrored=None, + subframe=False): + + if not fine: + lr, lz, m = load_var (var, grid, path=path, ntheta=ntheta, + opposite=opposite, rescaling=rescaling, + zcross=zcross) + else: + def _loader(_var, _grid, path='.'): + return load_var (_var, _grid, path=path, ntheta=ntheta, + opposite=opposite, rescaling=rescaling, + zcross=zcross) + lr, lz, m = load_fine(var, grid, path=path, loader=_loader) + + + if mirror: + lr, m = mirror_var(lr, m) + + if mirrored == -1: + lr, m = mirrored_var(lr, m) + + if zcross is None: + [z, r] = meshgrid(lz, lr) + else: + z, r = lz, lr + + if field is not None and var == 'phi': + m = m - field * z + + modes = {} + @add_to_dict(modes, 'pcolor') + def plot_pcolor(): + if var_range is not None: + vmin, vmax = var_range + norm = normalize(vmin=vmin, vmax=vmax) + else: + vmin, vmax = None, None + norm = normalize() + + if hasattr(cmap, 'center'): + # A dynamic colormap + if vmin is None or vmax is None: + vmin = min(m.flat) + vmax = max(m.flat) + + cmap.center = -vmin / (vmax - vmin) + + pcolor(r, z, m, shading='flat', vmin=vmin, vmax=vmax, + norm=norm, cmap=cmap) + + @add_to_dict(modes, 'contour') + def plot_contour(): + global prev_contours + ncont =ncontours or NCONTOURS.get(var, 1) + + if not prev_contours: + prev_contours = contour(r, z, m, ncont, + colors=color, linewidths=linewidth) + else: + contour(r, z, m, prev_contours[0], colors='black') + + @add_to_dict(modes, 'neg_shape') + def plot_neg_shape(): + themin = min(m.flat) + contour(r, z, m, [themin / 2], colors=color, linewidth=linewidth) + + @add_to_dict(modes, 'neg_filled') + def plot_neg_filled(): + themin = min(m.flat) + contourf(r, z, m, [themin / 2, themin], cmap=cmap) + + @add_to_dict(modes, 'pos_shape') + def plot_pos_shape(): + themax = max(m.flat) + contour(r, z, m, [themax / 2], colors=color, linewidth=linewidth) + + @add_to_dict(modes, 'pos_filled') + def plot_pos_filled(): + themax = max(m.flat) + contourf(r, z, m, [themax / 2, themax], cmap=cmap) + + @add_to_dict(modes, 'range') + def output_range(): + themax, themin = max(m.flat), min(m.flat) + print "%g:%g" % (themin, themax) + + modes[mode]() + + if frame: + hlines([lz[0], lz[-1]], lr[0], lr[-1], "w", linewidth=1.5) + vlines([lr[0], lr[-1]], lz[0], lz[-1], "w", linewidth=1.5) + + + if saffman is not None: + plot_saffman(color='blue', *saffman) + + if superimpose is not None: + try: + fname, shift, factor = superimpose + except ValueError: + fname, shift, factor = superimpose, 0.0, 1.0 + + plot_xyfile(fname, shift=shift, factor=factor, color='blue') + + if aspect: + axis('scaled') + + if setaxis and zcross is None: + axis([0, 0.75, 0, 1.0]) + xlim(lr[0], lr[-1]) + ylim(lz[0], lz[-1]) + + if rrange: + if normranges: + factor = rescaling.get('r', 1.0) + rrange = [factor * rl for rl in rrange] + + xlim(*rrange) + + if zrange: + if normranges: + factor = rescaling.get('z', 1.0) + zrange = [factor * zl for zl in zrange] + + ylim(*zrange) + + #@print_ret + def get_label(x): + theunits = units.get(x, '') + if theunits: + return (r'$%s$ [$\mathdefault{%s}$]' + % (pretty_var(x), theunits)) + else: + return r'%s' % pretty_var(x) + + + if touchaxis: + xlabel(get_label(rlabel), fontsize=fontsize) + ylabel(get_label(zlabel), fontsize=fontsize) + + + xmin, xmax = None, None + + ax = gca() + ax.xaxis.set_major_formatter(FancyFormatter()) + ax.yaxis.set_major_formatter(FancyFormatter()) + + + + if mode == 'pcolor' and touchaxis: + + #cax = colorbar(format="%.3g", cax=ncax) + + # This was for the Saffman-Taylor paper: + #cax = colorbar(format="%.3g", fraction=0.20, pad=0.00, aspect=12) + + format = FancyFormatter() + if 'log' in var: + format = r'$\mathdefault{10^{%d}}$' + + #format = 'log' in var and '$10^{%d}$' or "%.3g" + cax = colorbar(format=format) + #for t in cax.get_yticklabels(): + # t.set_fontsize(fontsize - 2) + #gcf().sca(ax) + #ipshell() + xmin, xmax = cax.get_clim() + + #trans = blend_xy_sep_transform(cax.transAxes, cax.transData) + #xpos = 2.5 + #xpos = 4.0 + #xpos = -0.5 + #cax.text(xpos, 0.5 * (xmin + xmax), + # get_label(var), ha='right', va='center', transform=trans, + # rotation='vertical', fontsize=fontsize) + if clabel is None: + clabel = get_label(var) + + cax.set_label(clabel, fontsize=fontsize) + + if vector is not None: + if ':' in vector: + grid, vector = vector.split(':') + + d = {'field': False, 'current': True} + plot_some_vect(grid, path=path, mirror=mirror, current=d[vector], + rescaling=rescaling) + + + for subgrid in subgrids: + if mirror or mirrored is not None: + mirrs = (-1, 1) + else: + mirrs = (1,) + + for mirr_ in mirrs: + plot_var(var, subgrid, mode=mode, setaxis=False, finish=False, + path=path, units=units, opposite=False, cmap=cmap, + mirror=False, frame=subframe, var_range=[xmin, xmax], + rescaling=rescaling, mirrored=mirr_, rrange=rrange, + zrange=zrange, aspect=False, touchaxis=False, + subframe=subframe) + + + if finish: + show() + +def plot_saffman(width, C, color='white'): + eps = 0.05 + A = width / math.pi + x = arange(-width / 2 + eps, width / 2 - eps, 0.01) + y = A * log(cos(x / A))+ float(C) + + #lam = 0.5 + #L = 2 * width + #y = (L * ( 1 - lam) / (2 * math.pi) + # * log (0.5 * (1 + cos(2 * math.pi * x / (lam * L))))) + float(C) + + plot(x, y, linewidth=1.5, color=color) + +def plot_xyfile(fname, shift=0, factor=1.0, color='white'): + data = load(fname) + + plot(factor * data[:, 0], factor * data[:, 1] + shift, + linewidth=1.5, color=color) + + +def plot_some_vect(grid, path='', dr=1, dz=1, + rescaling={}, mirror=False, current=False): + """ Plots either the electric field (if current == False) or the + current vector field (if current == True)""" + + lr, lz, er = load_var('er', grid, path=path, rescaling=rescaling) + void, void, ez = load_var('ez', grid, path=path, rescaling=rescaling) + + stepr, stepz = int(dr / (lr[1] - lr[0])), int(dr / (lz[1] - lz[0])), + + lr = lr[stepr / 2::stepr] + lz = lz[::stepz] + + er = er[stepr / 2::stepr, 0::stepz] + ez = ez[stepr / 2::stepr, 0::stepz] + + if mirror: + er = concatenate((-flipud(er), er), axis=0) + ez = concatenate((flipud(ez), ez), axis=0) + + lr = concatenate((-lr[::-1], lr)) + + if current: + void, void, electrons = load_var('electrons', grid, path) + electrons = electrons[stepr / 2::stepr, 0::stepz] + if mirror: + electrons = concatenate((flipud(electrons), electrons), axis=0) + else: + electrons = 1.0 + + mr, mz = electrons * er, electrons * ez + + eunit = 1.5e-3 * dr + + plot_vect(lr, lz, mr, mz, eunit=eunit) + +def plot_vect(lr, lz, mr, mz, eunit=1.0, threshold=0.0125): + EPS = 1e-15 + + mr = mr + EPS + mz = mz + EPS + + N = sqrt(mr**2 + mz**2) + if threshold is not None: + mr[N > threshold]=0 + mz[N > threshold]=0 + + Nmax = max(N.flat) * 0.00075 + + + [z, r] = meshgrid(lz, lr) + #quiver(r, z, mr, mz, eunit * Nmax, pivot='middle', + # width=1.0 * Nmax, headwidth=500, color="white") + + quiver(r, z, mr, mz, scale=Nmax / eunit, pivot='middle', color='w') + + +def draw_arrow( x, y, dx, dy, width=1, color = 'k' ): + ax = gca() + a = Arrow(x, y, dx, dy, width) + a.set_edgecolor(color) + a.set_facecolor(color) + ax.add_patch(a) + draw_if_interactive() + return a + +def plot_axis(var, grid, format=None, xlim=None, col=0, rescaling={}): + if format is not None and '@@' in format: + fmt, linewidth = format.split('@@') + linewidth = float(linewidth) + else: + fmt = format + linewidth = 1.5 + + lz, m = load_axis (var, grid, col=col, rescaling=rescaling) + if format: + plot (lz, m, fmt, linewidth=linewidth) + else: + plot (lz, m, linewidth=1.5) + + +def save_fig(var, grid, ext, what="", ofile=None, **kwargs): + if ofile is None: + ofile = output_name(var, grid, ext, what=what) + + savefig(ofile, **kwargs) + return ofile + +def print_ret(f): + def _f(*args, **kwargs): + ret = f(*args, **kwargs) + print "%s -> %s" % (f.__name__, repr(ret)) + return ret + return _f + + + +class FancyFormatter(Formatter): + def __call__(self, x, pos=None): + formatted = "%.3g" % x + if 'e' in formatted: + m, e = formatted.split('e') + formatted = (r'$\mathdefault{%s}\cdot \mathdefault{10^{%d}}$' + % (m, int(e))) + + return formatted diff --git a/src/Makefile b/src/Makefile new file mode 100644 index 0000000000000000000000000000000000000000..d1b2d8018358f463f1465c006966b96954cd0329 --- /dev/null +++ b/src/Makefile @@ -0,0 +1,112 @@ +# Alejandro Luque Estepa, 2006 +# Margreet Nool 2013 + +TOPDIR := .. + +include $(TOPDIR)/Makefile.config +include $(TOPDIR)/Makefile.inc + +.PHONY: example2 all clean + +all: + @echo + @echo "#################################" + @echo "### BUILDING arcos executable ###" + @echo "#################################" + @echo + make arcos + mv arcos .. + +# --------------------------------------------------------------------------- +DEBUG_LEVEL = 1 + +all: arcos +OBJ = cdr.o poisson.o rz_array.o interpol2.o misc.o \ + cstream.o dft.o grid.o reaction.o mapper.o \ + photo.o main.o sprites.o react_table.o rt.o configuration.o + +LIBDIR1 = $(TOPDIR)/fish90/lib +LIBDIR2 = $(TOPDIR)/arcos_f90/lib +LIBDIR3 = $(TOPDIR)/libconfig-1.4.9/lib +LIBS = -L./$(LIBDIR1) -L./$(LIBDIR2) $(LIBDIR3)/.libs/libconfig.so -lfish90 -larcos -lm -lfftw3 +INCDIRS1 = ../include +INCDIRS2 = $(TOPDIR)/fish90/include + +$(OBJ) : $(LIBDIR1)/libfish90.a $(LIBDIR1)/fish.mod \ + $(LIBDIR2)/libarcos.a $(LIBDIR3)/.libs/libconfig.la + + +%.o: %.c + $(CC) $(CFLAGS) $(DFLAGS) $(INCLUDES) -o $@ -c $< + +example2.o : $(INCDIRS1)/libconfig.h $(INCDIRS1)/configuration.h + +example2: configuration.o example2.o + $(CC) $(CCFLAGS) example2.o configuration.o -o $@ $(LIBS_new) + +cdr.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/cstream.h \ + $(INCDIRS1)/grid.h $(INCDIRS1)/interpol2.h \ + $(INCDIRS1)/mapper.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/poisson.h $(INCDIRS1)/proto.h \ + $(INCDIRS1)/react_table.h $(INCDIRS1)/rz_array.h \ + $(INCDIRS1)/species.h $(INCDIRS1)/tree.h + +cstream.o : $(INCDIRS1)/parameters.h $(INCDIRS1)/proto.h \ + $(INCDIRS1)/species.h + +dft.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/cstream.h \ + $(INCDIRS1)/grid.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/proto.h $(INCDIRS1)/rz_array.h \ + $(INCDIRS1)/species.h + +grid.o : $(INCDIRS1)/grid.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/proto.h $(INCDIRS1)/species.h + +interpol2.o : $(INCDIRS1)/grid.h $(INCDIRS1)/interpol2.h \ + $(INCDIRS1)/parameters.h $(INCDIRS1)/proto.h \ + $(INCDIRS1)/rz_array.h $(INCDIRS1)/species.h + +main.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/cstream.h \ + $(INCDIRS1)/grid.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/proto.h $(INCDIRS1)/species.h \ + $(INCDIRS1)/configuration.h + +mapper.o : $(INCDIRS1)/cstream.h $(INCDIRS1)/grid.h \ + $(INCDIRS1)/interpol2.h $(INCDIRS1)/mapper.h \ + $(INCDIRS1)/proto.h $(INCDIRS1)/species.h + +photo.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/interpol2.h \ + $(INCDIRS1)/mapper.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/photo.h $(INCDIRS1)/poisson.h \ + $(INCDIRS1)/proto.h $(INCDIRS1)/rz_array.h \ + $(INCDIRS1)/species.h + +poisson.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/cstream.h \ + $(INCDIRS1)/grid.h $(INCDIRS1)/interpol2.h \ + $(INCDIRS1)/mapper.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/poisson.h $(INCDIRS1)/proto.h \ + $(INCDIRS1)/rz_array.h $(INCDIRS1)/species.h \ + $(INCDIRS2)/fishpack.h + +reaction.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/grid.h \ + $(INCDIRS1)/parameters.h $(INCDIRS1)/photo.h \ + $(INCDIRS1)/proto.h $(INCDIRS1)/react_table.h \ + $(INCDIRS1)/species.h + +react_table.o : $(INCDIRS1)/react_table.h + +rt.o : $(INCDIRS1)/parameters.h $(INCDIRS1)/proto.h \ + $(INCDIRS1)/species.h + +rz_array.o : $(INCDIRS1)/parameters.h $(INCDIRS1)/proto.h \ + $(INCDIRS1)/rz_array.h $(INCDIRS1)/species.h + +sprites.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/photo.h $(INCDIRS1)/poisson.h \ + $(INCDIRS1)/rz_array.h $(INCDIRS1)/species.h + +arcos: $(OBJ) + $(F90) $(F90FLAGS) $(OBJ) -o $@ $(LIBS) + +clean: + rm -f *.o *~ arcos 2> /dev/null diff --git a/src/Makefile.org b/src/Makefile.org new file mode 100644 index 0000000000000000000000000000000000000000..8b5d66466f738355f2d06e6d5815813686f58812 --- /dev/null +++ b/src/Makefile.org @@ -0,0 +1,114 @@ +# Alejandro Luque Estepa, 2006 +# Margreet Nool 2013 + +TOPDIR := .. + +include $(TOPDIR)/Makefile.config +include $(TOPDIR)/Makefile.inc + +.PHONY: example2 all clean + +all: + @echo + @echo "#################################" + @echo "### BUILDING arcos executable ###" + @echo "#################################" + @echo + make arcos + mv arcos .. + +# --------------------------------------------------------------------------- +DEBUG_LEVEL = 1 + +all: arcos +OBJ = cdr.o poisson.o rz_array.o interpol2.o misc.o \ + cstream.o dft.o grid.o reaction.o mapper.o \ + photo.o main.o sprites.o react_table.o rt.o configuration.o + +LIBDIR1 = $(TOPDIR)/fish90/lib +LIBDIR2 = $(TOPDIR)/arcos_f90/lib +LIBDIR3 = /ufs/greta/libconfig/libconfig-1.4.9/lib +LIBDIRS = $(LIBDIR1) $(LIBDIR2) +LIBS = -L./$(LIBDIR1) -L./$(LIBDIR2) -lfish90 -larcos -lm -lfftw3 /ufs/greta/libconfig/libconfig-1.4.9/lib/.libs/libconfig.so +LIBS_new = -L./$(LIBDIR1) -L./$(LIBDIR2) -lfish90 -lm -lfftw3 /ufs/greta/libconfig/libconfig-1.4.9/lib/.libs/libconfig.so +INCDIRS1 = ../include +INCDIRS2 = $(TOPDIR)/fish90/include + +$(OBJ) : $(LIBDIR1)/libfish90.a $(LIBDIR1)/fish.mod \ + $(LIBDIR2)/libarcos.a + + +%.o: %.c + $(CC) $(CFLAGS) $(DFLAGS) $(INCLUDES) -o $@ -c $< + +example2.o : $(INCDIRS1)/libconfig.h $(INCDIRS1)/configuration.h + +example2: configuration.o example2.o + $(CC) $(CCFLAGS) example2.o configuration.o -o $@ $(LIBS_new) + +cdr.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/cstream.h \ + $(INCDIRS1)/grid.h $(INCDIRS1)/interpol2.h \ + $(INCDIRS1)/mapper.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/poisson.h $(INCDIRS1)/proto.h \ + $(INCDIRS1)/react_table.h $(INCDIRS1)/rz_array.h \ + $(INCDIRS1)/species.h $(INCDIRS1)/tree.h + +cstream.o : $(INCDIRS1)/parameters.h $(INCDIRS1)/proto.h \ + $(INCDIRS1)/species.h + +dft.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/cstream.h \ + $(INCDIRS1)/grid.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/proto.h $(INCDIRS1)/rz_array.h \ + $(INCDIRS1)/species.h + +grid.o : $(INCDIRS1)/grid.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/proto.h $(INCDIRS1)/species.h + +interpol2.o : $(INCDIRS1)/grid.h $(INCDIRS1)/interpol2.h \ + $(INCDIRS1)/parameters.h $(INCDIRS1)/proto.h \ + $(INCDIRS1)/rz_array.h $(INCDIRS1)/species.h + +main.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/cstream.h \ + $(INCDIRS1)/grid.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/proto.h $(INCDIRS1)/species.h \ + $(INCDIRS1)/configuration.h + +mapper.o : $(INCDIRS1)/cstream.h $(INCDIRS1)/grid.h \ + $(INCDIRS1)/interpol2.h $(INCDIRS1)/mapper.h \ + $(INCDIRS1)/proto.h $(INCDIRS1)/species.h + +photo.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/interpol2.h \ + $(INCDIRS1)/mapper.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/photo.h $(INCDIRS1)/poisson.h \ + $(INCDIRS1)/proto.h $(INCDIRS1)/rz_array.h \ + $(INCDIRS1)/species.h + +poisson.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/cstream.h \ + $(INCDIRS1)/grid.h $(INCDIRS1)/interpol2.h \ + $(INCDIRS1)/mapper.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/poisson.h $(INCDIRS1)/proto.h \ + $(INCDIRS1)/rz_array.h $(INCDIRS1)/species.h \ + $(INCDIRS2)/fishpack.h + +reaction.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/grid.h \ + $(INCDIRS1)/parameters.h $(INCDIRS1)/photo.h \ + $(INCDIRS1)/proto.h $(INCDIRS1)/react_table.h \ + $(INCDIRS1)/species.h + +react_table.o : $(INCDIRS1)/react_table.h + +rt.o : $(INCDIRS1)/parameters.h $(INCDIRS1)/proto.h \ + $(INCDIRS1)/species.h + +rz_array.o : $(INCDIRS1)/parameters.h $(INCDIRS1)/proto.h \ + $(INCDIRS1)/rz_array.h $(INCDIRS1)/species.h + +sprites.o : $(INCDIRS1)/cdr.h $(INCDIRS1)/parameters.h \ + $(INCDIRS1)/photo.h $(INCDIRS1)/poisson.h \ + $(INCDIRS1)/rz_array.h $(INCDIRS1)/species.h + +arcos: $(OBJ) + $(F90) $(F90FLAGS) $(OBJ) -o $@ $(LIBS) + +clean: + rm -f *.o *~ arcos 2> /dev/null diff --git a/src/cdr.c b/src/cdr.c new file mode 100644 index 0000000000000000000000000000000000000000..2a666b15b6cbb44eb73738f40f619f7a64e7ed25 --- /dev/null +++ b/src/cdr.c @@ -0,0 +1,2546 @@ +/** @file cdr.c +* @brief Routines for handling the CDR (convection-diffusion-reaction) equations +* +* Default interpolation methods.\n +* May be changed elsewhere.\n +* \n +* interpol_method_t *cdr_interpol_inside = \&interpol_quadratic;\n +* interpol_method_t *cdr_interpol_bnd = \&interpol_bilin;\n +* \n +*/ + +#include +#include +#include +#include +#include + +#include "cdr.h" +#include "cstream.h" +#include "grid.h" +#include "interpol2.h" +#include "mapper.h" +#include "parameters.h" +#include "poisson.h" +#include "proto.h" +#include "react_table.h" +#include "rz_array.h" +#include "species.h" +#include "tree.h" + +/** Declaration of the functions to interpolate the densities. */ +decl_mapper_funcs(dens); +mapper_t **dens_mappers, **dens_bnd_mappers; + +int cdr_ext_bnd_cond[4]; +double z_cutoff = 10000000.0; +double max_err = 0.0; +react_table mu; +react_table diff; + +extern pois_problem_t *pois_electrostatic; + +static void set_all_bnd (cdr_grid_t *grid, + int sign, int ir, int iz, int itheta, + int dim0, int inout, + int dim1, int dim1_from, int dim1_to, + int dim2, int dim2_from, int dim2_to); +static void set_axis_bnd (cdr_grid_t *grid); +static void max_update (double *x, double cmp); +static double f_ad (rz_array_t *dens, double efield, double dc, double mc, + int ir, int iz, int itheta, int dim); + +static double psi (double theta); +static void prepare_grid (cdr_grid_t *grid); +static double curv_at (cdr_grid_t *grid, rz_array_t *ar, + int ir, int iz, int itheta, double (*f) (double)); +static int needs_refinement (cdr_grid_t *grid, int ir, int iz, int itheta, + int *in_edge); +static int any_needs_refinement (cdr_grid_t *grid, int ir, int iz, + int *in_edge); +static int brick_needs_refinement (cdr_grid_t *grid, int r0, int z0, + int r1, int z1, int *in_edge); +static void refine_in (cdr_grid_t *grid, int cr0, int cz0, int cr1, int cz1, + int contains_edge); + +static void restrict_from (cdr_grid_t *parent, cdr_grid_t *child); +static int match_grids (cdr_grid_t *fro, cdr_grid_t *to); + +double gauss2_xyz (double x, double y, double z); +int curr_seed = 0; +react_table mu; +react_table diff; + +void aux_dump_frames_r (cdr_grid_t *grid, FILE *fp); + +/** @brief Some initialization is needed for this module which has to be + * inside this function. + */ +void +cdr_init (void) +{ + cdr_ext_bnd_cond[BND_BOTTOM] = cdr_bnd_bottom; + cdr_ext_bnd_cond[BND_TOP] = cdr_bnd_top; + cdr_ext_bnd_cond[BND_RIGHT] = cdr_bnd_right; + + dens_mappers = cdr_mappers_a (interpol_methods_index[cdr_interp_in]); + dens_bnd_mappers = cdr_mappers_a (interpol_methods_index[cdr_interp_bnd]); + + react_table_read("input/default.mobility",&mu); + react_table_read("input/default.diffusion",&diff); +} + +/** @brief And the cleaning up has to be here. */ +void +cdr_end (void) +{ + cdr_free_mappers (dens_mappers); + cdr_free_mappers (dens_bnd_mappers); +} + +/** @brief Creates a new 3D cdr grid */ +cdr_grid_t* +cdr_new_3d_a (int r0, int z0, int r1, int z1, int ntheta) +{ + rz_array_t *ez, *er, *etheta, *eabs, *charge, **dens, **d_dens, *photo; + cdr_grid_t *grid; + int i; + REAL *max_dens; + + debug (2, "cdr_new_3d_a (%d, %d, %d, %d)\n", r0, z0, r1, z1); + + ez = rz_new_3d_a (r0, z0, r1, z1, ntheta); + er = rz_new_3d_a (r0, z0, r1, z1, ntheta); + etheta = rz_new_3d_a (r0, z0, r1, z1, ntheta); + eabs = rz_new_3d_a (r0, z0, r1, z1, ntheta); + charge = rz_new_3d_a (r0, z0, r1, z1, ntheta); + photo = has_photoionization? rz_new_3d_a (r0, z0, r1, z1, ntheta): NULL; + + /* Apart from the real species, (electron, ions...) we can create + * a virtual species that enter into the possible reactions. + * For example, the absolute value of the electric field, eabs. + */ + dens = (rz_array_t **) xmalloc (sizeof(rz_array_t*) + * (no_species + N_VIRTUAL_SPECIES)); + d_dens = (rz_array_t **) xmalloc (sizeof(rz_array_t*) * no_species); + + max_dens = (REAL *) xmalloc (sizeof(REAL) * no_species); + + for (i = 0; i < no_species; i++) { + dens[i] = rz_new_3d_a (r0, z0, r1, z1, ntheta); + d_dens[i] = rz_new_3d_a (r0, z0, r1, z1, ntheta); + } + + dens[no_species] = eabs; + + grid = (cdr_grid_t *) xmalloc (sizeof(cdr_grid_t)); + + grid->r0 = r0; + grid->r1 = r1; + grid->z0 = z0; + grid->z1 = z1; + grid->charge = charge; + grid->er = er; + grid->ez = ez; + grid->etheta = etheta; + grid->eabs = eabs; + grid->photo = photo; + + grid->dens = dens; + grid->d_dens = d_dens; + grid->max_dens = max_dens; + + grid->ntheta = ntheta; + + grid->contains_edge = FALSE; + + init_leaf (grid); + + return grid; +} + +/** @brief Creates a guest cdr grid: + * + * one that does not have memory of its own but + * points to the data of another grid (the @a host grid). This is useful + * to easily set boundary conditions. Probably, this function and + * cdr_new_3d_a should be somehow merged. + */ +cdr_grid_t* +cdr_guest (cdr_grid_t *host, int r0, int z0, int r1, int z1) +{ + rz_array_t *ez, *er, *etheta, *eabs, *charge, **dens, **d_dens, *photo; + cdr_grid_t *grid; + int i; + REAL *max_dens; + + debug (2, "cdr_guest (" grid_printf_str ",%d, %d, %d, %d)\n", + grid_printf_args(host), r0, z0, r1, z1); + + ez = rz_guest (host->ez, r0, z0, r1, z1); + er = rz_guest (host->er, r0, z0, r1, z1); + etheta = rz_guest (host->etheta, r0, z0, r1, z1); + eabs = rz_guest (host->eabs, r0, z0, r1, z1); + charge = rz_guest (host->charge, r0, z0, r1, z1); + photo = (has_photoionization? + rz_guest (host->photo, r0, z0, r1, z1): NULL); + + dens = (rz_array_t **) xmalloc (sizeof(rz_array_t*) + * (no_species + N_VIRTUAL_SPECIES)); + d_dens = (rz_array_t **) xmalloc (sizeof(rz_array_t*) * no_species); + + max_dens = (REAL *) xmalloc (sizeof(REAL) * no_species); + + for (i = 0; i < no_species; i++) { + dens[i] = rz_guest (host->dens[i], r0, z0, r1, z1); + d_dens[i] = rz_guest (host->d_dens[i], r0, z0, r1, z1); + } + + dens[no_species] = eabs; + + grid = (cdr_grid_t *) xmalloc (sizeof(cdr_grid_t)); + + grid->r0 = r0; + grid->r1 = r1; + grid->z0 = z0; + grid->z1 = z1; + + grid->charge = charge; + grid->er = er; + grid->ez = ez; + grid->etheta = etheta; + grid->eabs = eabs; + grid->photo = photo; + + grid->dens = dens; + grid->d_dens = d_dens; + grid->max_dens = max_dens; + + grid->ntheta = host->ntheta; + + grid->contains_edge = FALSE; + + set_leaf (grid, host->parent, NULL, NULL, host->level); + + return grid; +} + +/** @brief Returns a grid with the same dimensions as grid and at the same + * level. + * + * Realize that the data is _not_ copied into the new grid. + */ +cdr_grid_t* +cdr_like_a (cdr_grid_t *grid) +{ + cdr_grid_t *n; + + debug (2, "cdr_like_a(" grid_printf_str ")\n", + grid_printf_args(grid)); + + n = cdr_new_3d_a (grid->r0, grid->z0, grid->r1, grid->z1, grid->ntheta); + n->level = grid->level; + n->ext_bound = grid->ext_bound; + n->contains_edge = grid->contains_edge; + + return n; +} + +/** @brief Returns a grid exactly like te one received, with the densities + * copied. + * + * But the descendants are ignored. + */ +cdr_grid_t* +cdr_clone_a (cdr_grid_t *grid) +{ + cdr_grid_t *n; + int itheta, s, nr, nz, nspecs; + + n = cdr_like_a (grid); + + nr = grid->r1 - grid->r0 + 4; + nz = grid->z1 - grid->z0 + 4; + + nspecs = no_species; + + /* When we use the efield as a refinement criterium, we also have to copy + * eabs (which is a @i virtual density). + */ + if (ref_level_eabs >= 0 && ref_threshold_eabs >= 0.0) nspecs++; + +#pragma omp parallel private(s) + { +#pragma omp for + iter_grid_theta_n (grid, itheta, 2) { + for (s = 0; s < nspecs; s++) { + rz_copy_modes (grid->dens[s], grid->r0 - 2, grid->z0 - 2, + n->dens[s], n->r0 - 2, n->z0 - 2, + nr, nz, itheta, itheta); + } + } + } + return n; +} + +/** @brief Impose periodic boundary conditions in \f$\theta\f$ on a grid. */ +void +cdr_set_periodic (cdr_grid_t *grid) +{ + int i; + + rz_set_periodic (grid->etheta); + + for (i = 0; i < no_species; i++) { + /* For negative r, we have the values + * of the densities on an opposite itheta. + */ + + rz_set_periodic (grid->dens[i]); + rz_set_periodic (grid->d_dens[i]); + + } + + /* I am not completely sure that this is actually neccesary */ + rz_set_periodic (grid->er); + rz_set_periodic (grid->ez); +} + +/** @brief Recursive version of cdr_set_periodic. */ +mk_recursive (cdr_set_periodic, cdr_grid_t) + +/** @brief Frees a cdr grid. */ +void +cdr_free (cdr_grid_t *grid) +{ + int i; + + debug (2, "cdr_free\n"); + + rz_free (grid->charge); + rz_free (grid->er); + rz_free (grid->ez); + rz_free (grid->etheta); + rz_free (grid->eabs); + if (has_photoionization) rz_free (grid->photo); + + for (i = 0; i < no_species; i++) { + rz_free (grid->dens[i]); + rz_free (grid->d_dens[i]); + } + + free (grid->dens); + free (grid->d_dens); + free (grid->max_dens); + + free (grid); +} + +/** @brief Recursive version of cdr_free. */ +void +cdr_free_r (cdr_grid_t *grid) +{ + cdr_grid_t *leaf; + + debug (2, "cdr_free_r (" grid_printf_str ")\n", grid_printf_args (grid)); + + free_childs (grid, leaf, cdr_free_r); + + cdr_free (grid); +} + +/** @brief Calculates the charge in a CDR grid. + * + * Important Note: The charge is here divided by ntheta because + * our FFT functions are unnormalized and hence when they are applied + * forth and back they return the initial value multiplied + * by ntheta. I believe that this is the best point to normalize the + * data. + */ +void +cdr_calc_charge (cdr_grid_t *grid) +{ + int s, r, z, t; + double s_charge; + + debug (3, "cdr_calc_charge\n"); + + rz_set_zero (grid->charge); + + for (s = 0; s < no_species; s++) { + s_charge = spec_index[s]->charge; + +#pragma omp parallel private(r, z) + { +#pragma omp for + iter_grid_theta (grid, t) { + for (r = grid->r0 - 2; r < grid->r1 + 2; r++) { + for (z = grid->z0 - 2; z < grid->z1 + 2; z++) { + RZT (grid->charge, r, z, t) += (RZT (grid->dens[s], r, z, t) + * s_charge) / grid->ntheta; + } + } + } + } + } +} + +/** @brief Recursive version of cdr_calc_charge. */ +mk_recursive (cdr_calc_charge, cdr_grid_t) + +/** @brief Fourier-transforms the charge in grid and all its descendants. */ +void +cdr_dft_charge_r (cdr_grid_t *grid, int sign) +{ + cdr_grid_t *leaf; + + debug (2, "cdr_dft_charge_r(" grid_printf_str ")\n", + grid_printf_args(grid)); + + iter_childs (grid, leaf) { + cdr_dft_charge_r (leaf, sign); + } + + dft_transform (grid->charge, grid->charge, sign); +} + +/** @brief Fourier-transforms the electric field in grid and all its descendants. */ +void +cdr_dft_field_r (cdr_grid_t *grid, int sign) +{ + cdr_grid_t *leaf; + + debug (2, "cdr_dft_field_r(" grid_printf_str ")\n", + grid_printf_args(grid)); + + iter_childs (grid, leaf) { + cdr_dft_field_r (leaf, sign); + } + + dft_transform (grid->er, grid->er, sign); + dft_transform (grid->ez, grid->ez, sign); + + dft_diff ((grid_t *) grid, grid->etheta); + dft_transform (grid->etheta, grid->etheta, sign); +} + +/** @brief Creates a grid one level coarser than GRID that covers the same area + * or somewhat more. + * + * Note: The new grid contains information only about the charge, + * not the other functions. + * That's why we don't use cdr_restrict. + */ +cdr_grid_t* +cdr_create_coarser_a (cdr_grid_t *grid) +{ + int r0_half, r1_half, z0_half, z1_half, itheta; + int r, z; + + cdr_grid_t *new_grid; + + debug (2, "cdr_create_coarser_a\n"); + + r0_half = grid->r0 >> 1; + r1_half = (grid->r1 + 1) >> 1; + + z0_half = grid->z0 >> 1; + z1_half = (grid->z1 + 1) >> 1; + + new_grid = cdr_new_3d_a (r0_half, z0_half, r1_half, z1_half, grid->ntheta); + +#pragma omp parallel private (r, z) + { + /** Note that here we may be going one cell out of the aparent boundaries + of the input grids but we allocated enough memory for that. */ +#pragma omp for + iter_grid_3d_n (new_grid, r, z, itheta, 1) { + /* Start cylindrical */ + /* Here we are interpolating the masses, but in many other places + * we interpolate the densities. Why? + */ + RZT (new_grid->charge, r, z, itheta) = + 0.25 + * (cyl_q (r + 0.25) * (RZT (grid->charge, 2 * r, 2 * z, itheta) + + RZT (grid->charge, 2 * r, 2 * z + 1, itheta)) + + cyl_q (r + 0.75) * (RZT (grid->charge, 2 * r + 1, 2 * z, itheta) + + RZT (grid->charge, 2 * r + 1, 2 * z + 1, + itheta))) + / cyl_q (r + 0.5); + /* End cylindrical */ + } + } + return new_grid; +} + +/** @brief Takes a tree of input nodes and adds n coarser grids, returning a + * pointer to the root leaf. + */ +cdr_grid_t* +cdr_add_coarser_grids_a (cdr_grid_t *prev_root, int n) +{ + int i; + cdr_grid_t *grid = NULL; + + debug (2, "cdr_add_coarser_grids_a\n"); + + assert (n > 0); + + for (i = 0; i < n; i++) { + grid = cdr_create_coarser_a (prev_root); + set_leaf (grid, NULL, NULL, prev_root, prev_root->level - 1); + + prev_root->parent = grid; + + prev_root = grid; + } + return grid; +} + +/** @brief Frees the memory allocated by cdr_add_coarser_grids_a. + * + * Note: be careful to pass here only a tree returned by + * cdr_add_coarser_grids_a, since some grids may lose their references and + * stay allocated forever otherwise. + * (see assert below). + */ +void +cdr_free_coarser_grids (cdr_grid_t *prev_root, int n) +{ + int i; + cdr_grid_t *grid; + + debug (2, "cdr_free_coarser_grids_a\n"); + + for (i = 0; i < n; i++) { + assert (NULL == prev_root->next); + grid = prev_root->first_child; + cdr_free (prev_root); + prev_root = grid; + } + + prev_root->parent = NULL; +} + +/** @brief The interface between the cdr and the poisson parts + * + * If return_pois is true, returns the Poisson trees and they have + * to be de-allocated by the calling program. If not, takes care himself + * of deallocation and returns NULL. + */ +pois_grid_t** +cdr_calc_field_r (cdr_grid_t *cdr, int return_pois) +{ + pois_grid_t **pois_modes; + + debug (2, "cdr_calc_field_r (" grid_printf_str ", %d)\n", + grid_printf_args(cdr), return_pois); + + if (cdr->ntheta != 1) + cdr_dft_charge_r (cdr, 1); + + pois_modes = pois_solve_a (cdr, pois_electrostatic); + + if (cdr->ntheta != 1) + cdr_dft_field_r (cdr, -1); + + cdr_add_ext_field_r (cdr); + + /* Formerly, I added the inhomogeneous field here. But this is problematic: + * see pois_add_inhom_phi_r in poisson.c for details. + * + * To return back to adding electric fields and not potentials, uncomment + * these lines: + + * if (pois_inhom) { + * q_factor = pois_inhom_q_factor (pois_modes[0]); + * debug (1, "q_factor = %g\n", q_factor); + * + * cdr_add_inhom_field_r (cdr, q_factor); + * } + */ + + /* Calculates the absolute value of the field. */ + cdr_calc_eabs_r (cdr); + + /* Impose periodic boundary conditions in theta. */ + if (cdr->ntheta != 1) + cdr_set_periodic_r (cdr); + + if (!return_pois) { + int i; + + for (i = 0; i < max_ntheta; i++) { + pois_free_r (pois_modes[i]); + } + free (pois_modes); + pois_modes = NULL; + } + return pois_modes; +} + +/** @brief Adds an external electric field to a cdr @a grid. + * + * Really, it would be more efficient to include that field in some other + * routine and we will avoid one more grid sweep. However, for the sake + * of code clarity, extendability and maintenability I prefer to add it here. + * + * ext_e_r, ext_e_z and ext_e_theta are functions of three real numbers + * (r, z, \f$\theta\f$) that return each of the components of the electric field. + * + * Note that it is the responsibility of e_theta to behave correctly + * (i.e. periodically) when it receives thetas outside \f$[0, 2 \pi]\f$. + */ +void +cdr_add_ext_field (cdr_grid_t *grid) +{ + int ir, iz, itheta; + + debug (2, "cdr_add_ext_field (" grid_printf_str ")\n", + grid_printf_args(grid)); + +#pragma omp parallel private(ir, iz) + { + #pragma omp for + iter_grid_3d_n (grid, ir, iz, itheta, 2) { + RZT(grid->er, ir, iz, itheta) += + ext_e_r (er_r_at (ir, grid->level), + er_z_at (iz, grid->level), + theta_at (itheta)); + + RZT(grid->ez, ir, iz, itheta) += + ext_e_z (ez_r_at (ir, grid->level), + ez_z_at (iz, grid->level), + theta_at (itheta)); + + RZT(grid->etheta, ir, iz, itheta) += + ext_e_theta (r_at (ir, grid->level), + z_at (iz, grid->level), + etheta_theta_at (itheta)); + } + } +} + +/** @brief Recursive version of cdr_add_ext_field. */ +mk_recursive (cdr_add_ext_field, cdr_grid_t) + + +/** @brief Adds to a cdr grid the inhomogeneous field created by a charge + * q located at (r = 0, z = pois_inhom_z). + * + * THIS FUNCTION IS KEPT FOR REFERENCE ONLY. It was superseded by + * pois_add_inhom_phi_r (see poisson.c) + */ +void +cdr_add_inhom_field_r (cdr_grid_t *grid, double q) +{ + int ir, iz, itheta; + cdr_grid_t *child; + + debug (2, "cdr_add_inhom_field_r (" grid_printf_str ", q = %f)\n", + grid_printf_args(grid), q); + + assert (0 != pois_inhom); + +#pragma omp parallel private(ir, iz) + { + #pragma omp for + iter_grid_3d_n (grid, ir, iz, itheta, 2) { + RZT(grid->er, ir, iz, itheta) += + q * pois_inhom_er (er_r_at (ir, grid->level), + er_z_at (iz, grid->level)); + + RZT(grid->ez, ir, iz, itheta) += + q * pois_inhom_ez (ez_r_at (ir, grid->level), + ez_z_at (iz, grid->level)); + } + } + iter_childs (grid, child) { + cdr_add_inhom_field_r (child, q); + } +} + +/** @brief Calculates the absolute value of the electric field by linear + * interpolation of its components. + * + * Of course, it requires that all the components are already present. */ +void +cdr_calc_eabs (cdr_grid_t *grid) +{ + int ir, iz, itheta; + double er, ez, etheta; + +#pragma omp parallel + { +#pragma omp for private(ir, iz, er, ez, etheta) + iter_grid_3d (grid, ir, iz, itheta) { + er = 0.5 * (RZT (grid->er, ir, iz, itheta) + + RZT (grid->er, ir - 1, iz, itheta)); + ez = 0.5 * (RZT (grid->ez, ir, iz, itheta) + + RZT (grid->ez, ir, iz - 1, itheta)); + if (grid->ntheta != 1) { + etheta = 0.5 * (RZT (grid->etheta, ir, iz, itheta) + + RZT (grid->etheta, ir, iz, itheta - 1)); + } else { + etheta = 0; + } + RZT (grid->eabs, ir, iz, itheta) = sqrt (er * er + ez * ez + + etheta * etheta); + + } + } +} + +/** @brief Recursive version of cdr_calc_eabs. */ +mk_recursive (cdr_calc_eabs, cdr_grid_t) + +/******************** + * Time integration * +*********************/ + +/** @brief Makes sure that all species of one grid are non-negative. */ +void +cdr_nonegative (cdr_grid_t *grid) +{ + int s, ir, iz, itheta; + +#pragma omp parallel + { +#pragma omp for private(ir, iz, s) + iter_grid_theta_n (grid, itheta, 2) { + iter_grid_n(grid, ir, iz, 2) { + for (s = 0; s < no_species; s++) + *RZTP (grid->dens[s], ir, iz, itheta) = + MYMAX(0, *RZTP (grid->dens[s], ir, iz, itheta)); + } + } + } +} + +/** @brief Recursive version of cdr_nonegative. */ +mk_recursive (cdr_nonegative, cdr_grid_t) + +/** @brief Sets the boundary values for the root grid and those grids that + have a boundary coinciding with any of the boundaries of the root grid. */ +void +cdr_set_ext_bnd (cdr_grid_t *grid) +{ + int r0, z0, r1, z1, ntheta; + + debug (2, "cdr_set_ext_bnd (" grid_printf_str " [grid->ext_bound = 0x%x])\n", + grid_printf_args(grid), grid->ext_bound); + + r0 = grid->r0; + z0 = grid->z0; + r1 = grid->r1; + z1 = grid->z1; + ntheta = grid->ntheta; + + /* Matching conditions (reduced to Hom. Neumann for ntheta = 1 at + r = r0 */ + if (grid->ext_bound & BND_MASK (BND_LEFT)) { + set_axis_bnd (grid); + } + + /* At r = r1. */ + if (grid->ext_bound & BND_MASK (BND_RIGHT)) + set_all_bnd (grid, cdr_ext_bnd_cond[BND_RIGHT], r1 - 1, z0 - 2, 0, + R_INDX, 1, + Z_INDX, 0, z1 - z0 + 4, + THETA_INDX, 0, ntheta); + + /* At z = z0. */ + if (grid->ext_bound & BND_MASK (BND_BOTTOM)) + set_all_bnd (grid, cdr_ext_bnd_cond[BND_BOTTOM], r0 - 2, z0, 0, + Z_INDX, -1, + R_INDX, 0, r1 - r0 + 4, + THETA_INDX, 0, ntheta); + + /* At z = z1. */ + if (grid->ext_bound & BND_MASK (BND_TOP)) + set_all_bnd (grid, cdr_ext_bnd_cond[BND_TOP], r0 - 2, z1 - 1, 0, + Z_INDX, 1, + R_INDX, 0, r1 - r0 + 4, + THETA_INDX, 0, ntheta); +} + +/** @brief Recursive version of cdr_set_ext_bnd. */ +mk_recursive (cdr_set_ext_bnd, cdr_grid_t) + +/** @brief Sets some boundary conditions for all the relevant variables in a + * grid, to understand the parameters, see rz_array.c:rz_set_bnd(..) + */ +static void +set_all_bnd (cdr_grid_t *grid, + int sign, int ir, int iz, int itheta, int dim0, int inout, + int dim1, int dim1_from, int dim1_to, + int dim2, int dim2_from, int dim2_to) +{ + int s; + + for (s = 0; s < no_species; s++) { + rz_set_bnd (grid->dens[s], sign, RZTP (grid->dens[s], ir, iz, itheta), + dim0, inout, + dim1, dim1_from, dim1_to, + dim2, dim2_from, dim2_to); + } +} + +/** @brief Sets the proper boundary conditions for a grid that has its + * left boundary at r = 0 (e.g. the root grid). + * + * We don't set Hom. Neumann at r = r0 since r = r0 is + * not a real boundary: the proper condition here is matching the + * opposite grid. But note that this condition reduces to Hom. + * Neumann in the case ntheta = 1 (because itheta2 = itheta = 0). + */ +static void +set_axis_bnd (cdr_grid_t *grid) +{ + int s, itheta, itheta2, ntheta; + + debug (2, "set_axis_bnd (" grid_printf_str ")\n", + grid_printf_args(grid)); + + assert (0 == grid->r0); + + ntheta = grid->ntheta; + + for (s = 0; s < no_species; s++) { + iter_grid_theta (grid, itheta) { + itheta2 = (itheta + ntheta / 2) % ntheta; + + rz_copy_bnd (grid->dens[s], grid->dens[s], + /* sign = */ 1, + /* start_from = */ RZTP (grid->dens[s], + grid->r0, grid->z0 - 2, itheta2), + /* start_to = */ RZTP (grid->dens[s], + grid->r0, grid->z0 - 2, itheta), + R_INDX, BND_OUTWARD, BND_INWARD, + Z_INDX, 0, grid->z1 - grid->z0 + 4, + THETA_INDX, 0, 1 /* <- relative to start_xxx */); + } + } +} + +/** @brief Calculates the derivatives of the densities for each point of the + * grid. + */ +void +cdr_calc_d_dens (cdr_grid_t *grid) +{ + react_apply_all (grid); + + cdr_advect_diffu_r (grid); +} + +/* See "An Adaptive Grid Refinement Strategy for the Simulation + * of Negative Streamers", C. Montijn, W. Hundsdorfer and U. Ebert + * for the computations and notation used in this function. + */ + +/** @brief This thing looks really ugly, but what does it mean? + * For example, for stride = dens[electrons]->strides[R_INDX], + * it is the \f$p_{ij}\f$ of the aforementioned paper: + * \f$p_{i,j} = (\sigma_{i,j} - \sigma_{i-1,j}) / (\sigma_{i+1,j} - \sigma_{i,j})\f$ + */ +#define pij(p_, stride_) \ + (((*(p_)) - *((p_) - (stride_))) / (*((p_) + (stride_)) - *(p_))) + +/** @brief This is the F^a + F^d in the paper (times \f$\delta\f${r, z, \f$\theta\f$}). */ +static double +f_ad (rz_array_t *dens, double efield, double dc, double mc, + int ir, int iz, int itheta, int dim) +{ + double sigma, psi_p, sigmasigma; + int ishift; + double *p; + + /* a p is the unmodified density-value in the cell (ir,iz,itheta). + * Normally this should be n_e, as only electrons are mobile. + */ + p = RZTP (dens, ir, iz, itheta); + + ishift = (efield > 0? 0: 1); + + /* sigma is just + * sigma_{i , j} for efield < 0, + * sigma_{i + 1, j} for efield > 0 + */ + sigma = *(p + ishift * dens->strides[dim]); + + /* psi_p has to be + * psi( p_{i , j}) for efield < 0 + * -psi(1/p_{i+1, j}) for efield > 0 + */ + psi_p = pij (p + ishift * dens->strides[dim], dens->strides[dim]); + + /* E > 0 ---> psi_p = -psi( 1 / p_ij ) + * E < 0, p_ij == 0 ---> psi_p = 1 + * E < 0, p_ij != 0 ---> psi_p = psi( 1 / p_ij ) + */ + psi_p = (efield > 0)? -psi (psi_p) : psi_p == 0? 1.0: psi (1.0 / psi_p); + + /* sigmasigma is (sigma_{i+1, j} - sigma_{i, j}) */ + sigmasigma = (*p) - *(p + dens->strides[dim]); + + /* The first term corresponds to the advection term, the second to the + * diffusion term. + * + * See eq. 3.1.5~3.1.8 in the thesis of C. Montijn. Division by cell-size + * is done in the function calling this one. + */ + return efield * mc * (sigma + psi_p * sigmasigma) + dc * sigmasigma; +} + +/** @brief Adds the advection and diffusion terms to the derivatives of the + * densities. + */ +void +cdr_advect_diffu (cdr_grid_t *grid) +{ + int ir, iz, itheta, s; + int ii; + double gdr_inv, gdz_inv, d_iso0, d_iso; + + double field; + int dimd, t, sg; + REAL *d_dens_p; + double r_inv, er_r; + rz_array_t *er,*ez,*etheta; + + debug (2, "cdr_advect_diffu (" grid_printf_str ")\n", + grid_printf_args(grid)); + + gdr_inv = 1.0 / dr[grid->level]; + gdz_inv = 1.0 / dz[grid->level]; + er = grid->er; + ez = grid->ez; + etheta = grid->etheta; + + for (s = 0; s < no_species; s++) { + /* The charge / mass ratio of a species. */ + double cm0, cm; + int *strides; + int ir, rmax, dim2; + rz_array_t *dens, *d_dens, **d_dens_copy; + + if (spec_index[s]->mass <= 0) continue; + + dens = grid->dens[s]; + d_dens = grid->d_dens[s]; + strides = dens->strides; + rmax = strides[1]; dim2 = strides[2]/strides[1]; + + /* Make a copy of d_dens to be able to compare both versions + * of arcos_cdr_advect + int nr = grid->r1 - grid->r0 + 4; + int nz = grid->z1 - grid->z0 + 4; + d_dens_copy = (rz_array_t **) xmalloc (sizeof(rz_array_t*) * no_species); + rz_copy(d_dens,grid->r0,grid->z0,*d_dens_copy,grid->r0,grid->z0,nr,nz); + + strides = dens->strides; + */ + + arcos_cdr_advect_vec(spec_index[s]->mass,spec_index[s]->charge, + dens->data,d_dens->data,er->data,er->len, + ez->data,ez->len,diffusion_coeff, + dr[grid->level],dz[grid->level], + sprite_module,grid->r0,grid->r1,grid->z0,grid->z1); + + /* rz_free(*d_dens_copy); */ + } +} + +mk_recursive (cdr_advect_diffu, cdr_grid_t) + +/** @brief Limiter function, psi(\f$\theta\f$) = max (0, min(1, 1/3 + \f$\theta\f$/6, \f$\theta\f$)) + */ +static double +psi (double theta) +{ + if (theta < 0) return 0; + if (theta < 0.4) return theta; + if (theta < 4) return (1 + 0.5 * theta) / 3.0; + else return 1.0; +} + +/** @brief Returns the minimum tau that satisfies the Courant-Friedrichs-Lewy + restriction (CFL). */ +double +cdr_courant (cdr_grid_t *grid) +{ + int s, ir, iz, itheta, depth, is_3d; + + double dr_min, dz_min, rdtheta_min, emax_r, emax_z, emax_theta, dmax, ddmax; + double tau_a, tau_d, tau_rt, tau_f, max_diff; + + debug (2, "cdr_courant (" grid_printf_str ")\n", grid_printf_args(grid)); + + is_3d = (grid->ntheta == 1? 0: 1); + + /* Should we better keep track of the level of the finest grid? */ + depth = grid_max_depth_r ((grid_t *) grid); + dr_min = dr[depth]; + dz_min = dz[depth]; + rdtheta_min = dtheta * grid_rmin_r ((grid_t *) grid); + + /* This part is not parallel, but if needed it can be parallelized + * easily by creating vectors xmax[0...ntheta-1], where we would store + * the maximum for each ntheta. + */ + emax_r = -1; + emax_z = -1; + emax_theta = -1; + dmax = -1; + ddmax = 0; + + iter_grid_3d (grid, ir, iz, itheta) { + double mu; + if (sprite_module) { + mu = 1.0 / spr_density_at (z_at (iz, grid->level)); + } else { + mu = 1.0; + } + //mu = sprite_module? 1.0 / spr_density_at (z_at (iz, grid->level)): 1.0; + + max_update (&emax_r, mu * fabs (RZT (grid->er, ir, iz, itheta))); + max_update (&emax_z, mu * fabs (RZT (grid->ez, ir, iz, itheta))); + max_update (&emax_theta, mu * fabs (RZT(grid->etheta, ir, iz, itheta))); + + for (s = 0; s < no_species; s++) { + if (spec_index[s]->mass > 0) { + max_update (&dmax, mu * RZT(grid->dens[s], ir, iz, itheta)); + max_update (&ddmax, -(RZT(grid->d_dens[s], ir, iz, itheta) / + RZT(grid->dens[s], ir, iz, itheta))); + } + } + } + + /* This assert fails when the grid has become completely nan. In that + * case, let us not waste cpu cycles any longer. + */ + assert (emax_r >= 0 && emax_z >= 0 && emax_theta >= 0 && dmax >= 0); + + /* Advection. This one usually dominates. */ + tau_a = nu_a / (emax_r / dr_min + emax_z / dz_min + + is_3d * emax_theta / rdtheta_min); + + /* Diffusion. */ + /* */ + if (sprite_module) { + double dens_z1, dens_z0; + /* Since we do not know where the density is higher, we check at both + * extremes of the domain. We are assuming that the density is monotonic + * but nothing else (if it is not an exp. it works still). + */ + dens_z0 = spr_density_at (z_at (grid->z0, grid->level)); + dens_z1 = spr_density_at (z_at (grid->z1, grid->level)); + max_diff = diffusion_coeff / MYMIN(dens_z0, dens_z1); + } else { + max_diff = 0.1; /* diffusion_coeff */ + } + + tau_d = nu_d / (max_diff / dr_min / dr_min + + max_diff / dz_min / dz_min + + is_3d * max_diff / rdtheta_min / rdtheta_min); + + /* */ + + /* Mainly reaction growth / decay time */ + /* tau_f = nu_f / ddmax; */ + + /* If sigma is zero somewhere, tau_f turns inf even if nu_f is very large. + * We correct this here. */ + /*if (tau_f == 0)*/ tau_f = tau_d; /* Just ignore tau_f please. */ + + /* Dielectric relaxation time */ + tau_rt = nu_rt / dmax; + + return MYMIN (tau_a, MYMIN(tau_d, MYMIN(tau_f, tau_rt))); +} + +static +void max_update (double *x, double cmp) +{ + if (*x < cmp) *x = cmp; +} + +/** @brief Writes into the densities of the grid dest the densities of grid orig + * plus its derivatives times h. + * + * If orig = dest, this implements an Euler step. + * But it can also be used as a tool to implement a RK */ +void +cdr_update (cdr_grid_t *orig, cdr_grid_t *dest, double h) +{ + int ir, iz, itheta, s; + + debug (2, "cdr_update (orig = " grid_printf_str ", dest = " + grid_printf_str ", %f)\n", + grid_printf_args(orig), grid_printf_args(dest), h); + + /* We assume that orig and dest have the same shape. */ + assert (orig->r0 == dest->r0 && orig->z0 == dest->z0 && + orig->r1 == dest->r1 && orig->z1 == dest->z1 && + orig->ntheta == dest->ntheta); + +#pragma omp parallel + { +#pragma omp for private(ir, iz, s) + iter_grid_3d_n (orig, ir, iz, itheta, 2) { + for (s = 0; s < no_species; s++) { + RZT (dest->dens[s], ir, iz, itheta) = + RZT (orig->dens[s], ir, iz, itheta) + + h * RZT (orig->d_dens[s], ir, iz, itheta); + } + } + } + cdr_calc_charge (dest); +} + +/** @brief Sets dest->dens = dens_0->dens + h/2 * d_dens_1->d_dens +\n + * h/2 * d_dens_2->d_dens + * + * Useful to implement 2nd order RK time-stepping. */ +void +cdr_rk2_update (cdr_grid_t *dens_0, cdr_grid_t *d_dens_1, + cdr_grid_t *d_dens_2, cdr_grid_t *dest, + double h) +{ + int ir, iz, itheta, s; + + debug (2, "cdr_rk2_update (dens_0 = " grid_printf_str + ",\n\t\td_dens_1 = " grid_printf_str + ",\n\t\td_dens_2 = " grid_printf_str + ",\n\t\tdest = " grid_printf_str ")\n", + grid_printf_args(dens_0), + grid_printf_args(d_dens_1), + grid_printf_args(d_dens_2), + grid_printf_args(dest)); + +#pragma omp parallel + { +#pragma omp for private(ir, iz, s) + iter_grid_3d_n (dest, ir, iz, itheta, 2) { + for (s = 0; s < no_species; s++) { + RZT (dest->dens[s], ir, iz, itheta) = + RZT (dens_0->dens[s], ir, iz, itheta) + + 0.5 * h * RZT (d_dens_1->d_dens[s], ir, iz, itheta) + + 0.5 * h * RZT (d_dens_2->d_dens[s], ir, iz, itheta); + } + } + } + cdr_calc_charge (dest); +} + +/** @brief Recursive version of cdr_rk2_update + * + * Note: we assume here that all the trees are congruent: this is, + * they have the same structure with nodes of the same size. + */ +void +cdr_rk2_update_r (cdr_grid_t *dens_0, cdr_grid_t *d_dens_1, + cdr_grid_t *d_dens_2, cdr_grid_t *dest, + double h) +{ + cdr_grid_t *c_dens_0, *c_d_dens_1, *c_d_dens_2, *c_dest; + + cdr_rk2_update (dens_0, d_dens_1, d_dens_2, dest, h); + + c_dens_0 = dens_0->first_child; + c_d_dens_1 = d_dens_1->first_child; + c_d_dens_2 = d_dens_2->first_child; + + iter_childs (dest, c_dest) { + cdr_rk2_update_r (c_dens_0, c_d_dens_1, c_d_dens_2, c_dest, h); + + c_dens_0 = c_dens_0->next; + c_d_dens_1 = c_d_dens_1->next; + c_d_dens_2 = c_d_dens_2->next; + } +} + +/** @brief Recursive version of the former QQQQ, used to implement Euler + * integration + */ +void +cdr_self_update_r (cdr_grid_t *grid, double h) +{ + cdr_grid_t *child; + cdr_update (grid, grid, h); + + iter_childs (grid, child) { + cdr_self_update_r (child, h); + } +} + +/** @brief Yet another recursive version of cdr_update, used to implement + * higher order Runge-Kutta integrations. + * + * It creates a new tree of cdr grids. + */ +void +cdr_like_update_ar (cdr_grid_t *grid, cdr_grid_t *new_grid, double h) +{ + cdr_grid_t *child, *new_child, *prev = NULL; + + cdr_update (grid, new_grid, h); + + iter_childs (grid, child) { + new_child = cdr_like_a (child); + + /* We can't use add_child here because we read the children of the grid + * in inverse order as we inserted them. + */ + if (NULL == prev) { + new_grid->first_child = new_child; + } else { + prev->next = new_child; + } + set_leaf (new_child, new_grid, NULL, NULL, new_grid->level + 1); + grid_inherit_ext_bound ((grid_t *) new_child); + + prev = new_child; + + cdr_like_update_ar (child, new_child, h); + } +} + +///** @brief Computes the grid error. QQQQ */ +//double +//cdr_grid_error (cdr_grid_t *grid, cdr_grid_t *inter) +//{ +// int ir, iz, itheta; +// int spec_nr; +// double vol, err, val; +// +// spec_nr = find_species_by_name("electrons"); +// +// assert(spec_nr > -1); +// +// vol = dz[grid->level] * dr[grid->level]; +// +// iter_grid_3d(grid, ir, iz, itheta) +// { +// +// val = RZT(grid->dens[spec_nr], ir, iz, itheta); +// err = val > 1e-12 ? (val - RZT(inter->dens[spec_nr], ir, iz, itheta)) / val : 0; +// err = err > 0 ? err : -err; +// if (max_err < err) +// { +// max_err = err; +// } +// } +// return err; +//} +// +///** @brief Recursive version of cdr_grid_error. QQQQ */ +//void +//cdr_grid_error_r (cdr_grid_t *grid, cdr_grid_t *inter) +//{ +// cdr_grid_t *g_child, *i_child; +// +// cdr_grid_error(grid, inter); +// +// i_child = inter->first_child; +// +// for (g_child = grid->first_child; g_child; g_child = g_child->next) +// { +// cdr_grid_error_r(g_child, i_child); +// +// i_child = i_child->next; +// } +//} + +/** @brief Makes a full second order Runge-Kutta step. + * + * Returns the timestep actually performed, which can be smaller that h + * if it does not satisfy the Courant criterium. + */ +double +cdr_rk2 (cdr_grid_t *grid, double h, double t) +{ + /* intermediate step. */ + cdr_grid_t *inter, *child; + double courant_h; + + /* After this number of warnings about small timesteps, the code stops. */ + static int count_min_timestep = 5; + + debug (2, "cdr_rk2 (" grid_printf_str ", %f)\n", + grid_printf_args(grid), h); + + cdr_nonegative_r (grid); + + /* We want to be sure that the boundaries are properly set. */ + prepare_grid (grid); + + /* Experimental: Moving z_max boundary -- DISABLED */ + + cdr_calc_field_r (grid, /*return_pois = */ FALSE); + + /* If we are using the sprite module, we set here the proper magnitudes + corresponding to the head altitude here. */ + if (sprite_module) spr_hook (grid); + + cdr_calc_d_dens (grid); + + /* The actual timestep is limited by the Courant stability criterium. + * + * Note that cdr_courant has to be called AFTER the computation of the fields. + */ + courant_h = cdr_courant (grid); + h = MYMIN (h, courant_h); + + if (h < warn_min_timestep) { + warning ("Time step [h = %g] is rather small. If this is ok, reduce " + "warn_time_step to remove this warning\n", h); + + if (0 == count_min_timestep--) { + fatal ("Too many warnings about small timesteps.\n"); + } + } + + inter = cdr_like_a (grid); + + /* We create a new tree and put there y + dy/dt * h at each level. */ + cdr_like_update_ar (grid, inter, h); + + /* Set the proper boundary conditions also in the intermediate step. */ + prepare_grid (inter); + + cdr_calc_field_r (inter, /* return_pois = */ FALSE); + cdr_calc_d_dens (inter); + + /* This is something like grid = grid + h / 2 * F(grid) + h / 2 F(inter) */ + cdr_rk2_update_r (grid, grid, inter, grid, h); + + /* Also, for the refinement functions, the boundary conditions have to be + * appropriately set. + */ + prepare_grid (grid); + + cdr_free_r (inter); + + return h; +} + +/** @brief Prepares a grid family : + * a) Set the boundaries for all subgrids,\n + * b) Restrict the coarser grids from the fine ones.\n + */ +static void +prepare_grid (cdr_grid_t *grid) +{ + /* Restrict the densities from finer to coarser grids. */ + cdr_restrict_r (grid); + + /* Sets the external boundaries. */ + cdr_set_ext_bnd_r (grid); + + /* Sets the boundaries of children grids interpolating from their parents. */ + cdr_set_bnd_r (grid); + + /* If two grids share a boundary, use the values of one to set the + boundaries of the other. */ + cdr_match_r (grid, NULL); + + /* Sets periodic boundary conditions in theta. */ + cdr_set_periodic_r (grid); +} + +/***************************************************************** + * Refinement and mapping. + *****************************************************************/ + +/** @brief Takes a pointer to a family of cdr grids, creates a new family + * which is stored in that pointer and takes rid of the initial family. + * + * This function is the entry point of the refinement code. +*/ +void +cdr_update_refined (cdr_grid_t **ptree) +{ + cdr_grid_t *old, *new; + + old = *ptree; + + new = cdr_clone_a (old); + cdr_calc_charge (new); + cdr_refine_r (new, old); + + *ptree = new; + + cdr_free_r (old); +} + +/** @brief Updates the values of max_dens and max_charge. + * + * This values are needed for the refinement criterium. + */ +void +cdr_calc_maxs (cdr_grid_t *grid) +{ + int start = TRUE; + int s, ir, iz, itheta; + + debug (2, "cdr_calc_maxs (" grid_printf_str ")\n", + grid_printf_args(grid)); + + /* If we have a parent, we inherit the maxs from him. */ + if (grid->parent) { + grid->max_charge = grid->parent->max_charge; + for (s = 0; s < no_species; s++) { + grid->max_dens[s] = grid->parent->max_dens[s]; + } + return; + } + + iter_grid_3d (grid, ir, iz, itheta) { + if (start) { + start = FALSE; + grid->max_charge = fabs(RZT (grid->charge, ir, iz, itheta)); + for (s = 0; s < no_species; s++) { + grid->max_dens[s] = RZT (grid->dens[s], ir, iz, itheta); + } + } else { + max_update (&grid->max_charge, fabs(RZT (grid->charge, ir, iz, itheta))); + for (s = 0; s < no_species; s++) { + max_update (&grid->max_dens[s], RZT (grid->dens[s], ir, iz, itheta)); + } + } + } + + debug (2, "->max_charge = %g, ->max_dens[0] = %g, ->max_dens[1] = %g\n", + grid->max_charge, grid->max_dens[0], grid->max_dens[1]); +} + +/** @brief Determines the curvature of ar, which has to be a component of + * grid at @a ir, @a iz. + * + * If @a f is nonnull, determines the curvature of \f$f(ar)\f$. \n + * Note that we only consider the curvatures in @a r and @a z (not in + * \f$\theta\f$). + * This is because \f$\theta\f$ is never refined. (can that be changed in some + * future?) + */ +static double +curv_at (cdr_grid_t *grid, rz_array_t *ar, int ir, int iz, int itheta, + double (*f) (double)) +{ + int i, level; + REAL x[3]; + double dur, duz; + + for (i = 0; i < 3; i++) { + x[i] = RZT (ar, ir - 1 + i, iz, itheta); + x[i] = f? f(x[i]): x[i]; + } + + level = grid->level; + /* */ + dur = (cyl_er_r_at (ir, level) * (x[2] - x[1]) + - cyl_er_r_at (ir - 1, level) * (x[1] - x[0])) / cyl_r_at (ir, level); + /* */ + + for (i = 0; i < 3; i++) { + x[i] = RZT (ar, ir, iz - 1 + i, itheta); + x[i] = f? f(x[i]): x[i]; + } + + duz = (x[2] - 2 * x[1] + x[0]); + + return fabs(dur) + fabs(duz); +} + +/** @brief Does the point in grid at @a ir, @a iz, @a itheta require to be + * further refined? + */ +static int +needs_refinement (cdr_grid_t *grid, int ir, int iz, int itheta, int *in_edge) +{ + double curv; + int s; + /* For sprites, the eabs refinement criterium may depend on the location. */ + int s_ref_level_eabs; + double s_ref_threshold_eabs; + + /* If the maximum charge is below this number, we ignore the refinement + * criterium. + */ + const double epsilon_charge = 1e-8; + + if (!sprite_module || ref_level_eabs < 0) { + s_ref_level_eabs = ref_level_eabs; + s_ref_threshold_eabs = ref_threshold_eabs; + } else { + double z, back_dens; + z = z_at (iz, grid->level); + back_dens = spr_density_at (z); + + s_ref_threshold_eabs = ref_threshold_eabs * back_dens; + + /* log2 appears because whenever we increase the background density by a + * factor 2, we should refine up to one more level. + */ + s_ref_level_eabs = ref_level_eabs + (int) floor (log2 (back_dens)); + } + + /* Electric field refinement. If eabs > ref_threshold_eabs, refine up to + * some predefined level. + */ + + if (grid->level < s_ref_level_eabs && + RZT (grid->eabs, ir, iz, itheta) > s_ref_threshold_eabs) { + debug (4, "Refine grid " grid_printf_str + " at ir = %d, iz = %d, itheta = %d\n" + "\t because too high EABS [eabs = %g]\n", + grid_printf_args(grid), ir, iz, itheta, + RZT (grid->eabs, ir, iz, itheta)); + + *in_edge = FALSE; + return TRUE; + } + + curv = curv_at (grid, grid->charge, ir, iz, itheta, NULL); + + if (grid->max_charge > epsilon_charge + && curv / grid->max_charge > ref_threshold_charge) { + debug (4, "Refine grid " grid_printf_str + " at ir = %d, iz = %d, itheta = %d\n" + "\t because too high CHARGE curvature [curv / max_charge = %g]\n", + grid_printf_args(grid), ir, iz, itheta, curv / grid->max_charge); + + *in_edge = FALSE; + return TRUE; + } + + for (s = 0; s < no_species; s++) { + /* We ignore immobile species: */ + if (spec_index[s]->mass <= 0) continue; + + curv = curv_at (grid, grid->dens[s], ir, iz, itheta, NULL); + if (curv / grid->max_dens[s] > ref_threshold_dens) { + debug (4, "Refine grid " grid_printf_str + " at ir = %d, iz = %d, itheta = %d\n" + "\t because too high DENS[%s] curvature [curv / max_dens = %g]\n", + grid_printf_args(grid), ir, iz, itheta, spec_index[s]->name, + curv / grid->max_dens[s]); + + *in_edge = FALSE; + return TRUE; + } + + /* If the grid contains the leading edge, the criterium of + * refinement also takes into account the density. + */ + if (*in_edge && RZT (grid->dens[s], ir, iz, itheta) > ref_threshold_edge) { + debug (4, "Refine grid " grid_printf_str + " at ir = %d, iz = %d, itheta = %d\n" + "\t because too high DENS[%s] in leading edge [dens = %g]\n", + grid_printf_args(grid), ir, iz, itheta, spec_index[s]->name, + RZT (grid->dens[s], ir, iz, itheta)); + return TRUE; + } + } + + /* If we are close to the border, we also check the border itself. + * + * NOTE: Does this have any sense? We are anyway checking for + * the boundaries, aren't we? + */ + if (ir == grid->r0 + 1 && needs_refinement (grid, ir - 1, iz, itheta, + in_edge)) + return TRUE; + + if (iz == grid->z0 + 1 && needs_refinement (grid, ir, iz - 1, itheta, + in_edge)) + return TRUE; + + if (ir == grid->r1 - 2 && needs_refinement (grid, ir + 1, iz, itheta, + in_edge)) + return TRUE; + + if (iz == grid->z1 - 2 && needs_refinement (grid, ir, iz + 1, itheta, + in_edge)) + return TRUE; + + return FALSE; +} + +/** @brief Calls the needs_refinement at all \f$\theta\f$ and returns true if + * the grids needs to be refined in _any_ of the angles. + * + * This is the safest thing to do, but some other criterium could be imagined + * as well. The search is stopped as soon as a cell that requires refinement + * is found, but not if it requires refinement due to the leading edge density + * criterium. This is because we need to find where we have to stop applying + * that criterium. + */ +static int +any_needs_refinement (cdr_grid_t *grid, int ir, int iz, int *in_edge) +{ + int itheta; + int ret = FALSE; + iter_grid_theta (grid, itheta) { + if (needs_refinement (grid, ir, iz, itheta, in_edge)) { + debug (6, grid_printf_str + " needs refinement at ir = %d, iz = %d itheta = %d\n", + grid_printf_args(grid), ir, iz, itheta); + ret = TRUE; + } + if (ret && ! *in_edge) return TRUE; + } + return ret; +} + +/** @brief Determines whether a @a brick needs refinement. + * + * Now we look if we need refinement in a @a brick \n + * i.e. a rectangle in @a r, @a z space + * (usually, @a height = @a cdr_brick_dz, + * @a width = @a cdr_brick_dr), + * but can be smaller if we reach a boundary. + * + * See above, any_needs_refinement to see when do we stop the search. + */ +static int +brick_needs_refinement (cdr_grid_t *grid, int r0, int z0, int r1, int z1, + int *in_edge) +{ + int ir, iz; + int ret = FALSE; + + for (ir = r0; ir < r1; ir ++) { + for (iz = z1 - 1; iz >= z0; iz--) { + ret = (any_needs_refinement (grid, ir, iz, in_edge) || ret); + if (ret && ! *in_edge) return TRUE; + } + } + return ret; +} + +/** @brief Uses the previous routines to refine (if needed) a cdr grid */ +void +cdr_refine (cdr_grid_t *grid) +{ + int ir; + + debug (2, "cdr_refine (" grid_printf_str ")\n", + grid_printf_args(grid)); + + assert (grid->level <= cdr_max_level); + + /* Checks if the maximum refinement level has been reached. */ + if (grid->level == cdr_max_level) return; + + cdr_calc_maxs (grid); + + for (ir = grid->r0; ir < grid->r1; ir += cdr_brick_dr) { + int irmax = MYMIN (grid->r1, ir + cdr_brick_dr); + int tainted, building, z0 = -1, z1 = -1; + int iz; + int in_edge; + int first_edge; + + first_edge = in_edge = grid->contains_edge; + + /* The leading edge extends downwards. */ + for (iz = grid->z0, building = FALSE; + iz < grid->z1; iz += cdr_brick_dz) { + int izmax = MYMIN (grid->z1, iz + cdr_brick_dz); + + tainted = brick_needs_refinement (grid, ir, iz, irmax, izmax, + &first_edge); + if (tainted) { + z1 = izmax; + if (!building) { + z0 = iz; + building = TRUE; + } + } else /* ! tainted */ { + if (building) { + assert (z0 >= 0 && z1 > 0); + /* If a grid does not satisfy the curvature criterium anywhere + * and is here only because of the density threshold (edge) + * criterium, he does not deserve to be refined. + */ + building = FALSE; + if (!first_edge) { + refine_in (grid, ir, z0, irmax, z1, in_edge); + in_edge = FALSE; + } + } + } + } + if (building) { + assert (z0 >= 0 && z1 > 0); + if (!first_edge) refine_in (grid, ir, z0, irmax, z1, in_edge); + } + } +} + +/** @brief Adds a child to a cdr grid. + * + * The coordinates are in the parent's units + */ +static void +refine_in (cdr_grid_t *grid, int cr0, int cz0, int cr1, int cz1, + int contains_edge) +{ + cdr_grid_t *child; + int nr0, nr1, nz0, nz1; + + nr0 = cr0 << 1; + nz0 = cz0 << 1; + nr1 = cr1 << 1; + nz1 = cz1 << 1; + + child = cdr_new_3d_a (nr0, nz0, nr1, nz1, grid->ntheta); + + add_child (grid, child); + grid_inherit_ext_bound ((grid_t*) child); + + child->contains_edge = contains_edge; + + debug (3, "new child created {r0 = %d, z0 = %d, r1 = %d, z1 = %d, " + "level = %d}\n", child->r0, child->z0, child->r1, child->z1, + child->level); +} + +/** @brief Recursively refines a cdr grid and constructs a tree based on it. + * + * if source == NULL\n + * then uses the initial densities\n + * else sets the densities of the newly created grids by interpolating and + * copying from the tree source. + */ +void +cdr_refine_r (cdr_grid_t *grid, cdr_grid_t *source) +{ + cdr_grid_t *child; + int itheta; + + cdr_calc_charge (grid); + + cdr_refine (grid); + + iter_childs (grid, child) { + if (NULL != source) { +#pragma omp parallel + { +#pragma omp for + iter_grid_theta (child, itheta) { + map_grid_r (dens_mappers, (grid_t *) source, (grid_t *) child, + itheta, + /* copy = */ TRUE, + /* interpol = */ TRUE, + /* coarsen = */ FALSE, + /* s_buff = */ 0, /* t_buff = */ 2); + } + } + } else { + cdr_init_dens (child); + } + cdr_refine_r (child, source); + } +} + +/* Matching of the boundaries: + * + * The boundary conditions of a grid that has a common border with another + * one at the same level have to be matched. This is the purpose of this set + * of functions. + */ + +/** @brief Examines pairs of grids and matches them and all their descendants. + * + * If grid2 == NULL, matches only the descendats of grid1. Hence, this + * routine is usually called as cdr_match_r (root, NULL). + */ +void +cdr_match_r (cdr_grid_t *grid1, cdr_grid_t *grid2) +{ + cdr_grid_t *child1, *child2; + int match = TRUE; + + if (grid2) { + debug (2, "cdr_match_r (grid1 = " grid_printf_str + ", grid2 = " grid_printf_str ")\n", + grid_printf_args (grid1), grid_printf_args (grid2)); + } else { + debug (2, "cdr_match_r (grid1 = " grid_printf_str + ", grid2 = NULL)\n", grid_printf_args (grid1)); + } + + if (NULL != grid2) { + match = match_grids (grid1, grid2); + } + + if (!match) return; + + iter_childs (grid1, child1) { + debug (4, "\tchild1 = " grid_printf_str "\n", + grid_printf_args (child1)); + iter_childs (grid1, child2) { + debug (4, "\t\tchild2 = " grid_printf_str "\n", + grid_printf_args (child2)); + + cdr_match_r (child1, (child1 != child2)? child2: NULL); + } + + if (NULL == grid2) + continue; + + iter_childs (grid2, child2) { + cdr_match_r (child1, child2); + } + } +} + +/** @brief Matches the boundaries of grid to reading from grid @a fro. + * + * Returns TRUE if there was a matching, FALSE otherwise. + * Maybe this function should be rewritten to make it more compact and clear. + */ +static int +match_grids (cdr_grid_t *fro, cdr_grid_t *to) +{ + int s, x0, x1; + + debug (2, "match_grids (to = " grid_printf_str + ", fro = " grid_printf_str ")\n", + grid_printf_args(to), grid_printf_args(fro)); + + assert (to->level == fro->level); + + if (to->r1 == fro->r0) { + x0 = MYMAX (to->z0 - 2, fro->z0 - 2); + x1 = MYMIN (to->z1 + 2, fro->z1 + 2); + if (x1 <= x0) return FALSE; + + for (s = 0; s < no_species; s++) { + rz_copy_bnd (fro->dens[s], to->dens[s], 1, + RZTP (fro->dens[s], fro->r0, x0, 0), + RZTP (to->dens[s], to->r1 - 1, x0, 0), + R_INDX, BND_OUTWARD, BND_OUTWARD, + Z_INDX, 0, x1 - x0, + THETA_INDX, 0, fro->ntheta); + } + return TRUE; + } + + if (to->r0 == fro->r1) { + x0 = MYMAX (to->z0 - 2, fro->z0 - 2); + x1 = MYMIN (to->z1 + 2, fro->z1 + 2); + if (x1 <= x0) return FALSE; + + for (s = 0; s < no_species; s++) { + rz_copy_bnd (fro->dens[s], to->dens[s], 1, + RZTP (fro->dens[s], fro->r1 - 1, x0, 0), + RZTP (to->dens[s], to->r0, x0, 0), + R_INDX, BND_INWARD, BND_INWARD, + Z_INDX, 0, x1 - x0, + THETA_INDX, 0, fro->ntheta); + } + return TRUE; + } + + if (to->z1 == fro->z0) { + x0 = MYMAX (to->r0 - 2, fro->r0 - 2); + x1 = MYMIN (to->r1 + 2, fro->r1 + 2); + if (x1 <= x0) return FALSE; + + for (s = 0; s < no_species; s++) { + rz_copy_bnd (fro->dens[s], to->dens[s], 1, + RZTP (fro->dens[s], x0, fro->z0, 0), + RZTP (to->dens[s], x0, to->z1 - 1, 0), + Z_INDX, BND_OUTWARD, BND_OUTWARD, + R_INDX, 0, x1 - x0, + THETA_INDX, 0, fro->ntheta); + } + return TRUE; + } + + if (to->z0 == fro->z1) { + x0 = MYMAX (to->r0 - 2, fro->r0 - 2); + x1 = MYMIN (to->r1 + 2, fro->r1 + 2); + if (x1 <= x0) return FALSE; + + for (s = 0; s < no_species; s++) { + rz_copy_bnd (fro->dens[s], to->dens[s], 1, + RZTP (fro->dens[s], x0, fro->z1 - 1, 0), + RZTP (to->dens[s], x0, to->z0, 0), + Z_INDX, BND_INWARD, BND_INWARD, + R_INDX, 0, x1 - x0, + THETA_INDX, 0, fro->ntheta); + } + return TRUE; + } + return FALSE; +} + +/** @brief Sets the boundary conditions of all children of grid by + * interpolating from grid itself. + */ +void +cdr_set_bnd (cdr_grid_t *grid) +{ + cdr_grid_t *top, *bottom, *left, *right, *parent; + int itheta; + + debug (2, "cdr_set_bnd (" grid_printf_str ")\n", + grid_printf_args(grid)); + + parent = grid->parent; + if (NULL == parent) { + assert (0 == grid->level); + return; + } + + /* Since our mapping functions are easier to implement when we map + * between rectangular regions (grids) we map the boundary conditions + * by creating from grid four "guest" grids that share memory with him + * and that contains each of the four boundaries. + */ + top = cdr_guest (grid, grid->r0 - 2, grid->z1, + grid->r1 + 2, grid->z1 + 2); + bottom = cdr_guest (grid, grid->r0 - 2, grid->z0 - 2, + grid->r1 + 2, grid->z0); + left = cdr_guest (grid, grid->r0 - 2, grid->z0, + grid->r0, grid->z1); + right = cdr_guest (grid, grid->r1, grid->z0, + grid->r1 + 2, grid->z1); + +#pragma omp parallel + { +#pragma omp for + iter_grid_theta (grid, itheta) { + if (0 == (grid->ext_bound & BND_MASK (BND_TOP))) + map_grid (dens_bnd_mappers, (grid_t *) parent, (grid_t *) top, itheta, + FALSE, TRUE, FALSE, 1, 0); + + if (0 == (grid->ext_bound & BND_MASK (BND_BOTTOM))) + map_grid (dens_bnd_mappers, (grid_t *) parent, (grid_t *) bottom, itheta, + FALSE, TRUE, FALSE, 1, 0); + + if (0 == (grid->ext_bound & BND_MASK (BND_LEFT))) { + assert (grid->r0 != 0); + map_grid (dens_bnd_mappers, (grid_t *) parent, (grid_t *) left, itheta, + FALSE, TRUE, FALSE, 1, 0); + + } + + if (0 == (grid->ext_bound & BND_MASK (BND_RIGHT))) + map_grid (dens_bnd_mappers, (grid_t *) parent, (grid_t *) right, itheta, + FALSE, TRUE, FALSE, 1, 0); + } + } + + cdr_free (top); + cdr_free (bottom); + cdr_free (left); + cdr_free (right); +} + +/** @brief Recursive version of cdr_set_bnd. */ +mk_recursive (cdr_set_bnd, cdr_grid_t) + +/** @brief Mapping of the densities. */ +mapper_t** +cdr_mappers_a (interpol_method_t *interp_method) +{ + mapper_t *mapper, **mappers; + int s, nmappers; + + nmappers = no_species; + + /* mapper->extra represent the species whose density we will map. + * There are no_species species, but no_species + 1 represents + * the abs value of the electric field, which is mapped only to use + * as an electric field-based refinement criterium. + */ + if (ref_level_eabs >= 0 && ref_threshold_eabs >= 0.0) nmappers++; + + mappers = (mapper_t **) xmalloc (sizeof(mapper_t*) * (nmappers + 1)); + + for (s = 0; s < nmappers; s++) { + mapper = (mapper_t *) xmalloc (sizeof(mapper_t)); + mapper->extra = s; + mapper->interpol_method = interp_method; + mapper->copy = dens_copy; + mapper->interpol_set = dens_interpol_set; + mapper->interpol = dens_interpol; + mapper->coarsen = NULL; + mapper->shift_r = 0; + mapper->shift_z = 0; + mappers[s] = mapper; + } + + mappers[nmappers] = NULL; + + return mappers; +} + +/** @brief Frees the memory of all mappers QQQQ */ +void +cdr_free_mappers (mapper_t **mappers) +{ + int s; + + for (s = 0; s < no_species; s++) { + free (mappers[s]); + } + free (mappers); +} + +/** @brief dens_copy Copies QQQQ */ +void +dens_copy (mapper_t *mapper, grid_t *source, grid_t *target, + int ir, int iz, int itheta) +{ + cdr_grid_t *cdr_s, *cdr_d; + + cdr_s = (cdr_grid_t*) source; + cdr_d = (cdr_grid_t*) target; + + RZT (cdr_d->dens[mapper->extra], ir, iz, itheta) = + RZT (cdr_s->dens[mapper->extra], ir, iz, itheta); +} + +/** @brief Interpolates a set QQQQ */ +int +dens_interpol_set (mapper_t *mapper, grid_t *source, interpol_t *interpol, + int pr, int pz, int itheta) +{ + cdr_grid_t *cdr; + + cdr = (cdr_grid_t*) source; + + interpol_set_stencil_at (source, interpol, + r_at (pr, cdr->level), + z_at (pz, cdr->level), + cdr->dens[mapper->extra], pr, pz, itheta); + return TRUE; +} + +/** @brief dens_interpol Interpolates QQQQ */ +void +dens_interpol (mapper_t *mapper, grid_t *source, grid_t *target, + interpol_t *interpol, + int ir, int iz, int itheta) +{ + double r, z; + cdr_grid_t *cdr; + + cdr = (cdr_grid_t *) target; + + r = r_at (ir, cdr->level); + z = z_at (iz, cdr->level); + + RZT (cdr->dens[mapper->extra], ir, iz, itheta) = + interpol_apply (interpol, r, z); +} + +/** @brief Restricts the values of the densities from the child grid into the + * parent. + */ +static void +restrict_from (cdr_grid_t *parent, cdr_grid_t *child) +{ + int ir, iz, cr, cz, itheta, s; + REAL sum; + + debug (2, "restrict_from (parent =" grid_printf_str + ", child = " grid_printf_str ")\n", + grid_printf_args(parent), grid_printf_args(child)); + + assert (parent->level == child->level - 1); + +#pragma omp parallel private(sum, ir, iz, cr, cz, s) + { +#pragma omp for + iter_grid_theta (parent, itheta) { + iter_grid_parent (child, ir, iz) { + for (s = 0; s < no_species; s++) { + sum = 0; + for (cr = (ir << 1); cr <= (ir << 1) + 1; cr++) + for (cz = (iz << 1); cz <= (iz << 1) + 1; cz++) + sum += cyl_r_at (cr, child->level) + * RZT (child->dens[s], cr, cz, itheta); + RZT (parent->dens[s], ir, iz, itheta) = + 0.25 * sum / cyl_r_at (ir, parent->level); + } + } + } + } +} + +/** @brief Restricts a grid with all its children. + */ +void +cdr_restrict (cdr_grid_t *grid) +{ + cdr_grid_t *child; + + iter_childs(grid, child) { + restrict_from (grid, child); + } +} + +/** @brief And its recursive version. + * + * Note that this has to be tail recursive, sice we first have to restrict + * the childs. + */ +mk_tail_recursive (cdr_restrict, cdr_grid_t) + + +/** @brief Now the routines to initialize a grid with given densities. + * gauss2 initializes one or two gaussian seeds + */ +double +gauss2_xyz (double x, double y, double z) +{ + double q; + + q = invpi32 * 1 / (seed_index[curr_seed]->sigma_x * seed_index[curr_seed]->sigma_y * + seed_index[curr_seed]->sigma_z) + * exp (- SQ(x - seed_index[curr_seed]->x0) / SQ(seed_index[curr_seed]->sigma_x) + - SQ(y - seed_index[curr_seed]->y0) / SQ(seed_index[curr_seed]->sigma_y) + - SQ(z - seed_index[curr_seed]->z0) / SQ(seed_index[curr_seed]->sigma_z)); + return q; +} + +/** @brief Sets the densities of species species according to the function + * \f$f (x, y, z)\f$. + * + * mode can be one of the following:\n + * SET_DENS_OVERWRITE: Set the dens to f(x, y, x), ignoring what was there + * before.\n + * SET_DENS_ADD: Adds f to the former density.\n + * SET_DENS_SUB: Substracts f from the former density.\n + */ +void +cdr_set_dens (cdr_grid_t *cdr, int species, int mode, double factor, + double (*f) (double, double, double)) +{ + int ir, iz, itheta; + double ctheta, stheta, x, y; + debug (2, "cdr_set_dens (" grid_printf_str ", %s, ...)\n", + grid_printf_args(cdr), spec_index[species]->name); + +#pragma omp parallel private(ir, iz, ctheta, stheta, x, y) + { +#pragma omp for + iter_grid_theta_n (cdr, itheta, 2) { + //sincos (theta_at(itheta), &stheta, &ctheta); + stheta=sin(theta_at(itheta)); + ctheta=cos(theta_at(itheta)); + iter_grid_r_n(cdr, ir, 2) { + x = r_at(ir, cdr->level) * ctheta; + y = r_at(ir, cdr->level) * stheta; + iter_grid_z_n(cdr, iz, 2) { + switch (mode) { + case SET_DENS_OVERWRITE: + *RZTP(cdr->dens[species], ir, iz, itheta) = + factor * f (x, y, z_at(iz, cdr->level)); + break; + case SET_DENS_ADD: + *RZTP(cdr->dens[species], ir, iz, itheta) += + factor * f (x, y, z_at(iz, cdr->level)); + break; + case SET_DENS_SUB: + *RZTP(cdr->dens[species], ir, iz, itheta) -= + factor * f (x, y, z_at(iz, cdr->level)); + break; + } + } + } + } + } +} + +/** @brief Returns 1.0 */ +double f_one(double x, double y, double z) +{ + return 1.0; +} + +/** @brief Inits the densities of all species. */ +void +cdr_init_dens (cdr_grid_t *cdr) +{ + int cnt; + + debug (2, "cdr_init_dens (" grid_printf_str ")\n", + grid_printf_args(cdr)); + + for (cnt = 0; cnt < no_species; cnt++) + { + cdr_set_dens(cdr, cnt, SET_DENS_OVERWRITE, 0.0, f_one); + } + + for (cnt = 0; cnt < no_seed; cnt++) + { + curr_seed = cnt; + if (seed_index[cnt]->type == 0) + cdr_set_dens(cdr, seed_index[cnt]->species, SET_DENS_ADD, seed_index[cnt]->value, gauss2_xyz); + if (seed_index[cnt]->type == 1) + cdr_set_dens(cdr, seed_index[cnt]->species, SET_DENS_ADD, seed_index[cnt]->value, f_one); + } +} + +/** @brief Initializes the densities allocating a new grid family.*/ +cdr_grid_t* +cdr_scratch_init (void) +{ + cdr_grid_t *cdr; + + cdr = cdr_new_3d_a (0, 0, gridpoints_r, gridpoints_z, max_ntheta); + + cdr->level = 0; + cdr->ext_bound = BND_MASK_ALL; + cdr->contains_edge = TRUE; + + cdr_init_dens (cdr); + cdr_refine_r (cdr, NULL); + + if (perturb_epsilon > 0.0 && max_ntheta > 1) { + dft_dens_perturb_r (cdr, electrons, NULL); + + /* Maybe the perturbation has messed up the boundary conditions, so we + * have to repair them. + */ + cdr_set_ext_bnd_r (cdr); + cdr_set_periodic_r (cdr); + } + return cdr; +} + +/** @brief Dumps all the contents of the given grid into filenames given by + * prefix and name + */ +void +cdr_dump (cdr_grid_t *grid, const char *prefix, const char *name) +{ + char *fname; + int s, nt; + + int m = cdr_output_margin; + + /* To make it easier to produce plots in theta, we save one extra + * theta that has to give the same data as the first one. Except if + * we are working in 2D, where anyway we have only one possible theta (0) + */ + nt = grid->ntheta == 1? 1: grid->ntheta + 1; + + +#pragma omp parallel sections private(fname) + { +#pragma omp section + { + asprintf (&fname, "%s/r.%s.tsv", prefix, name); + rz_axis_dump (fname, grid->r0 - m, grid->r1 + m, dr[grid->level]); + free (fname); + } +#pragma omp section + { + asprintf (&fname, "%s/z.%s.tsv", prefix, name); + rz_axis_dump (fname, grid->z0 - m , grid->z1 + m, dz[grid->level]); + free (fname); + } +#pragma omp section + { + /* In all this function we use ntheta + 1 to make matlab's life easier. + * Note that some of these variables have not been made periodic + * and hence the value for ntheta may be undefined. + */ + asprintf (&fname, "%s/theta.%s.tsv", prefix, name); + rz_axis_dump (fname, 0, nt, dtheta); + free (fname); + } +#pragma omp section + { + asprintf (&fname, "%s/charge.%s.tsv", prefix, name); + rz_dump_3d (grid->charge, fname, "w", grid->r0 - m, grid->z0 - m, + grid->r1 + m, grid->z1 + m, nt); + free (fname); + } +#pragma omp section + { + asprintf (&fname, "%s/er.%s.tsv", prefix, name); + rz_dump_3d (grid->er, fname, "w", grid->r0 - m, grid->z0 - m, + grid->r1 + m, grid->z1 + m, nt); + free (fname); + } +#pragma omp section + { + asprintf (&fname, "%s/ez.%s.tsv", prefix, name); + rz_dump_3d (grid->ez, fname, "w", grid->r0 - m, grid->z0 - m, + grid->r1 + m, grid->z1 + m, nt); + free (fname); + } +#pragma omp section + { + asprintf (&fname, "%s/etheta.%s.tsv", prefix, name); + rz_dump_3d (grid->etheta, fname, "w", grid->r0 - m, grid->z0 - m, + grid->r1 + m, grid->z1 + m, nt); + free (fname); + } + +#pragma omp section + { + asprintf (&fname, "%s/eabs.%s.tsv", prefix, name); + rz_dump_3d (grid->eabs, fname, "w", grid->r0 - m, grid->z0 - m, + grid->r1 + m, grid->z1 + m, nt); + free (fname); + } + +#pragma omp section + { + if (has_photoionization) { + asprintf (&fname, "%s/photo.%s.tsv", prefix, name); + rz_dump_3d (grid->photo, fname, "w", grid->r0 - m, grid->z0 - m, + grid->r1 + m, grid->z1 + m, nt); + free (fname); + } + } + +#pragma omp section + { + for (s = 0; s < no_species; s++) { + /* The densities */ + asprintf (&fname, "%s/%s.%s.tsv", prefix, spec_index[s]->name, name); + rz_dump_3d (grid->dens[s], fname, "w", grid->r0 - m, grid->z0 - m, + grid->r1 + m, grid->z1 + m, nt); + free (fname); + + /* ...and their derivatives. */ + asprintf (&fname, "%s/d_%s.%s.tsv", prefix, spec_index[s]->name, name); + rz_dump_3d (grid->d_dens[s], fname, "w", grid->r0 - m, grid->z0 - m, + grid->r1 + m, grid->z1 + m, nt); + free (fname); + } + } + } +} + +/** @brief Dumps all the contents of the given grid into filenames given by + * @a prefix and @a name. + * + * It also writes in tree.NAME.dat the tree structure of grid, in a format + * appropiate for cdr_load_tree to understand. + + @a infp has to be NULL when called from outside. + + The format of a tree.NAME.dat is as follows. Each line is composed + by a "command" and some parameters. the "commands" can be + + * time + parameter: sim_time + Writes the current simulation time, as received in sim_time + + * open + parameters: gridname r0 z0 r1 z1 level ext_bound margin + + Reads the densities from the files given by gridname, with + the corresponding values of the grid parameters. Leaves the grid + open to add childrens to it. Those children will be all the grids + read until the grid is closed. + + * close + parameters: gridname + + Closes the latest opened grid. All subsequent grids will be regarded + as brothers of gridname. + */ +void +cdr_dump_r (cdr_grid_t *grid, const char *prefix, const char *name, + FILE *infp, double sim_time) +{ + cdr_grid_t *child; + char *cname; + int i, nchilds; + char codes[] = "abcdefghijklmnopqrstuvwxyz"; + FILE *fp; + + if (NULL == infp) { + /* Root call */ + asprintf (&cname, "%s/tree.%s.dat", prefix, name); + fp = fopen (cname, "w"); + if (NULL == fp) { + fatal ("Could not open file %s/tree.%s.dat to write\n", + prefix, name); + } + free (cname); + fprintf (fp, "time %g\n", sim_time); + } else { + fp = infp; + } + + /* We want to be sure that the charge that we plot is actually the + * charge and not its Fourier transform. + */ + cdr_calc_charge_r (grid); + + fprintf (fp, "open %s %d %d %d %d %d %d %d\n", name, grid->r0, grid->z0, + grid->r1, grid->z1, grid->level, grid->ext_bound, + cdr_output_margin); + + cdr_dump (grid, prefix, name); + + nchilds = grid_howmany_children ((grid_t *) grid); + + for (i = 0; i < nchilds; i++) { + child = (cdr_grid_t *) grid_get_child ((grid_t*) grid, nchilds - i - 1); + + assert (NULL != child); + + if (i > sizeof(codes) - 2) + asprintf (&cname, "%s{%d}", name, i); + else + asprintf (&cname, "%s%c", name, codes[i]); + + cdr_dump_r (child, prefix, cname, fp, sim_time); + free (cname); + } + + fprintf (fp, "close %s\n", name); + + if (NULL == infp) { + /* Root call */ + fclose (fp); + } +} + +/** @brief Reads the data format produced by cdr_dump_r and creates a complete + * tree from it. + * + * This function is really quick-and-dirty: one should check the fscanfs + * and do everything cleanlier. + */ +cdr_grid_t * +cdr_load_tree_r (const char *prefix, const char *name, FILE *infp) +{ + char command[16], gridname[32], *fname; + int r0, z0, r1, z1, level, ext_bound, margin, nt, s; + int open_close; + cdr_grid_t *grid = NULL, *leaf; + FILE *fp; + + debug (2, "cdr_load_tree_r (prefix = \"%s\", name = \"%s\", ...)\n", + prefix, name); + + nt = max_ntheta == 1? 1: max_ntheta + 1; + + if (NULL == infp) { + asprintf (&fname, "%s/tree.%s.dat", prefix, name); + fp = fopen (fname, "r"); + if (NULL == fp) { + fatal ("Could not open file %s/tree.%s.dat to read\n", + prefix, name); + } + free (fname); + } else { + fp = infp; + } + + do { + fscanf (fp, "%15s %15s", command, gridname); + open_close = TRUE; + + /* We analyze some commands that do not create/close grids, now + * restricted to set time. + */ + if (0 == strcmp (command, "time")) { + double new_time; + sscanf (gridname, "%lf\n", &new_time); + warning ("Starting time [%f] was read from %s/tree.%s.dat\n", + new_time, prefix, name); + + start_t = new_time; + open_close = FALSE; + } + } while (!open_close); + + if (0 == strcmp (command, "open")) { + debug (3, "opening %s\n", gridname); + + fscanf (fp, "%d %d %d %d %d %d %d\n", + &r0, &z0, &r1, &z1, &level, &ext_bound, &margin); + + grid = cdr_new_3d_a (r0, z0, r1, z1, max_ntheta); + grid->ext_bound = ext_bound; + grid->level = level; + + for (s = 0; s < no_species; s++) { + /* The densities */ + asprintf (&fname, "%s/%s.%s.tsv", prefix, spec_index[s]->name, gridname); + debug (3, "Loading %s\n", fname); + rz_dump_3d (grid->dens[s], fname, "r", + grid->r0 - margin, grid->z0 - margin, + grid->r1 + margin, grid->z1 + margin, nt); + free (fname); + } + + do { + leaf = cdr_load_tree_r (prefix, name, fp); + if (NULL != leaf) { + assert (leaf->level == grid->level + 1); + add_child (grid, leaf); + } + + } while (NULL != leaf); + } else if (0 == strcmp (command, "close")) { + debug (3, "closing %s\n", gridname); + grid = NULL; + } + + if (NULL == infp) { + fclose (fp); + } + return grid; +} + +/** @brief Given a grid family, writes in the file named @a fname the + * coordinates of the frames that define the grid and his descendants. + */ +void +cdr_dump_frames (cdr_grid_t *grid, const char *prefix, const char *name) +{ + FILE *fp; + char *fname; + + asprintf (&fname, "%s/frames.%s.tsv", prefix, name); + fp = fopen (fname, "w"); + free (fname); + + if (fp == NULL) { + warning ("Unable to open %s\n", fname); + return; + } + aux_dump_frames_r (grid, fp); + + fclose (fp); +} + +/** @brief aux_dump_frames_r QQQQ */ +void +aux_dump_frames_r (cdr_grid_t *grid, FILE *fp) +{ + cdr_grid_t *child; + int level; + + level = grid->level; + + fprintf (fp, "%g %g %g %g %d\n", + er_r_at (grid->r0 - 1, level), ez_z_at (grid->z0 - 1, level), + er_r_at (grid->r1 - 1, level), ez_z_at (grid->z1 - 1, level), + level); + + iter_childs(grid, child) { + aux_dump_frames_r (child, fp); + } +} diff --git a/src/configuration.c b/src/configuration.c new file mode 100644 index 0000000000000000000000000000000000000000..b740bf6893c3c16268593792d5de7b1b3a190dd9 --- /dev/null +++ b/src/configuration.c @@ -0,0 +1,847 @@ +/** @file configuration.c + * @brief Module for input/output of parameters + */ +/* ---------------------------------------------------------------------------- + libconfig - A library for processing structured configuration files + Copyright (C) 2005-2010 Mark A Lindner + + This file is part of libconfig. + + This library is free software; you can redistribute it and/or + modify it under the terms of the GNU Lesser General Public License + as published by the Free Software Foundation; either version 2.1 of + the License, or (at your option) any later version. + + This library is distributed in the hope that it will be useful, but + WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU + Lesser General Public License for more details. + + You should have received a copy of the GNU Library General Public + License along with this library; if not, see + . + ---------------------------------------------------------------------------- +*/ + +#include +#include +#include +#include +#include + +#include +#include +#include +#include +#include + +/** @brief Looks in a libconfig file *.cfg for a parameter of type 'int', with + * name 'sstring' and add its value to the global variable with the same name. + * If already initialized, its value will be overwritten. + * + * @param[in] name name of the parameter (see e.g., input file default.cfg) + * @param[in] type type of parameter (see e.g., input file default.cfg) + * @param[in] comment comment to be added (see e.g., input file default.cfg) + * @param[in] sstring name to be found + * @param[out] *par global 'int' variable named 'name'; + * on return *par will have value 'value' + * @param[in] value of type 'int' + * @param[in] count number of elements in array 'parameter_names' to examine + * @param[in] *change if TRUE then value in setting_default will be changed + * @param[in] setting_default related to default configuration file + * @param[out] i position in global array 'parameter_names' + * defined in configuration.h + * + */ +bool +change_cfg_integer(const char* name, + const char *type, + const char *comment, + const char *sstring, + int *par, + int value, + int count, + bool *change, + config_setting_t *setting_default, + int i) +{ + int j; + config_setting_t *elem,*setting_value,*setting_comment; + + if(!(strncmp(name,sstring,COMPARE_LIMIT))) { + if(!(strncmp(type,"int",COMPARE_LIMIT))) { + *par = value; + if(change) { + /* Find the corresponding index in the file default.cfg */ + for(j=0; j You should use something smaller. + */ + if(change_cfg_integer (name,type,comment,"max_disk_space_mb",&max_disk_space_mb,ivalue,count,change,setting,ii)) + return; + + /************************ + * Numerical parameters * + ************************/ + + /* Number of gridpoints in r direction at level 0. */ + if(change_cfg_integer (name,type,comment,"gridpoints_r",&gridpoints_r,ivalue,count,change,setting,ii)) + return; + + /* Number of gridpoints in z direction at level 0. */ + if(change_cfg_integer (name,type,comment,"gridpoints_z",&gridpoints_z,ivalue,count,change,setting,ii)) + return; + + /* Number of azimuthal modes. */ + if(change_cfg_integer (name,type,comment,"max_ntheta",&max_ntheta,ivalue,count,change,setting,ii)) + return; + + /* Initial time may be away from 0 */ + if(change_cfg_double(name,type,comment,"start_t",&start_t,dvalue,count,change,setting,ii)) + return; + + /* End time of simulation, originally 500.0 */ + if(change_cfg_double(name,type,comment,"end_t",&end_t,dvalue,count,change,setting,ii)) + return; + + /* The actual timestep may be smaller that this one, if it is needed + * to satisfy the Courant constraint. + */ + if(change_cfg_double(name,type,comment,"attempt_dt",&attempt_dt,dvalue,count,change,setting,ii)) + return; + + /* Number of levels that are used for the Poisson equation + * but NOT for the cdr integrator. + */ + if(change_cfg_integer (name,type,comment,"extra_pois_levels",&extra_pois_levels,ivalue,count,change,setting,ii)) + return; + + /* Maximum nesting depth */ + if(change_cfg_integer (name,type,comment,"max_levels",&max_levels,ivalue,count,change,setting,ii)) + return; + + /* Total number of species */ + if(change_cfg_integer (name,type,comment,"no_species",&no_species,ivalue,count,change,setting,ii)) + return; + + /* Maximum error allowed in the Poisson solver. + * Cells with larger errors will be further refined. + */ + if(change_cfg_double(name,type,comment,"pois_max_error",&pois_max_error,dvalue,count,change,setting,ii)) + return; + + /* Maximum refinement level for the Poisson solver. */ + if(change_cfg_integer(name,type,comment,"pois_max_level",&pois_max_level,ivalue,count,change,setting,ii)) + return; + + /* These are photo-ionization parameters equivalent to the Poisson ones. + * If extra_photo_levels < 0, then these parameters are ignored and the + * poisson-parameters are used. If extra_photo_levels_2 < 0 then the + * parameters for the second term are ignored and the parameters for the + * first term are used for both terms. + */ + + /* First photo-ionization term */ + if(change_cfg_integer (name,type,comment,"extra_photo_levels",&extra_photo_levels,ivalue,count,change,setting,ii)) + return; + + /* Maximum level of refinement in the photo-ionization solver.*/ + if(change_cfg_integer (name,type,comment,"photo_max_level",&photo_max_level,ivalue,count,change,setting,ii)) + return; + + /* Error threshold that leads to refinement in the photo-ionization code. */ + if(change_cfg_double(name,type,comment,"photo_max_error",&photo_max_error,dvalue,count,change,setting,ii)) + return; + + /* Photo-ionization boundary condition at r = L_r + * 1 means homogeneous Neumann boundary conditions + * -1 means homogeneous Dirichlet boundary conditions. + */ + if(change_cfg_integer(name,type,comment,"photo_bnd_right" ,&photo_bnd_right ,ivalue,count,change,setting,ii)) + return; + + if(change_cfg_integer(name,type,comment,"photo_bnd_bottom",&photo_bnd_bottom,ivalue,count,change,setting,ii)) + return; + + if(change_cfg_integer(name,type,comment,"photo_bnd_top" ,&photo_bnd_top ,ivalue,count,change,setting,ii)) + return; + + + /* Second photo-ionization term: Extra levels for the photo-ionization solver. */ + if(change_cfg_integer(name,type,comment,"extra_photo_levels_2",&extra_photo_levels_2,ivalue,count,change,setting,ii)) + return; + + /* Maximum level of refinement in the photo-ionization solver.*/ + if(change_cfg_integer(name,type,comment,"photo_max_level_2",&photo_max_level_2,ivalue,count,change,setting,ii)) + return; + + + /* Error threshold that leads to refinement in the photo-ionization code.*/ + if(change_cfg_double(name,type,comment,"photo_max_error_2",&photo_max_error_2,dvalue,count,change,setting,ii)) + return; + + /* Photo-ionization boundary condition at r = L_r. + * 1 for homogeneous Neumann, + * -1 for homogeneous Dirichlet + */ + if(change_cfg_integer(name,type,comment,"photo_bnd_right_2",&photo_bnd_right_2,ivalue,count,change,setting,ii)) + return; + + /* Photo-ionization boundary condition at z = 0. + * 1 for homogeneous Neumann, + * -1 for homogeneous Dirichlet + */ + if(change_cfg_integer(name,type,comment,"photo_bnd_bottom_2",&photo_bnd_bottom_2,ivalue,count,change,setting,ii)) + return; + + /* Photo-ionization boundary condition at z = L_z. + * 1 for homogeneous Neumann, + * -1 for homogeneous Dirichlet + */ + if(change_cfg_integer(name,type,comment,"photo_bnd_top_2",&photo_bnd_top_2,ivalue,count,change,setting,ii)) + return; + + /* Boundary conditions for the CDR system. */ + if(change_cfg_integer(name,type,comment,"cdr_bnd_bottom",&cdr_bnd_bottom,ivalue,count,change,setting,ii)) + return; + + if(change_cfg_integer(name,type,comment,"cdr_bnd_top",&cdr_bnd_top,ivalue,count,change,setting,ii)) + return; + + if(change_cfg_integer(name,type,comment,"cdr_bnd_right",&cdr_bnd_right,ivalue,count,change,setting,ii)) + return; + + if(change_cfg_integer(name,type,comment,"pois_bnd_right",&pois_bnd_right,ivalue,count,change,setting,ii)) + return; + + if(change_cfg_integer(name,type,comment,"pois_bnd_bottom",&pois_bnd_bottom,ivalue,count,change,setting,ii)) + return; + + if(change_cfg_integer(name,type,comment,"pois_bnd_top",&pois_bnd_top,ivalue,count,change,setting,ii)) + return; + + /* Courant numbers. */ + if(change_cfg_double(name,type,comment,"nu_a",&nu_a,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"nu_d",&nu_d,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"nu_rt",&nu_rt,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"nu_f",&nu_f,dvalue,count,change,setting,ii)) + return; + + /* Refinement criteria for the CDR equation. */ + if(change_cfg_double(name,type,comment,"ref_threshold_eabs",&ref_threshold_eabs,dvalue,count,change,setting,ii)) + return; + + /* Refinement criteria for the CDR equation. */ + if(change_cfg_integer(name,type,comment,"ref_level_eabs",&ref_level_eabs,ivalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"ref_threshold_charge",&ref_threshold_charge,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"ref_threshold_dens",&ref_threshold_dens,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"ref_threshold_edge",&ref_threshold_edge,dvalue,count,change,setting,ii)) + return; + + /* r- and z-length of the minimal refinement area in the cdr equation*/ + if(change_cfg_integer(name,type,comment,"cdr_brick_dr",&cdr_brick_dr,ivalue,count,change,setting,ii)) + return; + + if(change_cfg_integer(name,type,comment,"cdr_brick_dz",&cdr_brick_dz,ivalue,count,change,setting,ii)) + return; + + /* Maximum refinement level for the cdr solver. */ + if(change_cfg_integer(name,type,comment,"cdr_max_level",&cdr_max_level,ivalue,count,change,setting,ii)) + return; + + /* Interpolation method. */ + if(change_cfg_integer(name,type,comment,"cdr_interp_in",&cdr_interp_in,ivalue,count,change,setting,ii)) + return; + + if(change_cfg_integer(name,type,comment,"cdr_interp_bnd",&cdr_interp_bnd,ivalue,count,change,setting,ii)) + return; + + /*********************** + * Physical parameters * + ***********************/ + if(change_cfg_double(name,type,comment,"L_r",&L_r,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"L_z",&L_z,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"diffusion_coeff",&diffusion_coeff,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"attachment_rate",&attachment_rate,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"attachment_E0",&attachment_E0,dvalue,count,change,setting,ii)) + return; + + /* Constant external electric field. */ + if(change_cfg_double(name,type,comment,"E0_x",&E0_x,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"E0_y",&E0_y,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"E0_z",&E0_z,dvalue,count,change,setting,ii)) + return; + + /* Constant external electric field. */ + if(change_cfg_double(name,type,comment,"rise_time",&rise_time,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"off_time",&off_time,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_integer(name,type,comment,"has_photoionization",&has_photoionization,ivalue,count,change,setting,ii)) + return; + + /* Width of the initial seed in x-, y- and z-direction */ + if(change_cfg_double(name,type,comment,"seed_sigma_x",&seed_sigma_x,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"seed_sigma_y",&seed_sigma_y,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"seed_sigma_z",&seed_sigma_z,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"seed_N",&seed_N,dvalue,count,change,setting,ii)) + return; + + /* Initial background ionization */ + if(change_cfg_double(name,type,comment,"background_ionization",&background_ionization,dvalue,count,change,setting,ii)) + return; + + /* Length of exponential increase of the pre-ionization for atmospherical + * models + */ + if(change_cfg_double(name,type,comment,"background_increase_length",&background_increase_length, + dvalue,count,change,setting,ii)) + return; + + /* Use the point-plane geometry? */ + if(change_cfg_integer(name,type,comment,"pois_inhom",&pois_inhom,ivalue,count,change,setting,ii)) + return; + + /* Number of mirror charges to use*/ + if(change_cfg_integer(name,type,comment,"pois_inhom_reflections",&pois_inhom_reflections,ivalue,count,change,setting,ii)) + return; + + /* Length of the needle */ + if(change_cfg_double(name,type,comment,"needle_length",&needle_length,dvalue,count,change,setting,ii)) + return; + + /* Radius of the needle */ + if(change_cfg_double(name,type,comment,"needle_radius",&needle_radius,dvalue,count,change,setting,ii)) + return; + + /* If nonzero, the charge is fixed, not floating + * Simulation of charged clouds close to the earth surface. + */ + if(change_cfg_double(name,type,comment,"pois_inhom_fixed_q",&pois_inhom_fixed_q,dvalue,count,change,setting,ii)) + return; + + /* Constant ionization rate. */ + if(change_cfg_double(name,type,comment,"constant_source",&constant_source,dvalue,count,change,setting,ii)) + return; + + /* Random perturbations for stability analysis. */ + if(change_cfg_double(name,type,comment,"perturb_epsilon",&perturb_epsilon,dvalue,count,change,setting,ii)) + return; + + /* Perturb only modes up to perturb_max_k, i.e. large number to perturb all */ + if(change_cfg_integer(name,type,comment,"perturb_max_k",&perturb_max_k,ivalue,count,change,setting,ii)) + return; + + /****************** + * Sprites module * + ******************/ + if(change_cfg_integer(name,type,comment,"sprite_module",&sprite_module,ivalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"dens_decay_len",&dens_decay_len,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"sprite_dens_0",&sprite_dens_0,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_double(name,type,comment,"sprite_dens_q",&sprite_dens_q,dvalue,count,change,setting,ii)) + return; + + if(change_cfg_integer(name,type,comment,"sprite_sign",&sprite_sign,ivalue,count,change,setting,ii)) + return; + +} + +/* @brief Read just one parameter from configuration file connected + * to setting2. + * + * In case setting1 and setting2 are different then + * the value in setting1 will be overwritten by the value of setting2. + * + * In case setting1 and setting2 are the same then + * the value in setting1 will be added. + * + * @param[in] config_setting_t *setting1 represents s configuration setting + * @param[in] config_setting_t *setting2 represents s configuration setting + * @param[in] ii position in array 'parameter_names' + * @param[in] count number of elements in parameter array to examine + * @param[in] *change if TRUE then value in setting_default will be changed + * + */ +bool +read_parameter(config_setting_t *setting1, + config_setting_t *setting2, + int ii, + int count, + bool *change) +{ + const char *type,*name,*comment; + double dvalue; + int ivalue; + int bbool; + const char* astring; + config_setting_t *elem = config_setting_get_elem(setting2,ii); + + /* Only output the record if all of the expected fields are present. */ + if(config_setting_lookup_string(elem, "type", &type) && + config_setting_lookup_string(elem, "name", &name) && + config_setting_lookup_string(elem, "comment",&comment) && + (config_setting_lookup_float (elem,"value", &dvalue) || + config_setting_lookup_int (elem,"value", &ivalue) || + config_setting_lookup_bool (elem,"value", &bbool ) || + config_setting_lookup_string(elem,"value", &astring)) + ) { + printf("\n# %s\n",comment); + if(!(strncmp(type,"string",COMPARE_LIMIT))) + printf("(%s) %s=%s\n",type,name,astring); + if(!(strncmp(type,"double",COMPARE_LIMIT))) + printf("(%s) %s=%g\n",type,name,dvalue); + if(!(strncmp(type,"int",COMPARE_LIMIT))) + printf("(%s) %s=%i\n",type,name,ivalue); + if(!(strncmp(type,"bool",COMPARE_LIMIT))) + printf("(%s) %s=%i\n",type,name,bbool); + } else { + printf("read_parameter: type is no string, double, int or bool but something else\n"); + return(FALSE); + } + + change_cfg_parameters(name,type,comment,ii,ivalue,dvalue,bbool,astring, + setting1,count,change); + return(TRUE); +} + +/* @brief Reads the specifications of specie number 'ii' in the configuration + * file related to *setting. Initializes the fields of *temp_s. + * + * @param[in] *setting Of type config_setting_t. It represents a configuration + * setting + * @param[in] ii position in global 'parameter_names' array + * @param[out] *temp_s Of type 'species_t'. Its fields will be initialized + * with values "name","mass" and "charge" read + * from setting connected to configuration file + */ +bool +read_specie(config_setting_t *setting, + int ii, + species_t *temp_s) +{ + config_setting_t *elem = config_setting_get_elem(setting,ii); + + /* Only output the record if all of the expected fields are present. */ + if (!(config_setting_lookup_string(elem,"name",&temp_s->name) && + config_setting_lookup_float (elem,"mass",&temp_s->mass) && + config_setting_lookup_float (elem,"charge",&temp_s->charge))) + { + printf("wrong types in kinetic file for species\n"); + return(FALSE); + } + return(TRUE); +} + +/* @brief Read the specifications of seed number 'ii' in the configuration + * file related to *setting. Initialize *temp_se. + * + * @param[in] *setting of type config_setting_t. It represents a configuration + * setting + * @param[in] ii position in global array '*seed_index' + * @param[out] *temp_se of type 'seed_t' describing a seed + */ +bool +read_seed(config_setting_t *setting, + int ii, + seed_t *temp_se) +{ + config_setting_t *elem = config_setting_get_elem(setting,ii); + + /* Only output the record if all of the expected fields are present. */ + if (!(config_setting_lookup_string(elem,"species",&temp_se->kind_species) && + config_setting_lookup_float (elem,"value",&temp_se->value) && + config_setting_lookup_string(elem,"type",&temp_se->kind_type))) + { + printf("wrong types in kinetic file for seed: species,value or type\n"); + return(FALSE); + } + + /* Find the position in the species-array of a given species */ + temp_se->species = find_species_by_name(temp_se->kind_species); + + /* Translate string 'kind_type' into integer value, + * temp_se->type = -1 denotes unknown */ + if (strcmp(temp_se->kind_type,"gaussian") == 0) + temp_se->type = 0; + else if (strcmp(temp_se->kind_type,"constant") == 0) + temp_se->type = 1; + else + temp_se->type = -1; + + if (!(config_setting_lookup_float(elem,"x0",&temp_se->x0))) + { temp_se->x0=0.0; } + if (!(config_setting_lookup_float(elem,"y0",&temp_se->y0))) + { temp_se->y0=0.0; } + if (!(config_setting_lookup_float(elem,"z0",&temp_se->z0))) + { temp_se->z0=0.0; } + + if (!(config_setting_lookup_float (elem,"sigma_x",&temp_se->sigma_x))) + { temp_se->sigma_x=0.0; } + if (!(config_setting_lookup_float(elem,"sigma_y",&temp_se->sigma_y))) + { temp_se->sigma_y=0.0; } + if (!(config_setting_lookup_float(elem,"sigma_z",&temp_se->sigma_z))) + { temp_se->sigma_z=0.0; } + + return(TRUE); +} + +/* @brief Read the specifications of reaction number 'ii' in the configuration + * file related to *setting. Initialize *temp_r. + * + * @param[in] *setting of type config_setting_t. It represents a configuration + * setting + * @param[in] ii position in global array '*reaction_index' + * @param[out] *temp_r of type 'reaction_t' describing a reaction + */ +bool +read_reaction(config_setting_t *setting, + int ii, + reaction_t *temp_r) +{ + config_setting_t *elem = config_setting_get_elem(setting,ii); + const char *table; + const char *error; + int cnt; + + /* Only output the record if fields nin and nout are present. */ + if (!(config_setting_lookup_string(elem,"reacttable",&table))) + { + printf("wrong types in kinetic file for reaction.reacttable\n"); + return(FALSE); + } else + temp_r->tablefile = (char *) table; + + /* Only output the record if fields nin and nout are present. */ + if (!(config_setting_lookup_int(elem,"nin",&temp_r->nin) && + config_setting_lookup_int(elem,"nout",&temp_r->nout))) + { + printf("wrong types in kinetic file for reactions\n"); + return(FALSE); + } + + error="not_init"; + for(cnt = 0; cnt < REACTION_MAX_IN; ++cnt) { + temp_r->input[cnt] = -1; + temp_r->inname[cnt]=error; + } + + config_setting_lookup_string(elem,"specin0",&temp_r->inname[0]); + config_setting_lookup_string(elem,"specin1",&temp_r->inname[1]); + config_setting_lookup_string(elem,"specin2",&temp_r->inname[2]); + config_setting_lookup_string(elem,"specin3",&temp_r->inname[3]); + + /* Find the position in the species-array of a given species */ + for(cnt = 0; cnt < temp_r->nin; cnt++) { + if(strcmp(temp_r->inname[cnt],error)==0) + { + printf("NOT all reaction.specin initialized for reaction %d and specie %d\n",ii,cnt); + exit(1); + } + else + temp_r->input[cnt] = find_species_by_name(temp_r->inname[cnt]); + } + + for(cnt = 0; cnt < REACTION_MAX_OUT; ++cnt) { + temp_r->output[cnt] = -1; + temp_r->outname[cnt]=error; + } + + config_setting_lookup_string(elem,"specout0",&temp_r->outname[0]); + config_setting_lookup_string(elem,"specout1",&temp_r->outname[1]); + config_setting_lookup_string(elem,"specout2",&temp_r->outname[2]); + config_setting_lookup_string(elem,"specout3",&temp_r->outname[3]); + config_setting_lookup_string(elem,"specout4",&temp_r->outname[4]); + config_setting_lookup_string(elem,"specout5",&temp_r->outname[5]); + + /* Find the position in the species-array of a given species */ + for(cnt = 0; cnt < temp_r->nout; cnt++) { + if(strcmp(temp_r->outname[cnt],error)==0) + { + debug(1,"temp_r->outname[%d]=%s; error=%s\n",cnt,temp_r->outname[cnt],error); + printf("NOT all reaction.specout initialized for reaction %d and specie %d\n",ii,cnt); + exit(1); + } + else + temp_r->output[cnt] = find_species_by_name(temp_r->outname[cnt]); + } + + return(TRUE); +} diff --git a/src/cstream.c b/src/cstream.c new file mode 100644 index 0000000000000000000000000000000000000000..a91857f6f1f259caec51311a251ff219b8d0d030 --- /dev/null +++ b/src/cstream.c @@ -0,0 +1,459 @@ +/** @file cstream.c + * @brief General initialization/termination functions. + */ + +#include +#include +#include +#include +#define ALLOC_PARAMS + +#include "cstream.h" +#include "parameters.h" +#include "proto.h" +#include "species.h" + +double E_x, E_y, E_z; +/**< For time-dependent electric fields E_x, E_y, E_z there is a difference between + E0 (the highest field) and E (the field at a given time). */ + +extern double pois_inhom_fixed_q_t; +/**< The same is true for time-dependent fixed charges (useful to model + the charging of a cloud in modeling sprites. */ + +double *dr, *dz, dtheta; +/**< dr[i] and dz[i] represent the grid size at level @a i. Note that + @a i can go from -extra_pois_levels...max_levels. */ +double *dr_start, *dz_start; + +double *w2k, *wk; +/**< w2k[k] = 2 / dtheta^2 (1 - cos(k dtheta)). This numbers appear due to the + finite-differences derivatives of a Fourier transform. If we would make + a continuous fourier transform, they will approach k^2. +*/ + + +char *invok_name = "cstream"; +/**< Name of this program. */ + +const double twopi = 6.283185307179586477L; +/**< \f$ 2 \times \pi \f$. */ + +const double invfourpi = 0.079577471545947667884441882L; +/**< \f$ 1 / (4 \pi )\f$ */ + +const double invpi32 = 0.179587122125166561689081L; +/**< \f$ 1 / (\pi ^ {3/2} )\f$ */ + +/** @brief Initializes the parameters. + * + * The global parameters will get their default values. + * These values correspond with the values in input/defaults.cfg + */ +void +init_parameters(void) +{ + debug (1, "entry init_parameters\n"); + /* An identification name for this run */ + prog_id = "example"; + + /* Output directory. */ + output_dir = "output/"; + + /* Kinetics input file */ + kin_input = "input/kinetic_example.cfg"; + + /* If restart is TRUE, the simulation will continue with data from a previous run */ + restart = 0; + + /* If restart is TRUE, the name of the file with data from previous run, otherwise empty */ + load_file = ""; + + /* Time interval for output to be written to disk */ + output_dt = 0.100; + + /* Output of the Poisson grids, including the potential? */ + pois_output = 0; + + /* Margin outside the grids in the output of the cdr equation */ + cdr_output_margin = 0; + + /* Margin outside the grids in the output of the poisson equation */ + pois_output_margin = 1; + + /* If the time steps are smaller than this number, the program issues a warning */ + warn_min_timestep = 1e-06; + + /* Maximum disk space, in Mb, to use */ + max_disk_space_mb = 1048576; + + /* Number of R and Z gridpoints at level 0 */ + gridpoints_r = 600; + gridpoints_z = 600; + + /* Number of azimuthal gridcells and modes */ + max_ntheta = 1; + + /* Initial and end time */ + start_t = 0.0; + end_t = 0.12; + + /* Attempted timestep. The actual timestep may be larger */ + attempt_dt = 50.0; + + /* Extra levels for the Poisson solver */ + extra_pois_levels = 2; + + /* Maximum level of refinement. Use a big number here */ + max_levels = 64; + + /* Error threshold that leads to refinement in the Poisson code. */ + pois_max_error = 0.001; + + /* Maximum level of refinement in the Poisson equation. */ + pois_max_level = 3; + + /* Extra levels for the photo-ionization solver */ + extra_photo_levels = -1; + + /* Maximum level of refinement in the photo-ionization solver. */ + photo_max_level = 4; + + /* Error threshold that leads to refinement in the photo-ionization code. */ + photo_max_error = 0.01; + + /* Photo-ionization boundary condition at r = L_r, z = 0, z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet */ + photo_bnd_right = -1; + photo_bnd_bottom = -1; + photo_bnd_top = -1; + + /* Extra levels for the photo-ionization solver */ + extra_photo_levels_2 = -1; + + /* Maximum level of refinement in the photo-ionization solver. */ + photo_max_level_2 = 4; + + /* Error threshold that leads to refinement in the photo-ionization code. */ + photo_max_error_2 = 0.01; + + /* Photo-ionization boundary condition at r = L_r, z = 0, z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet */ + photo_bnd_right_2 = -1; + photo_bnd_bottom_2 = -1; + photo_bnd_top_2 = -1; + + /* Particles boundary condition at z = 0, z = L_z, r = L_r. 1 for Hom. Neumann, -1 for Hom. Dirichlet */ + cdr_bnd_bottom = 1; + cdr_bnd_top = 1; + cdr_bnd_right = 1; + + /* Potential boundary condition at r = L_r, z = 0, z = L_z. 1 for Hom. Neumann, -1 for Hom. Dirichlet */ + pois_bnd_right = -1; + pois_bnd_bottom = -1; + pois_bnd_top = -1; + + /* Maximum advection and diffusion Courant number */ + nu_a = 0.2; + nu_d = 0.2; + + /* Maximum ratio of dt/relaxation time */ + nu_rt = 0.2; + + /* Maximum ratio of change of the densities (set to a very large number to ignore) */ + nu_f = 1e+20; + + /* Refinement threshold for the electric field */ + ref_threshold_eabs = 0.2; + + /* Maximum refinement level reached through ref_threshold_eabs */ + ref_level_eabs = 4; + + /* Refinement threshold for the curvature of the charge, densities */ + ref_threshold_charge = 0.004; + ref_threshold_dens = 0.004; + + /* Refinement threshold for the densities in the leading edge */ + ref_threshold_edge = 10000.0; + + /* r-length and z-length of the minimal refinement area in the cdr equation */ + cdr_brick_dr = 8; + cdr_brick_dz = 8; + + /* Maximum level of refinement in the Fluid equation. */ + cdr_max_level = 3; + + /* Interpolation method for the grid interior, and grid boundaries (0=zero_masses, 1=quadratic_masses [default], 2=wackers_masses, 3=quadlog */ + cdr_interp_in = 1; + cdr_interp_bnd = 1; + + /* Length in r and z of the complete domain */ + L_r = 13044.0; + L_z = 13044.0; + + /* Isotropic difussion coefficient */ + diffusion_coeff = 0.1; + + /* Whether the code includes photoionization or not */ + has_photoionization = 1; + + /* The name of a file from which we can read the photoionization parameters */ + photoionization_file = "input/air760torr.photo"; + + /* Rate of dissociative attachment */ + attachment_rate = 0.0; + + /* E0 in the exp(-E0/E) factor in the attachment expression. */ + attachment_E0 = 0.0; + + /* x-, y- and z-component of the external electric field */ + E0_x = 0.0; + E0_y = 0.0; + E0_z = -0.06; + + /* Rise time of the electric field (0 for instantaneous rise) */ + rise_time = 0.0; + + /* Time to switch off the electric field (0.0 means never) */ + off_time = 0.0; + + /* x-, y- and z-width of the initial seed */ + seed_sigma_x = 0.0; + seed_sigma_y = 0.0; + seed_sigma_z = 0.0; + + /* Number of electrons in the initial seed */ + seed_N = 0.0; + + /* Initial at z=0 densities of electrons and ions */ + background_ionization = 0.0; + + /* Length of exponential increase of the pre-ionization (for atmospherical models) */ + background_increase_length = 0.0; + + /* Use the point-plane geometry? */ + pois_inhom = 1; + + /* Number of mirror charges to use */ + pois_inhom_reflections = 4; + + /* Length and radius of the needle */ + needle_length = 2500.0; + needle_radius = 400.0; + + /* If nonzero, the charge is fixed, not floating (simulation of charged clouds close to the earth surface) */ + pois_inhom_fixed_q = 0.0; + + /* Constant ionization rate */ + constant_source = 0.0; + + /* Initial perturbation to the axisymmetric configuration */ + perturb_epsilon = 0.0; + + /* Perturb only modes up to perturb_max_k (large number to perturb all) */ + perturb_max_k = 1024; + + /* 1 if the sprite module is activated, 0 otherwise */ + sprite_module = 0; + + /* Lenght of exponential decay of the density w/r to altitude */ + dens_decay_len = 0.0; + + /* Density at z = 0 */ + sprite_dens_0 = 0.0; + + /* Quenching density */ + sprite_dens_q = 0.0; + + /* Sign of the sprite head that we are following (the other will not be reliable */ + sprite_sign = -1; + debug (1, "exit init_parameters\n"); +} + + int n, i; +/** @brief Initializes the grid sizes. The parameters dr_root and dz_root + * specify the grid size at level 0 (dz_root = dz[0], dr_root[0] = dr[0]) + */ +static void +init_gridsizes_a (void) +{ + int n, i; + double root_dr, root_dz; + + root_dr = L_r / gridpoints_r; + root_dz = L_z / gridpoints_z; + + n = max_levels + extra_pois_levels + 1; + + dr_start = (double *) xmalloc(sizeof(double) * n); + dz_start = (double *) xmalloc(sizeof(double) * n); + + dr = dr_start + extra_pois_levels; + dz = dz_start + extra_pois_levels; + + dr_start[0] = root_dr * (1 << extra_pois_levels); + dz_start[0] = root_dz * (1 << extra_pois_levels); + + for (i = 1; i < n; i++) { + dr_start[i] = dr_start[i - 1] / 2.0; + dz_start[i] = dz_start[i - 1] / 2.0; + + debug (3, "dr[%d] = %e\n", i - extra_pois_levels, + dr[i - extra_pois_levels]); + debug (3, "dz[%d] = %e\n", i - extra_pois_levels, + dz[i - extra_pois_levels]); + } + + dtheta = twopi / max_ntheta; +} + +/** @brief Initializes the vector of wk's for the Helmholtz equation. */ +static void +init_wk_a (void) +{ + int k; + double twobydtheta2; + + debug (2, "init_w2k_a()\n"); + + w2k = (double*) xmalloc (sizeof(double) * max_ntheta); + wk = (double*) xmalloc (sizeof(double) * max_ntheta); + + twobydtheta2 = 2. / (dtheta * dtheta); + + for (k = 0; k < max_ntheta / 2 + (max_ntheta % 2); k++) { + double w2k_ = twobydtheta2 * (1 - cos (k * dtheta)); + double re_wk, im_wk; + + re_wk = (cos (k * dtheta) - 1) / dtheta; + im_wk = sin (k * dtheta) / dtheta; + + wk[k] = re_wk; + w2k[k]= w2k_; + + if (k != 0) { + wk[max_ntheta - k] = im_wk; + w2k[max_ntheta - k] = w2k_; + } + } + + if ((max_ntheta % 2) == 0) { + w2k[max_ntheta / 2] = twobydtheta2 * (1 - cos (k * dtheta)); + wk[max_ntheta / 2] = (cos (k * dtheta) - 1) / dtheta; + } + + assert (wk[0] == 0.); +} + +/** @brief Frees the space allocated for dr and dz. */ +static void +free_gridsizes (void) +{ + free (dr_start); + free (dz_start); +} + +/** @brief Frees the allocated space for \f$ \lambda \f$. */ +static void +free_wk (void) +{ + free (wk); + free (w2k); +} + +/** @brief Here all the initialization calls. */ +void +cstream_init (void) +{ + /* For the perturbations, it is better to start with different seeds at + each run. */ + srand (time (0)); + + init_gridsizes_a (); + init_wk_a (); + react_init (); + cdr_init (); + pois_init (); + photo_init (); + if (has_photoionization) { + printf("Photoionization\n"); + photo_load_file (photoionization_file); + } else { + printf("No photoionization\n"); + } + + if (sprite_module) spr_init (); +} + +/** @brief Here all the cleaning and finishing calls. */ +void +cstream_end (void) +{ + photo_unregister_all (); + free_gridsizes (); + free_wk (); + cdr_end (); +} + + +/** @brief When we use a time-varying external field, we update the field + * components at each timesteps. */ +void +cstream_set_field_at_time (double t) +{ + static int rise_reached = FALSE, off_reached = FALSE; + double factor; + + if (rise_reached && off_reached) + return; + + if (t >= rise_time) { + rise_reached = TRUE; + } + + if (t >= off_time || off_time == 0.0) { + off_reached = TRUE; + } + + /* We make sure that we never use a field _larger_ than E0 and that + if rise_time is 0 we do not calculate t / 0.0. */ + factor = t >= rise_time? 1.0: (t / rise_time); + + factor = (off_time > 0.0 && t >= off_time)? 0.0: factor; + + E_x = factor * E0_x; + E_y = factor * E0_y; + E_z = factor * E0_z; + + if (pois_inhom_fixed_q != 0.0) { + pois_inhom_fixed_q_t = factor * pois_inhom_fixed_q; + } + + return; +} + +/** @brief Functions for a constant external electric field given in (x, y, z) components. */ +double +e0_r (double r, double z, double theta) +{ + return E_x * cos (theta) + E_y * sin (theta); +} + +/** @brief Functions for a constant external electric field given in (x, y, z) components. */ +double +e0_z (double r, double z, double theta) +{ + return E_z; +} + +/** @brief Functions for a constant external electric field given in (x, y, z) components. */ +double +e0_theta (double r, double z, double theta) +{ + return -E_x * cos (theta) + E_y * sin (theta); +} + +/** Initializes the component of the external electric field in \f$r\f$-direction. */ +decl_field_comp(r) = e0_r; +/** Initializes the component of the external electric field in \f$z\f$-direction. */ +decl_field_comp(z) = e0_z; +/** Initializes the component of the external electric field in \f$\theta\f$-direction. */ +decl_field_comp(theta) = e0_theta; diff --git a/src/dft.c b/src/dft.c new file mode 100644 index 0000000000000000000000000000000000000000..c473f78e0ac16a42c2681adc6aa161a7c5f59fce --- /dev/null +++ b/src/dft.c @@ -0,0 +1,373 @@ +/** @file dft.c + * @brief All routines related with discrete fourier transformations. + * + * We make intensive use of the fftw library.\n + * FFTW, the Fastest Fourier Transform in the West, is a collection of fast + * C routines to compute the discrete Fourier transform. + * See http://www.fftw.org/doc/ for the manual documents of FFTW version 3.3.3. + * + * Note: All calls to FFTW should be made here, so + * 1. If we decide to change our FFT library, we only have to make + * changes in this module. + * 2. We can compile a 2d version of the code that does not depend on fftw. + * by eliminating this module. + */ + +#include +#include +#include +#include + +#include + +#include "cdr.h" +#include "cstream.h" +#include "grid.h" +#include "parameters.h" +#include "proto.h" +#include "rz_array.h" +#include "species.h" + +static void renormalize (cdr_grid_t *grid, rz_array_t *var); +static double rnd_gauss (double mu, double sigma); +static double ranf (void); + +/** @brief Transform the discrete fourier transformations ???? */ +void +dft_transform (rz_array_t *in, rz_array_t *out, int sign) +{ + int i; + fftw_plan *plans; + fftw_r2r_kind kind; + + debug (2, "dft_transform (..., sign = %d)\n", sign); + + if (sign > 0) kind = FFTW_R2HC; + else kind = FFTW_HC2R; + + assert(in->dim == 3 && out->dim == 3); + assert(in->ntheta == out->ntheta && in->nr == out->nr && in->nz == out->nz); + + /* Unfortunately, the fftw planning routines are not thread-safe. */ + + /* The +4 here is because we also transform the buffer, which is + useful to easily set boundaries, etc. */ + plans = xmalloc (sizeof (fftw_plan) * (in->nz + 4)); + + for (i = 0; i < in->nz + 4; i++) { + plans[i] = fftw_plan_many_r2r (1, /* Rank */ + &in->ntheta, /* n[] */ + in->nr + 4, /* howmany */ + RZTP (in, in->r0, in->z0 + i, 0), + /* in */ + &in->ntheta, /* inembed */ + in->strides[THETA_INDX], /* istride */ + in->strides[R_INDX], /* idist */ + RZTP (out, in->r0, out->z0 + i, 0), + /* out */ + &out->ntheta, /* onembed */ + out->strides[THETA_INDX], /* ostride */ + out->strides[R_INDX], /* odist */ + &kind, /* kind */ + FFTW_ESTIMATE); /* flags */ + + } + +#pragma omp parallel + { +#pragma omp for + for (i = 0; i < in->nz + 4; i++) { + fftw_execute (plans[i]); + } + } + + + for (i = 0; i < in->nz + 4; i++) { + fftw_destroy_plan (plans[i]); + } + + free (plans); + fftw_cleanup(); +} + + +/** @brief Calculates the Fourier transform of the derivative of a function given its + Fourier transform. */ +void +dft_diff (grid_t *grid, rz_array_t *f) +{ + int ir, iz, k; + + debug (2, "dft_diff (" grid_printf_str ", ...)\n", grid_printf_args(grid)); + + /* The parallelization here is not optimal if max_ntheta is not a multiple + of 2. */ +#pragma omp parallel + { +#pragma omp for private(ir, iz) + for (k = 0; k < grid->ntheta / 2 + 1; k++) { + if (k < grid->ntheta / 2) { + iter_grid_n (grid, ir, iz, 2) { + double re, im, re_f, im_f; + + /* For k == 0, everything is real. */ + re_f = RZT (f, ir, iz, k); + im_f = (k == 0? 0: RZT (f, ir, iz, grid->ntheta - k)); + + re = re_f * wk[k] - (k == 0? 0: im_f * wk[grid->ntheta - k]); + im = (k == 0? 0: re_f * wk[grid->ntheta - k] + im_f * wk[k]); + + RZT (f, ir, iz, k) = re / r_at (ir, grid->level); + if (k != 0) + RZT (f, ir, iz, grid->ntheta - k) = im / r_at (ir, grid->level); + } + } else if ((grid->ntheta % 2) == 0) { + iter_grid_n (grid, ir, iz, 2) { + /* Also for k = ntheta / 2, everything is real. */ + RZT (f, ir, iz, k) = wk[k] * RZT (f, ir, iz, k) + / r_at (ir, grid->level); + } + } + } + } +} + + +/** @brief Calculates the @a weight for a given cdr grid and a variable ??? + * + * For a given cdr grid and a variable, calculates its "weight": + * the integral of the variable raised to power for each Fourier mode. + * weights[] must be able to contain at least cdr->ntheta values. +*/ +void +dft_weight (cdr_grid_t *cdr, rz_array_t *var, double weights[], double power) +{ + int k, ir, iz; + double pwr, tmp; + + debug (2, "dft_weigth(" grid_printf_str ", ...)\n", grid_printf_args(cdr)); + +#pragma omp parallel + { +#pragma omp for private(ir, iz, pwr, tmp) + for (k = 0; k < cdr->ntheta; k++) { + pwr = 0; + iter_grid(cdr, ir, iz) { + /* Slow, since power is usually 1 or 2, + but this is outside the main loop, so we buy generality + at the cost of speed. */ + tmp = pow(RZT(var, ir, iz, k), power); + pwr += (tmp * r_at(ir, cdr->level)); + } + weights[k] = twopi * pwr * dr[cdr->level] * dz[cdr->level]; + } + } +} + + +/** @brief Outputs to a file 'weights.tsv' the results of dft_weight. + * + * Assumes that grid->charge is calculated but in real space then it + * transforms it to Fourier space and leaves it like that: so do not + * assume that grid->charge is unchanged. + * + * grid->dens[electrons], on the other hand, is transformed forth and back. + */ +void +dft_out_weights (cdr_grid_t *grid, const char *prefix, double t) +{ + static FILE *fp_charge = NULL; + static FILE *fp_electrons = NULL; + static double *powers_charge = NULL; + static double *powers_electrons = NULL; + int i; + + if (NULL == fp_charge) { + char *fname; + asprintf (&fname, "%s/charge-weights.tsv", prefix); + fp_charge = fopen (fname, "w"); + + if (NULL == fp_charge) { + fatal ("Unable to open %s\n", fname); + return; + } + free (fname); + + asprintf (&fname, "%s/electrons-weights.tsv", prefix); + fp_electrons = fopen (fname, "w"); + + if (NULL == fp_electrons) { + fatal ("Unable to open %s\n", fname); + return; + } + free (fname); + } + + if (NULL == powers_charge) { + powers_charge = xmalloc (sizeof(double) * grid->ntheta); + powers_electrons = xmalloc (sizeof(double) * grid->ntheta); + } + + dft_transform (grid->charge, grid->charge, 1); + dft_weight (grid, grid->charge, powers_charge, 2.0); + + /* The electron density has to be transformed back, since we will still need + it. */ + dft_transform (grid->dens[electrons], grid->dens[electrons], 1); + dft_weight (grid, grid->dens[electrons], powers_electrons, 1.0); + dft_transform (grid->dens[electrons], grid->dens[electrons], -1); + renormalize(grid, grid->dens[electrons]); + + fprintf (fp_charge, "%g", t); + fprintf (fp_electrons, "%g", t); + + for (i = 0; i < grid->ntheta; i++) { + fprintf (fp_charge, "\t%g", powers_charge[i]); + fprintf (fp_electrons, "\t%g", powers_electrons[i]); + } + + fprintf (fp_charge, "\n"); + fprintf (fp_electrons, "\n"); + + fflush(fp_charge); + fflush(fp_electrons); +} + + +/** @brief Perturbs a FFT-transformed variable. + * + * Assumes that the unperturbed variable is axi-symmetrical and hence + * all modes are zero except k=0. The perturbation is then selected + * as a Gaussian random number epsilon_k times the zero-mode value of + * the variable. epsilon_k is distributed as + * epsilon_k = N(0, perturb_epsilon). + */ +void +dft_perturb (cdr_grid_t *cdr, rz_array_t *var, double *epsilon_k) +{ + int k, ir, iz; + +#pragma omp parallel + { +#pragma omp for private(ir, iz) + for (k = 1; k < cdr->ntheta; k++) { + if (k > perturb_max_k && k < (cdr->ntheta - perturb_max_k)) + continue; + + iter_grid_n (cdr, ir, iz, 2) { + RZT (var, ir, iz, k) = + /* We multiply the perturbation by r to ensure that it is + continuous at r -> 0. */ + epsilon_k[k - 1] * RZT (var, ir, iz, 0) * r_at (ir, cdr->level); + } + } + } +} + +/** @brief Takes a density in real space, transforms it to Fourier space, + * perturbs it and then transforms back to real space. */ +void +dft_dens_perturb_r (cdr_grid_t *grid, int species, double *epsilon_k) +{ + int ir, iz, k, allocated = FALSE; + cdr_grid_t *leaf; + double A; + + debug (2, "dft_dens_perturb_r(" grid_printf_str ", %s)\n", + grid_printf_args(grid), spec_index[species]->name); + + /* We normalize the perturbation using the maximum of the densities. */ + A = invpi32 * seed_N / (seed_sigma_x * seed_sigma_y * seed_sigma_z); + + if (NULL == epsilon_k) { + epsilon_k = (double*) xmalloc (sizeof(double) * (grid->ntheta - 1)); + + for (k = 1; k < grid->ntheta; k++) { + /* We divide by ntheta because the FFT is not normalized and we want + to express perturb_epsilon as a fraction of the k=0 mode. */ + epsilon_k[k - 1] = rnd_gauss (0, perturb_epsilon) / grid->ntheta / A; + } + + allocated = TRUE; + } + + iter_childs (grid, leaf) { + dft_dens_perturb_r (leaf, species, epsilon_k); + } + + dft_transform (grid->dens[species], grid->dens[species], 1); + + renormalize(grid, grid->dens[species]); + + dft_perturb (grid, grid->dens[species], epsilon_k); + dft_transform (grid->dens[species], grid->dens[species], -1); + + if (allocated) free (epsilon_k); +} + + +/** @brief Renormalize @a var for some cases. + * + * FFTW does not normalize the Fourier transform, so after transforming + * forth and back, the original values are multiplied by max_ntheta. + * We use this routine to renormalize @a var in those cases. + * + * Note that this is taken care of when calculating the charge, so + * in most cases you do not need to call this function. + */ +static void +renormalize (cdr_grid_t *grid, rz_array_t *var) +{ + int ir, iz, itheta; + +#pragma omp parallel + { +#pragma omp for private(ir, iz) + for (itheta = 0; itheta < grid->ntheta; itheta++) { + iter_grid_n (grid, ir, iz, 2) { + RZT(var, ir, iz, itheta) /= grid->ntheta; + } + } + } +} + + +/** @brief Returns a random number with a gaussian distribution centered + * around mu with width sigma. + */ +static double +rnd_gauss(double mu, double sigma) +{ + double x1, x2, w; + static double y1, y2; + static int has_more = FALSE; + + + if (has_more) { + has_more = FALSE; + return mu + y2 * sigma; + } + + do { + x1 = 2.0 * ranf() - 1.0; + x2 = 2.0 * ranf() - 1.0; + w = x1 * x1 + x2 * x2; + } while (w >= 1.0); + + w = sqrt ((-2.0 * log (w)) / w); + y1 = x1 * w; + y2 = x2 * w; + + has_more = TRUE; + + return mu + y1 * sigma; +} + +#define AM (1.0 / RAND_MAX) + +/** @brief Returns a random number uniformly distributed in [0, 1] */ +static double +ranf (void) +{ + return rand() * AM; +} diff --git a/src/grid.c b/src/grid.c new file mode 100644 index 0000000000000000000000000000000000000000..3e60bbcc85b4bb840a00f3c4e68327af9d50deb5 --- /dev/null +++ b/src/grid.c @@ -0,0 +1,295 @@ +/** @file grid.c + * @brief General grid functions common for cdr and poisson grids. + */ +#include +#include +#include + +#include "grid.h" +#include "parameters.h" +#include "proto.h" +#include "species.h" + +/** @brief Gets the maximum depth of a tree (the level of its deepest node) */ +int +grid_max_depth_r (grid_t *grid) +{ + int l, lc; + grid_t *child; + + l = grid->level; + iter_childs (grid, child) { + lc = grid_max_depth_r (child); + l = (l > lc)? l: lc; + } + return l; +} + +/** @brief Gets the minimum r of a grid and all its descendants */ +double +grid_rmin_r (grid_t *grid) +{ + int lev; + double minr, cminr; + grid_t *child; + + lev = grid->level; + minr = r_at (grid->r0, lev); + + iter_childs (grid, child) { + cminr = grid_rmin_r (child); + minr = (minr > cminr)? cminr: minr; + } + return minr; +} + +/** @brief Recursively prints one grid and all its descendants. */ +void +grid_print_r (grid_t *grid, int indent) +{ + int i; + grid_t *child; + + for (i = 0; i < indent; i++) fputs (" ", stdout); + printf ("grid (" grid_printf_str") {\n", grid_printf_args(grid)); + + iter_childs (grid, child) { + grid_print_r (child, indent + 1); + } + for (i = 0; i < indent; i++) fputs (" ", stdout); + fputs ("}\n", stdout); +} + +/** @brief Checks whether a point is in the interior or on a given boundary + * of a grid. + * + * Does the grid contain the point (i, j) (in its own coordinates)?\n + * @a check has the following meaning:\n + * GRID_INSIDE : Checks if the point is in the interior of the grid\n + * BND_MASK_* : Checks if it is on the given boundary (BND_MASK_ALL checks for + * any boundary).\n + */ +int +grid_contains (grid_t *grid, int i, int j, int check) +{ + int r0, r1, z0, z1; + int r; + + r0 = grid->r0; + z0 = grid->z0; + r1 = grid->r1 - 1; + z1 = grid->z1 - 1; + + r = FALSE; + + if (check & BND_MASK_LEFT) { + r0 -= 1; + } + + if (check & BND_MASK_RIGHT) { + r1 += 1; + } + + if (check & BND_MASK_BOTTOM) { + z0 -= 1; + } + + if (check & BND_MASK_TOP) { + z1 += 1; + } + + if (r0 < i && i < r1 && z0 < j && j < z1) + r = TRUE; + + if (check & GRID_INSIDE) { + return r; + } else { + return (r && !grid_contains (grid, i, j, GRID_INSIDE)); + } +} + +/** @brief Checks whether two grids overlap and return the rectangle that they + * in common. + * + * Checks whether two grids overlap and return the rectangle that they + * have in common in the coordinates of the finest grid in + * (*left, *bottom) - (*right, *top)\n + * + * Note that *left, *bottom... can be modified even if the two grids do + * not overlap. + * @a buff1 and @a buff2 are integers that specify the numbers of cells + * that are taken as buffer in the boundaries for @a grid1 and @a grid2. + */ +int +grid_overlap (grid_t *grid1, grid_t *grid2, int buff1, int buff2, + int *left, int *bottom, int *right, int *top, int *level_diff) +{ + return grid_overlap_with_shifts (grid1, grid2, buff1, buff2, + left, bottom, right, top, level_diff, + 0, 0); +} + +/** @brief Checks the overlap between two grids. + * + * Checks the overlap between two grids before it shifts the + * coarser grid by (shift_r << (level_diff - 1), shift_z << (level_diff - 1) + * (in finer grid coordinates). + * + * Q: WTF! WHY!!!? \n + * A: We use this to implement the mapping between electric fields. Since + * The electric field is evaluated not in the cell centers but in the + * borders, when we interpolate we have to take a shift into account. + * See mapper.c and mapper.h for more info. + */ +int +grid_overlap_with_shifts (grid_t *grid1, grid_t *grid2, int buff1, int buff2, + int *left, int *bottom, int *right, int *top, + int *level_diff, int shift_r, int shift_z) +{ + int sign; + + debug (3, "grid_overlap(" grid_printf_str", " grid_printf_str + ", buff1 = %d, buff2 = %d)\n", + grid_printf_args(grid1), grid_printf_args(grid2), + buff1, buff2); + + sign = 1; + + /* If level_diff < 0, grid2 is finer */ + *level_diff = grid1->level - grid2->level; + + if (*level_diff < 0) { + sign = -1; + *level_diff = - *level_diff; + XCHG (grid1, grid2); + XCHG (buff1, buff2); + } + + /* At this point, level_diff >= 0 and grid1 is finer + or equivalent to grid2 */ + + *left = MAX_AT_LEVEL_WITH_SHIFT (grid1->r0 - buff1, grid2->r0 - buff2, + *level_diff, shift_r); + *right = MIN_AT_LEVEL_WITH_SHIFT (grid1->r1 + buff1, grid2->r1 + buff2, + *level_diff, shift_r); + + /* Note: *right is not contained in the grid. Hence, if *left == *right + the two grids do not overlap. Same for *bottom and *top, below. */ + debug (3, "*left = %d, *right = %d\n", *left, *right); + if (*left >= *right) { + *level_diff *= sign; + return FALSE; + } + + *bottom = MAX_AT_LEVEL_WITH_SHIFT (grid1->z0 - buff1, grid2->z0 - buff2, + *level_diff, shift_z); + *top = MIN_AT_LEVEL_WITH_SHIFT (grid1->z1 + buff1, grid2->z1 + buff2, + *level_diff, shift_z); + + debug (3, "*bottom = %d, *top = %d\n", *bottom, *top); + if (*bottom >= *top) { + *level_diff *= sign; + return FALSE; + } + debug (3, "pois_overlap = TRUE\n"); + + *level_diff *= sign; + return TRUE; +} + +/** @brief Makes a grid inherit the ext_bound field of its parent, + * + * with the appropiate modifications. + */ +void +grid_inherit_ext_bound (grid_t *grid) +{ + grid_t *parent = grid->parent; + + debug (3, "grid_inherit_ext_bound (...)\n"); + + grid->ext_bound = BND_NONE; + + /* If the parent does not have any external boundary, the child will also + not have */ + if (BND_NONE == parent->ext_bound) { + return; + } + + if (parent->ext_bound & BND_MASK_LEFT) { + if ((parent->r0 << 1) == grid->r0) grid->ext_bound |= BND_MASK_LEFT; + } + + if (parent->ext_bound & BND_MASK_RIGHT) { + if ((parent->r1 << 1) == grid->r1) grid->ext_bound |= BND_MASK_RIGHT; + } + + if (parent->ext_bound & BND_MASK_BOTTOM) { + if ((parent->z0 << 1) == grid->z0) grid->ext_bound |= BND_MASK_BOTTOM; + } + + if (parent->ext_bound & BND_MASK_TOP) { + if ((parent->z1 << 1) == grid->z1) grid->ext_bound |= BND_MASK_TOP; + } + +} + + +/** @brief Finds the finest descendant of grid that contains the point given by + * the (@a r, @a z) coordinates. + * + * Or NULL if the point is not contained in grid. + * We assume that only ONE sub-grid can contain a given point. + */ +grid_t * +grid_finest_containing_r (grid_t *grid, double r, double z) +{ + grid_t *leaf, *ret; + + if (r < er_r_at(grid->r0 - 1, grid->level) || + r > er_r_at(grid->r1 - 1, grid->level)) + return NULL; + + if (z < ez_z_at(grid->z0 - 1, grid->level) || + z > ez_z_at(grid->z1 - 1, grid->level)) + return NULL; + + iter_childs (grid, leaf) { + ret = grid_finest_containing_r (leaf, r, z); + if (NULL != ret) + return ret; + } + return grid; +} + +/** @brief How many children does one grid have? */ +int +grid_howmany_children (grid_t *grid) +{ + grid_t *leaf; + int count; + + count = 0; + iter_childs (grid, leaf) { + count ++; + } + return count; +} + +/** @brief Finds child number @a n of the given grid. + * + * If it doesn't have enough children just returns NULL + */ +grid_t* +grid_get_child (grid_t *grid, int n) +{ + grid_t *leaf; + int count; + + count = 0; + iter_childs (grid, leaf) { + if (count == n) return leaf; + count ++; + } + return NULL; +} diff --git a/src/interpol2.c b/src/interpol2.c new file mode 100644 index 0000000000000000000000000000000000000000..852248ebf9aa8fdc8993119babb6675de4ddbc93 --- /dev/null +++ b/src/interpol2.c @@ -0,0 +1,446 @@ +/** @file interpol2.c + * @brief New interpolation routines + * + * We want to obtain a function \f$f(r, z)\f$ from another one \f$phi(r, z)\f$ + * which is known only in some points of a stencil, + * \f$\phi(r0 + i dr, z0 + j dz), 0 <= {i, j} < q\f$. + * + * We approximate \f$f\f$ as + * + * \f$f(r, z) = \sum_{nm} (r - r0)^n (z - z0)^m c_{nm}\f$ + * + * where \f$m + n < p\f$, \f$p\f$ being the order of the interpolating function + * plus one. + * + * The coefficients \f$c_{nm}\f$ are calculated from \f$\phi\f$ as + * + * \f$c_{nm} = \sum_{ij} b_{nm ij} phi(r0 + i L, z0 + j L)\f$ + * + * Thus, to define an interpolation method, we only need the matrix + * \f$b_{nm ij}\f$, which has \f$1/2 q^2 p(p+1)\f$ elements. + * + * HOWEVER, using this general interpolation matrix turns out to be too + * slow. Hence we define also specific routines that have the same + * interface and that are called transparently. Thus the calling program + * does not have to worry about the internals of how the interpolation + * is computed. + */ +#include +#include +#include +#include + +#include "grid.h" +#include "interpol2.h" +#include "parameters.h" +#include "proto.h" +#include "rz_array.h" +#include "species.h" + +#define anm(N_, M_) this->stencil[(N_) * this->method->q + (M_)] + +static double gen_apply (interpol_t *this, double r, double z); +void bilin_set_coeffs (interpol_t *this); +void quadlog_set_coeffs (interpol_t *this); +double quadlog_apply (interpol_t *this, double r, double z); + +/** @brief Creates a new interpolator that uses a given method. */ +interpol_t* +interpol_new_a (double Lr, double Lz, interpol_method_t *method) +{ + interpol_t *interpol; + + interpol = xmalloc (sizeof (interpol_t)); + + interpol->method = method; + interpol->Lr = Lr; + interpol->Lz = Lz; + + /* The number of pairs {i, j} (i, j >= 0) such that i + j < p + is p (p + 1) / 2 */ + interpol->coeffs = xmalloc (sizeof(double) * + method->p * (method->p + 1) / 2); + interpol->stencil = xmalloc (sizeof(double) * method->q * method->q); + + return interpol; +} + +/** @brief Frees the interpolator */ +void +interpol_free (interpol_t *this) +{ + free (this->coeffs); + free (this->stencil); + free (this); +} + +/** @brief Sets the stencil of the interpolation object. + * + * @a r0 and @a z0 are the coordinates of the bottom-left corner of the stencil + * (the [0,0] point). +*/ +void +interpol_set_stencil (interpol_t *this, double r0, double z0, ...) +{ + int i, j, indx; + va_list ap; + + va_start (ap, z0); + + for (indx = 0, i = 0; i < this->method->q; i++) { + for (j = 0; j < this->method->q; j++) { + this->stencil[indx++] = va_arg (ap, double); + } + } + + this->r0 = r0; + this->z0 = z0; + + va_end (ap); + + /* If the method has an optimized routine, use it. */ + if (this->method->set_coeffs != NULL) { + this->method->set_coeffs (this); + } + else { + interpol_set_coeffs (this); + } +} + +/** @brief Sets the stencil reading from an array. + * + * @a ir, @a iz give the index of the cell in the array corresponding to + * the stencil origin. + */ +void +interpol_set_stencil_at (grid_t *grid, interpol_t *this, double r0, double z0, + rz_array_t *ar, + int ir, int iz, int itheta) +{ + int indx, i, j; + REAL *sp, *ap; + + assert (ar->ntheta > itheta); + + sp = this->stencil; + for (indx = 0, i = 0; i < this->method->q; i++) { + double r; + if (this->method->masses) { + r = cyl_r_at (ir + i - this->method->ir0, grid->level); + } else { + r = 1; + } + + ap = RZTP (ar, ir + i - this->method->ir0, + iz - this->method->iz0, itheta); + + for (j = 0; j < this->method->q; j++, ap += ar->strides[Z_INDX]) { + /* The case ir = -1 does not give any problem, since we set + up the correct boundaries. */ + *sp = r * (*ap); + sp++; + } + } + + this->r0 = r0; + this->z0 = z0; + + /* If the method has an optimized routine, use it. */ + if (this->method->set_coeffs != NULL) { + this->method->set_coeffs (this); + } + else { + interpol_set_coeffs (this); + } +} + +/** @brief Calculates the coefficients of the interpolating polynomial. + * + * Has to be called after interpol_set_stencil. */ +void +interpol_set_coeffs (interpol_t *this) +{ + double Lrn[MAX_ORDER], Lzn[MAX_ORDER]; + double *matrix, sum; + int n, ip, j; + int pindx, mindx; + + matrix = this->method->matrix; + + Lrn[0] = 1.0; + Lzn[0] = 1.0; + + for (ip = 0, pindx = 0, mindx = 0; ip < this->method->p; ip++) { + Lrn[ip + 1] = Lrn[ip] * this->Lr; + Lzn[ip + 1] = Lzn[ip] * this->Lz; + for (n = 0; n <= ip; n++) { + sum = 0; + + /* This is the coefficient of r^n z^m, with m + n = ip */ + for (j = 0; j < this->method->q * this->method->q; j++) + sum += matrix[mindx++] * this->stencil[j]; + + this->coeffs[pindx++] = sum / Lrn[n] / Lzn[ip - n]; + } + } +} + +/** @brief Evaluates the interpolating polynomial. */ +double +interpol_apply (interpol_t *this, double r, double z) +{ + double result; + + /* If the method has an optimized routine, call it and return */ + if (this->method->apply != NULL) { + result = this->method->apply (this, r, z); + } else { + /* Else, apply the general method. */ + result = gen_apply (this, r, z); + } + + if (this->method->masses) { + return result / cyl_q(r); + } else { + return result; + } +} + +/** @brief gen_apply ?????. */ +static double +gen_apply (interpol_t *this, double r, double z) +{ + double deltar, deltaz, sum; + + deltar = r - this->r0; + deltaz = z - this->z0; + + int ipmax=this->method->p; + if (ipmax < 3) { + fprintf(stdout,"ipmax=%d\n",ipmax); + fatal("interpol2: order interpolation not equal to 3\n"); + } + + if (deltar==deltaz) { + sum = this->coeffs[0] + + deltar * (this->coeffs[1] + + this->coeffs[2] + + deltar * (this->coeffs[3] + + this->coeffs[4] + + this->coeffs[5] )); + + } else + { + sum = this->coeffs[0] + + deltaz * (this->coeffs[1] + deltaz * this->coeffs[3]) + + deltar * (this->coeffs[2] + + deltaz * this->coeffs[4] + + deltar * this->coeffs[5] ); + } + return sum; +} + +/** You are not supposed to understand these numbers. + * Refer to InterpolArrays.nb + */ +double matrix_zero[] = {1.0}; + +interpol_method_t interpol_zero = {matrix_zero, 1, 1, 0, 0, FALSE, + interpol_set_coeffs, + gen_apply}; + +interpol_method_t interpol_zero_masses = {matrix_zero, 1, 1, 0, 0, TRUE, + interpol_set_coeffs, + gen_apply}; + +/* You are not supposed to understand these numbers. + Refer to InterpolArrays.nb */ + +/** Coefficients for a 9-point stencil quadratic interpolation. */ +double matrix_quadratic[] = + {-0.1111111111111111, 0.2222222222222222, -0.1111111111111111, + 0.2222222222222222, 0.5555555555555556, 0.2222222222222222, + -0.1111111111111111, 0.2222222222222222, -0.1111111111111111, + -0.1666666666666667, 0 , 0.1666666666666667, + -0.1666666666666667, 0 , 0.1666666666666667, + -0.1666666666666667, 0 , 0.1666666666666667, + -0.1666666666666667, -0.1666666666666667, -0.1666666666666667, + 0 , 0 , 0 , + 0.1666666666666667, 0.1666666666666667, 0.1666666666666667, + 0.1666666666666667, -0.3333333333333333, 0.1666666666666667, + 0.1666666666666667, -0.3333333333333333, 0.1666666666666667, + 0.1666666666666667, -0.3333333333333333, 0.1666666666666667, + 0.25 , 0 , -0.25 , + 0.25 , 0 , -0.25 , + 0 , 0 , 0 , + -0.25 , 0 , 0.25 , + 0.1666666666666667, 0.1666666666666667, 0.1666666666666667, + -0.3333333333333333, -0.3333333333333333, -0.3333333333333333, + 0.1666666666666667, 0.1666666666666667, 0.1666666666666667 + }; + +interpol_method_t interpol_quadratic = {matrix_quadratic, 3, 3, 1, 1, FALSE, + interpol_set_coeffs, + gen_apply}; + +interpol_method_t interpol_quadratic_masses = {matrix_quadratic, 3, 3, 1, 1, + TRUE, + interpol_set_coeffs, + gen_apply}; + +/** @brief In this approach, we make sure that the interpolation error at + * the matrix center (anm(2, 2)) is zero (this is used by J. Wackers' code) */ +double matrix_wackers[] = + { 0 , 0 , 0 , + 0 , 1.0 , 0 , + 0 , 0 , 0 , + -0.1666666666666667, 0 , 0.1666666666666667, + -0.1666666666666667, 0 , 0.1666666666666667, + -0.1666666666666667, 0 , 0.1666666666666667, + -0.1666666666666667, -0.1666666666666667, -0.1666666666666667, + 0 , 0 , 0 , + 0.1666666666666667, 0.1666666666666667, 0.1666666666666667, + 0.1 , -0.2 , 0.1 , + 0.3 , -0.6 , 0.3 , + 0.1 , -0.2 , 0.1 , + 0.25 , 0 , -0.25 , + 0 , 0 , 0 , + -0.25 , 0 , 0.25 , + 0.1 , 0.3 , 0.1 , + -0.2 , -0.6 , -0.2 , + 0.1 , 0.3 , 0.1 }; + +interpol_method_t interpol_wackers = {matrix_wackers, 3, 3, 1, 1, FALSE, + interpol_set_coeffs, + gen_apply}; + +interpol_method_t interpol_wackers_masses = {matrix_wackers, 3, 3, 1, 1, TRUE, + interpol_set_coeffs, + gen_apply}; + + +double matrix_averaged[] = +{ -0.01880341880341880 , -0.008547008547008547, -0.01880341880341880 , + -0.008547008547008547, 1.109401709401709 , -0.008547008547008547, + -0.01880341880341880 , -0.008547008547008547, -0.01880341880341880 , + -0.1666666666666667 , 0 , 0.1666666666666667 , + -0.1666666666666667 , 0 , 0.1666666666666667 , + -0.1666666666666667 , 0 , 0.1666666666666667 , + -0.1666666666666667 , -0.1666666666666667 , -0.1666666666666667 , + 0 , 0 , 0 , + 0.1666666666666667 , 0.1666666666666667 , 0.1666666666666667 , + 0.1128205128205128 , -0.1987179487179487 , 0.1128205128205128 , + 0.3012820512820513 , -0.6564102564102564 , 0.3012820512820513 , + 0.1128205128205128 , -0.1987179487179487 , 0.1128205128205128 , + 0.25 , 0 , -0.25 , + 0 , 0 , 0 , + -0.25 , 0 , 0.25 , + 0.1128205128205128 , 0.3012820512820513 , 0.1128205128205128 , + -0.1987179487179487 , -0.6564102564102564 , -0.1987179487179487 , + 0.1128205128205128 , 0.3012820512820513 , 0.1128205128205128 }; + +interpol_method_t interpol_averaged = {matrix_averaged, 3, 3, 1, 1, FALSE, + interpol_set_coeffs, + gen_apply}; + +interpol_method_t interpol_averaged_masses = {matrix_averaged, 3, 3, 1, 1, TRUE, + interpol_set_coeffs, + gen_apply}; + +/* 4-point bilinear interpolation. */ +double matrix_bilin[] = + { 1.0, 0.0, 0.0, 0.0, + -1.0, 0.0, 1.0, 0.0, + -1.0, 1.0, 0.0, 0.0, + 0.0, 0.0, 0.0, 0.0, + 1.0, -1.0, -1.0, 1.0, + 0.0, 0.0, 0.0, 0.0}; + +/** @brief For bilinear interpolations, the standard fallback routines are too slow, + so we define optimized routines to increase performance. The results, + however, should be the same. */ +void +bilin_set_coeffs (interpol_t *this) +{ + double Lr, Lz; + double *c; + + c = this->coeffs; + + Lr = this->Lr; + Lz = this->Lz; + + c[0] = anm(0, 0); + c[1] = (anm(0, 1) - anm(0, 0)) / Lz; + c[2] = (anm(1, 0) - anm(0, 0)) / Lr; + c[3] = 0; /* Never used anyway. */ + c[4] = (anm(0, 0) - anm(1, 0) - anm(0, 1) + anm(1, 1)) / Lr / Lz; + c[5] = 0; /* Never used anyway. */ +} + +double +bilin_apply (interpol_t *this, double r, double z) +{ + double d_r, d_z; + double *c; + + c = this->coeffs; + + d_r = r - this->r0; + d_z = z - this->z0; + + return c[0] + d_z * (c[1] + c[4] * d_r) + c[2] * d_r; +} + + +interpol_method_t interpol_bilin = {matrix_bilin, + 3, 2, + 0, 0, + FALSE, + bilin_set_coeffs, + bilin_apply}; + +interpol_method_t interpol_bilin_masses = {matrix_bilin, + 3, 2, + 0, 0, TRUE, + bilin_set_coeffs, + bilin_apply}; + +void +quadlog_set_coeffs (interpol_t *this) +{ + int indx, i, j; + + for (indx = 0, i = 0; i < this->method->q; i++) { + for (j = 0; j < this->method->q; j++) { + this->stencil[indx] = log (this->stencil[indx]); + indx++; + } + } + interpol_set_coeffs (this); +} + +double +quadlog_apply (interpol_t *this, double r, double z) +{ + double rlog; + + rlog = gen_apply (this, r, z); + return exp (rlog); +} + +interpol_method_t interpol_quadlog = {matrix_quadratic, 3, 3, 1, 1, + FALSE, + quadlog_set_coeffs, + quadlog_apply}; + +interpol_method_t *interpol_methods_index[MAX_INTERPOL_METHODS] = { + &interpol_zero_masses, + &interpol_quadratic_masses, + &interpol_wackers_masses, + &interpol_averaged_masses, + &interpol_zero, + &interpol_quadratic, + &interpol_wackers, + &interpol_averaged, + &interpol_quadlog }; diff --git a/src/main.c b/src/main.c new file mode 100644 index 0000000000000000000000000000000000000000..a728fcc60122906962df089fec66a26b9e5cf843 --- /dev/null +++ b/src/main.c @@ -0,0 +1,248 @@ +/**i @file main.c + * @brief Code regarding input of parameters + starting of the code. */ + +#include +#include +#include +#include +#include +//#include +#include + +#include "cdr.h" +#include "cstream.h" +#include "grid.h" +#include "parameters.h" +#include "proto.h" +#include "species.h" + +int main (int argc, char *argv[]); +void start_process (cdr_grid_t *cdr); +void output_tree (cdr_grid_t *cdr, int step, double t); +void check_params (void); + +/** @brief The main program */ +int +main (int argc, char *argv[]) +{ + // param_t **p; + // char *s; + // struct option *opt; + // struct option *long_options; + // int c; + cdr_grid_t *cdr; + int count,count_user; + static const char *output_file; + config_t cfg,cfg_user; + config_setting_t *setting,*setting_user; + const char *prog_name,*f_defname,*f_username; + + f_defname = "input/default.cfg"; + f_username = "input/user_init.cfg"; + output_file = "input/user_continue.cfg"; + + /* Open configuration cfg */ + config_init(&cfg); + + /* Read the default file. + * The default file might be a result of a previous run, containing values + * for all global variables. + * If there is an error, report it and exit. */ + if(! config_read_file(&cfg, f_defname)) + { + fprintf(stderr, "%s:%d - %s\n", config_error_file(&cfg), + config_error_line(&cfg), config_error_text(&cfg)); + config_destroy(&cfg); + return(EXIT_FAILURE); + } + + /* Get the program name. */ + if(config_lookup_string(&cfg, "name", &prog_name)) + printf("Example : %s\n\n", prog_name); + else + fprintf(stderr, "No ' program name' setting in configuration file.\n"); + + /* Output a list of all parameters in the file. */ + setting = config_lookup(&cfg, "param"); + if(setting != NULL) + { + int i; + count = config_setting_length(setting); + + fprintf(stdout, "# params: count=%i\n",count); + + for(i = 0; i < count; ++i) + { + if (read_parameter(setting,setting,i,count,FALSE)) + continue; + } + + /* Write out the updated configuration. */ + if(! config_write_file(&cfg, output_file)) + { + fprintf(stderr, "Error while writing file.\n"); + config_destroy(&cfg); + return(EXIT_FAILURE); + } + putchar('\n'); + } + fprintf(stdout, "Default configuration successfully written to: %s\n", + output_file); + +/* ========================================================================== */ + + /* Open configuration cfg_user */ + config_init(&cfg_user); + + /* Read the file made by the user, with adapted values. + * This file does not have to contain entries for variables which remain + * unchanged. + * If there is an error, report it and exit. */ + if(! config_read_file(&cfg_user, f_username)) + { + fprintf(stderr, "%s:%d - %s\n", config_error_file(&cfg_user), + config_error_line(&cfg_user), config_error_text(&cfg_user)); + config_destroy(&cfg_user); + return(EXIT_FAILURE); + } + + /* Output a list of all parameters in the file. */ + setting_user = config_lookup(&cfg_user, "param"); + if(setting_user) + { + int i; + count_user = config_setting_length(setting_user); + + fprintf(stdout, "# params: count_user=%i\n",count_user); + + for(i = 0; i < count_user; ++i) + { + if (read_parameter(setting,setting_user,i,count,TRUE)) + continue; + } + + /* Write out the updated configuration. */ + if(! config_write_file(&cfg, output_file)) + { + fprintf(stderr, "Error while writing file.\n"); + config_destroy(&cfg); + return(EXIT_FAILURE); + } else { + fprintf(stdout, "Updated configuration successfully written to: %s\n", + output_file); + } + putchar('\n'); + } + + check_params (); + + cstream_init (); + + if (restart) { + if (0 == strcmp (load_file, "")) { + printf("restart file is empty\n"); + return 1; + } else + cdr = cdr_load_tree_r (output_dir, load_file, NULL); + } else + cdr = cdr_scratch_init (); + + start_process(cdr); + + /* Destroy both configurations */ + config_destroy(&cfg_user); + config_destroy(&cfg); + + return 0; +} + +/** @brief Starts a given run on a given @a cdr tree. */ +void +start_process (cdr_grid_t *cdr) +{ + int i, i0; + double t, dt; + double t0, t1; + struct timeval tv; + FILE *fp; + + i0 = (int) (start_t / output_dt); + + debug(1,"before loop :start_t= %e; t = %e; dt = %e\n",start_t,t, dt); + /* This is the main loop of the code. */ + for (i = i0, t = start_t; t < end_t; t += dt) + { + debug(1,"inside loop: i, t, dt : %d %e %e\n",i,t,dt); + /* Set the field and the fixed charge when we have time-dependent + external fields (controled by rise_time) */ + cstream_set_field_at_time (t); + dt = cdr_rk2 (cdr, attempt_dt, t); + cdr_update_refined (&cdr); + printf("t = %lf\tdt = %lf\tnext output at: %lf\n",t,dt,i * output_dt); + if (output_dt <= 0.0 || t >= output_dt * i) + { + output_tree (cdr, i, t); + if (cdr->ntheta > 1) + { + dft_out_weights (cdr, output_dir, t); + } + i++; + } + } + cdr_dump (cdr, output_dir, "C"); + cdr_free_r (cdr); + cstream_end (); +} + +/** @brief Outputs the tree contained in cdr. + * + * If pois_output (global parameter) is true, it also dumps the Poisson tree. + */ +void +output_tree (cdr_grid_t *cdr, int step, double t) +{ + char *gname; + pois_grid_t **pois_modes; + FILE *fp; + char logfile[100]; + + asprintf (&gname, "C%.3d", step); + cdr_set_ext_bnd_r (cdr); + + /* !!!!!!!!!!!! */ + if (1 || t > start_t || 0 == strcmp (load_file, "")) { + cdr_dump_r (cdr, output_dir, gname, NULL, t); + cdr_dump_frames (cdr, output_dir, gname); + + printf ("CDR grid %s saved\n", gname); + } + + free (gname); + + if (pois_output) { + int mode; + pois_modes = cdr_calc_field_r (cdr, TRUE); + + for (mode = 0; mode < max_ntheta; mode++) { + asprintf (&gname, "P%.3d%.2d", step, mode); + pois_dump_r (pois_modes[mode], output_dir, gname); + pois_free_r (pois_modes[mode]); + printf ("Poisson grid %s saved\n", gname); + free (gname); + } + + free (pois_modes); + } +} + +/** @brief Checks for some errors in the parameters that will produce + * nonsense output. + */ +void +check_params () +{ + if ((gridpoints_z % 4) != 0 && pois_inhom == 1) { + fatal ("To use inhomogeneous fields, gridpoints_z must be a" + " multiple of 4\n"); + } +} diff --git a/src/mapper.c b/src/mapper.c new file mode 100644 index 0000000000000000000000000000000000000000..97924cee4b80ccf8d691f13029521d2f6bc0c440 --- /dev/null +++ b/src/mapper.c @@ -0,0 +1,345 @@ +/** @file mapper.c + * @brief All functions related to the mapping of whatever variable + * (densities, electric field...) from one tree into another. + * + * Here the relevant data structure is defined by mapper_t, which tells + * us what functions should we call to perform copying, interpolation + * and coarsening from one grid into another (not neccesarily ofthe same type). */ + +#include +#include +#include + +#include "cstream.h" +#include "grid.h" +#include "interpol2.h" +#include "mapper.h" +#include "proto.h" +#include "species.h" + +static void map_same (mapper_t **mappers, + grid_t *source, grid_t *target, int ntheta, + int r0, int z0, int r1, int z1); +static void map_interpol (mapper_t **mappers, grid_t *source, grid_t *target, + int ntheta, int r0, int z0, int r1, int z1, + int level_diff); +static void interpol_inner (mapper_t **mappers, grid_t *source, grid_t *target, + int pr, int pz, int ntheta, + interpol_t **interpols, + int *extend_r, int *extend_z); +static void map_coarsen (mapper_t **mappers, grid_t *source, grid_t *target, + int ntheta, int r0, int z0, int r1, int z1, + int level_diff); + + +/** @brief Maps two grids. + * + * The arguments @a copy, @a interpol and @a coarsen are + booleans that specify whether we should apply these methods + in the mapping. */ +void +map_grid (mapper_t **mappers, grid_t *source, grid_t *target, int ntheta, + int copy, int interpol, int coarsen, int s_buff, int t_buff) +{ + int r0, z0, r1, z1, level_diff; + int br0, bz0, br1, bz1; + mapper_t **m; + int overlap; + + debug (3, "map_grid (source = " grid_printf_str + ",\n\t dest = " grid_printf_str + ",\n\t s_buff = %d, t_buff = %d)\n", + grid_printf_args (source), grid_printf_args (target), + s_buff, t_buff); + + overlap = grid_overlap (source, target, s_buff, t_buff, + &r0, &z0, &r1, &z1, &level_diff); + + if (!overlap) { + debug (3, " -> no overlap\n"); + return; + } + + if (level_diff == 0 && copy) { + map_same (mappers, source, target, ntheta, r0, z0, r1, z1); + } else if (level_diff < 0 && interpol) { + /* When we interpolate electric fields, the stencil used in the coarse + grid does not map exactly to cells in the finer grid by the standard + rules. Hence may have to extend the range of fine-grid cells that + can be affected by a coarse grid. + But later we must be careful, because not all fine-grid cells can + be interpolated. + */ + for (m = mappers; *m; m++) { + int max_shift; + + max_shift = MYMAX(abs((*m)->shift_r) << (-level_diff - 1), + abs((*m)->shift_z) << (-level_diff - 1)); + + debug (3, "max_shift = %d, shift_r = %d, shift_z = %d\n", + max_shift, (*m)->shift_r, (*m)->shift_z); + + grid_overlap_with_shifts (source, target, + s_buff, + MYMAX (t_buff, max_shift), + &br0, &bz0, &br1, &bz1, &level_diff, + (*m)->shift_r, (*m)->shift_z); + if (br0 < r0) r0 = br0; + if (bz0 < z0) z0 = bz0; + if (br1 > r1) r1 = br1; + if (bz1 > z1) z1 = bz1; + } + map_interpol (mappers, source, target, ntheta, r0, z0, r1, z1, + -level_diff); + } else if (level_diff > 0 && coarsen) { + map_coarsen (mappers, source, target, ntheta, r0, z0, r1, z1, level_diff); + } +} + + +/** @brief Recursive version of map_grid. + * + * Recurses over the source tree depth-first + */ +void +map_grid_r (mapper_t **mappers, grid_t *source, grid_t *target, int ntheta, + int copy, int interpol, int coarsen, int s_buff, int t_buff) +{ + grid_t *child; + + debug (3, "map_grid_r (...)\n"); + + map_grid (mappers, source, target, ntheta, copy, interpol, coarsen, + s_buff, t_buff); + + iter_childs (source, child) { + map_grid_r (mappers, child, target, ntheta, copy, interpol, coarsen, + s_buff, t_buff); + } +} + +/** @brief Double-recursive version: + * + * Also recurses over the target tree. + */ +void +map_trees_r (mapper_t **mappers, grid_t *source, grid_t *target, int ntheta, + int copy, int interpol, int coarsen, int s_buff, int t_buff) +{ + grid_t *child; + + debug (3, "map_trees_r (...)\n"); + + iter_childs (target, child) { + map_trees_r (mappers, source, child, ntheta, copy, interpol, coarsen, + s_buff, t_buff); + } + + map_grid_r (mappers, source, target, ntheta, copy, interpol, coarsen, + s_buff, t_buff); +} + +/** @brief The level of the source and target grids is the same. + * + * This is the easiest case. + */ +static void +map_same (mapper_t **mappers, + grid_t *source, grid_t *target, int ntheta, + int r0, int z0, int r1, int z1) +{ + int ir, iz; + mapper_t **m; + + debug (3, "map_same (source = " grid_printf_str + ",\n\t dest = " grid_printf_str + ",\n\t r0 = %d, z0 = %d, r1 = %d, z1 = %d)\n", + grid_printf_args (source), grid_printf_args (target), + r0, z0, r1, z1); + + for (ir = r0; ir < r1; ir++) { + for (iz = z0; iz < z1; iz++) { + for (m = mappers; *m; m++) { + (*m)->copy (*m, source, target, ir, iz, ntheta); + } + } + } + debug (3, " < map_same (...)\n"); +} + +/** @brief With this, we limit the number of mappers. + * + * But it is extremely improbable that someone would like to use more + * than 32 mappers at the same time. */ +#define MAX_MAPPERS 32 + +/** @brief The source grid is coarser than the target grid. */ +static void +map_interpol (mapper_t **mappers, grid_t *source, grid_t *target, int ntheta, + int r0, int z0, int r1, int z1, int level_diff) +{ + int pr, pz; + int i, extend_r, extend_z; + interpol_t *interpols[MAX_MAPPERS]; + mapper_t **m; + + debug (3, "map_interpol (source = " grid_printf_str + ",\n\t dest = " grid_printf_str + ",\n\t r0 = %d, z0 = %d, r1 = %d, z1 = %d, level_diff = %d)\n", + grid_printf_args (source), grid_printf_args (target), + r0, z0, r1, z1, level_diff); + + for (m = mappers, i = 0; *m; m++, i++) + interpols[i] = interpol_new_a (dr[source->level], dz[source->level], + (*m)->interpol_method); + + /* The +- 1 are there because even when we are including the + boundaries to calculate the overlap, we have to let one buffer cell + for the 9-point interpolation. */ + r0 = MYMAX (r0 >> level_diff, source->r0 - 1); + + /* Explanation of the formula used: r1 is the index of the first cell not + in the overlap + -> r1 - 1 is the last cell in the overlap + -> (r1 - 1) >> level_diff indexes the last cell in the coarser grid + that contains part of the overlap. + -> since the loop has to include the former index, we add one. + */ + r1 = MYMIN (((r1 - 1) >> level_diff) + 1, source->r1 + 1); + z0 = MYMAX (z0 >> level_diff, source->z0 - 1); + z1 = MYMIN (((z1 - 1) >> level_diff) + 1, source->z1 + 1); + + + debug (4, "r0 = %d, z0 = %d, r1 = %d, z1 = %d\n", + r0, z0, r1, z1); + + /* assert (r0 < r1 && z0 < z1); */ + + for (pr = r0, extend_r = TRUE; pr < r1; pr++) { + /* The 0 initialization is to shut up the compiler. */ + int extend_r_in = 0; + for (pz = z0, extend_z = TRUE; pz < z1; pz++) { + debug (6, "pr = %d, pz = %d, extend_r = %d, extend_z = %d\n", + pr, pz, extend_r, extend_z); + extend_r_in = extend_r; + + interpol_inner (mappers, source, target, pr, pz, ntheta, + interpols, &extend_r_in, &extend_z); + } + extend_r = extend_r_in; + } + + for (m = mappers, i= 0; *m; m++, i++) + interpol_free (interpols[i]); + + debug (3, "< map_interpol (...)\n"); +} + +/** @brief Calculates all the points in a target grid, finer than a source + * grid that are interpolated from a stencil centered at @a pr, @a pz in + * the source grid. + * + * @a interpol_xxx are interpolation objects that can thus be reused. + * @a extend_r and @a extend_z are here because one call to @a interpol_inner + * can actually set (1 << level_diff + 1) fine grid points, but the boundaries + * are shared with the next/previous call. + * + * In the first call in a row/column, we set all the points, since the + * right/lower boundary is not shared. + */ +static void +interpol_inner (mapper_t **mappers, grid_t *source, grid_t *target, + int pr, int pz, int ntheta, + interpol_t **interpols, int *extend_r, int *extend_z) +{ + int level_diff; + int i, ir, iz; + int rmin, rmax, zmin, zmax; + int inside; + + mapper_t **m; + + level_diff = target->level - source->level; + + debug (6, "interpol_inner (source = " grid_printf_str ",\n\t\t target = " + grid_printf_str ",\n\t\t pr = %d, pz = %d, ntheta = %d)\n", + grid_printf_args (source), grid_printf_args (target), pr, pz, ntheta); + + for (m = mappers, i = 0; *m; m++, i++) { + int fine_shift_r, fine_shift_z; + + inside = (*m)->interpol_set (*m, source, interpols[i], pr, pz, ntheta); + + if (!inside) continue; + + fine_shift_r = (*m)->shift_r << (level_diff - 1); + fine_shift_z = (*m)->shift_z << (level_diff - 1); + + debug (6, "shift_r = %d, shift_z = %d\n", (*m)->shift_r, (*m)->shift_z); + + rmin = (pr << level_diff) + fine_shift_r; + /* (*m)->shift_z tells us if the grid is staggered. If it is not, + it doesn't make sense to extend it. */ + if (*extend_r && (*m)->shift_z != 0) { + *extend_r = FALSE; + rmin--; + } + + zmin = (pz << level_diff) + fine_shift_z; + if (*extend_z && (*m)->shift_r != 0) { + *extend_z = FALSE; + zmin--; + } + + /* The 2 are there because there is no problem in writing in the + buffer margin of the target grid. */ + rmin = MYMAX (target->r0 - 2, rmin); + rmax = MYMIN (target->r1 + 2, ((pr + 1) << level_diff) + fine_shift_r); + zmin = MYMAX (target->z0 - 2, zmin); + zmax = MYMIN (target->z1 + 2, ((pz + 1) << level_diff) + fine_shift_z); + + + debug(6, "\trmin = %d, rmax = %d, zmin = %d, zmax = %d\n", + rmin, rmax, zmin, zmax); + + for (ir = rmin; ir < rmax; ir++) { + for (iz = zmin; iz < zmax; iz++) { + (*m)->interpol (*m, source, target, interpols[i], + ir, iz, ntheta); + } + } + } +} + +/** @brief The target grid is coarser than the source grid. */ +static void +map_coarsen (mapper_t **mappers, grid_t *source, grid_t *target, int ntheta, + int r0, int z0, int r1, int z1, int level_diff) +{ + int i, ir, iz; + int rmin, rmax, zmin, zmax; + mapper_t **m; + + debug (3, "map_coarsen (source = " grid_printf_str + ",\n\t dest = " grid_printf_str + ",\n\t r0 = %d, z0 = %d, r1 = %d, z1 = %d, level_diff = %d)\n", + grid_printf_args (source), grid_printf_args (target), + r0, z0, r1, z1, level_diff); + + rmin = MYMAX (r0 >> level_diff, target->r0 - 2); + + /* See above for an explanation for this formula. */ + rmax = MYMIN (((r1 - 1) >> level_diff) + 1, target->r1 + 2); + zmin = MYMAX (z0 >> level_diff, target->z0 - 2); + zmax = MYMIN (((z1 - 1) >> level_diff) + 1, target->z1 + 2); + + for (iz = zmin; iz < zmax; iz++) { + for (ir = rmin; ir < rmax; ir++) { + for (m = mappers, i = 0; *m; m++, i++) { + (*m)->coarsen (*m, source, target, ir, iz, ntheta); + } + } + } + debug (3, "< map_coarsen (...)\n"); +} + diff --git a/src/misc.c b/src/misc.c new file mode 100644 index 0000000000000000000000000000000000000000..97de89488c1f1afb9c95333f97f7b8935d0c3cfb --- /dev/null +++ b/src/misc.c @@ -0,0 +1,47 @@ +/** @file misc.c + * @brief Miscellaneous utilities. + */ + +#include +#include + +extern char *invok_name; + +/** @brief Allocates memory with check and (eventually) error reporting. */ +void* +xmalloc (size_t size) +{ + void *value = malloc(size); + if (value == 0) { + fprintf (stderr, "%s: virtual memory exhausted", invok_name); + exit (1); + } + return value; +} + +/** @brief Reallocates memory */ +void * +xrealloc (void *ptr, size_t size) +{ + void *value = realloc (ptr, size); + if (value == 0) { + fprintf (stderr, "%s: Virtual memory exhausted", invok_name); + exit (1); + } + return value; +} + + +/** @brief Reallocates memory, but now initializes the memory to zero. */ +void* +xcalloc (size_t count, size_t size) +{ + void *value; + + value = calloc (count, size); + if (value == 0){ + fprintf (stderr, "%s: virtual memory exhausted", invok_name); + exit (1); + } + return value; +} diff --git a/src/photo.c b/src/photo.c new file mode 100644 index 0000000000000000000000000000000000000000..ed3efc613f0fe041effffda9b22fb3f5d3c42c17 --- /dev/null +++ b/src/photo.c @@ -0,0 +1,400 @@ +/** @file photo.c + * @brief Routines for the calculation of the photoionization source term. + * + * We use the Helmholtz approximation for the kernel in the photoionization + * integral and we use the routines of the Poisson solver for the Helmholtz + * equation (FISHPACK was modified to take a new inhomogeneous term into + * account). + */ + +#include +#include +#include + +#include "cdr.h" +#include "interpol2.h" +#include "mapper.h" +#include "parameters.h" +#include "photo.h" +#include "poisson.h" +#include "proto.h" +#include "rz_array.h" +#include "species.h" + +void photo_copy (mapper_t *mapper, grid_t *source, grid_t *target, + int ir, int iz, int itheta); +void photo_coarsen (mapper_t *mapper, grid_t *source, grid_t *target, + int ir, int iz, int itheta); +int photo_interpol_set (mapper_t *mapper, grid_t *source, + interpol_t *interpol, + int pr, int pz, int itheta); +void photo_interpol (mapper_t *mapper, grid_t *source, grid_t *target, + interpol_t *interpol, + int ir, int iz, int itheta); + +photo_term_t *photo_terms = NULL; + +mapper_t photo_mapper = {&interpol_bilin, photo_coarsen, photo_copy, + photo_interpol_set, photo_interpol}; + +mapper_t *photo_mappers[] = {&photo_mapper, NULL}; + +pois_problem_t *pois_photo_1; +pois_problem_t *pois_photo_2; +extern pois_problem_t *pois_electrostatic; + +/** @brief Initializes photoionization QQQQ? */ +void +photo_init () +{ + /* Since it makes no sense, we use photo_extra_levels < 0 to say that + the conditions for the photoionization are the same as for + the electrostatic problem. This is needed for backwards compatibility. */ + if (extra_photo_levels < 0) + { + pois_photo_1 = pois_electrostatic; + pois_photo_2 = pois_electrostatic; + return; + } + + /* Two different sets of refinement criteria for the two photoionization + terms. If extra_photo_levels_2 < 0, then pois_photo_2 = pois_photo_1 */ + pois_photo_1 = xmalloc (sizeof (pois_problem_t)); + + pois_photo_1->max_level = photo_max_level; + pois_photo_1->extra_levels = extra_photo_levels; + pois_photo_1->max_error = photo_max_error; + + pois_photo_1->bnd_right = photo_bnd_right; + pois_photo_1->bnd_top = photo_bnd_top; + pois_photo_1->bnd_bottom = photo_bnd_bottom; + + if (extra_photo_levels_2 < 0) + { + pois_photo_2 = pois_photo_1; + return; + } + + pois_photo_2 = xmalloc (sizeof (pois_problem_t)); + + pois_photo_2->max_level = photo_max_level_2; + pois_photo_2->extra_levels = extra_photo_levels_2; + pois_photo_2->max_error = photo_max_error_2; + + pois_photo_2->bnd_right = photo_bnd_right_2; + pois_photo_2->bnd_top = photo_bnd_top_2; + pois_photo_2->bnd_bottom = photo_bnd_bottom_2; +} + + +/** @brief Copies the photoionization QQQQ? */ +void +photo_copy (mapper_t *mapper, grid_t *source, grid_t *target, + int ir, int iz, int itheta) +{ + cdr_grid_t *cdr; + pois_grid_t *pois; + + cdr = (cdr_grid_t*) target; + pois = (pois_grid_t*) source; + + RZT (cdr->photo, ir, iz, itheta) = RZ (pois->phi, ir, iz); +} + +/** @brief Coarsens the photoionization QQQQ? */ +void +photo_coarsen (mapper_t *mapper, grid_t *source, grid_t *target, + int ir, int iz, int itheta) +{ + cdr_grid_t *cdr; + pois_grid_t *pois; + int level_diff, z, r; + + cdr = (cdr_grid_t*) target; + pois = (pois_grid_t*) source; + + level_diff = pois->level - cdr->level; + + z = (iz << level_diff) + (1 << (level_diff - 1)); + r = (ir << level_diff) + (1 << (level_diff - 1)); + + if (grid_contains (source, r, z, GRID_INSIDE) && + grid_contains (source, r - 1, z, GRID_INSIDE) && + grid_contains (source, r, z - 1, GRID_INSIDE) && + grid_contains (source, r - 1, z - 1, GRID_INSIDE)) { + + RZT (cdr->photo, ir, iz, itheta) = 0.25 * + (RZ (pois->phi, r, z) + + RZ (pois->phi, r - 1, z) + + RZ (pois->phi, r, z - 1) + + RZ (pois->phi, r - 1, z - 1)); + } + +} + +/** @brief photo_interpol_set QQQQ? */ +int +photo_interpol_set (mapper_t *mapper, grid_t *source, interpol_t *interpol, + int pr, int pz, int itheta) +{ + pois_grid_t *pois; + + pois = (pois_grid_t*) source; + + interpol_set_stencil (interpol, + r_at (pr, pois->level), + z_at (pz, pois->level), + RZ (pois->phi, pr, pz), + RZ (pois->phi, pr, pz + 1), + RZ (pois->phi, pr + 1, pz), + RZ (pois->phi, pr + 1, pz + 1)); + + return TRUE; +} + +/** @brief photo_interpol QQQQ? */ +void +photo_interpol (mapper_t *mapper, grid_t *source, grid_t *target, + interpol_t *interpol, int ir, int iz, int itheta) +{ + double r, z; + cdr_grid_t *cdr; + + cdr = (cdr_grid_t *) target; + + r = r_at (ir, cdr->level); + z = z_at (iz, cdr->level); + + RZT (cdr->photo, ir, iz, itheta) = interpol_apply (interpol, r, z); +} + + +/** @brief Registers a photoionization term with given @a A and @a lambda. */ +void +photo_register (double A, double lambda) +{ + photo_term_t *t; + + t = (photo_term_t *) xmalloc (sizeof (photo_term_t)); + + t->A = A; + t->lambda = lambda; + t->next = photo_terms; + + photo_terms = t; +} + +/** @brief Copies a list of photo terms into @a *dest. */ +void +photo_copy_list (photo_term_t *src, photo_term_t **dest) +{ + photo_term_t *ptr_term; + photo_term_t *p = NULL, *p1; + + *dest = NULL; + + while (src) { + p1 = (photo_term_t *) xmalloc (sizeof (photo_term_t)); + if (p) { + p->next = p1; + } else { + *dest = p1; + } + + p = p1; + p->A = src->A; + p->lambda = src->lambda; + src = src->next; + } + + if (p) p->next = NULL; +} + + +/** @brief Unregisters all the photoionization terms and + * frees the allocated space. + */ +void +photo_unregister_all (void) +{ + photo_term_t *t, *next; + + for (t = photo_terms; t; t = next) { + next = t->next; + free (t); + } + + photo_terms = NULL; +} + +/** @brief Transforms back the photoionization calculation into real space. */ +void +photo_dft_r (cdr_grid_t *grid, int sign) +{ + cdr_grid_t *leaf; + + debug (3, "photo_dft_r(" grid_printf_str ", %d)\n", + grid_printf_args(grid), sign); + + iter_childs (grid, leaf) { + photo_dft_r (leaf, sign); + } + + dft_transform (grid->photo, grid->photo, sign); +} + +/** @brief Copies the derivative of the ion density into cdr->charge + * + * The ion density, which is supposed to be at this point, the impact + * ionization) into cdr->charge, which will be used as the source for + * the Poisson/Helmholtz solver. */ +void +photo_copy_source (cdr_grid_t *grid) +{ + int ir, iz, itheta; + + debug(3, "photo_copy_source (" grid_printf_str ")\n", + grid_printf_args(grid)); + +#pragma omp parallel + { +#pragma omp for private (ir, iz) + iter_grid_3d_n (grid, ir, iz, itheta, 2) { + RZT (grid->charge, ir, iz, itheta) = + RZT (grid->d_dens[ions], ir, iz, itheta) / grid->ntheta; + } + } +} + +/** @brief Recursive version of @a photo_copy_source. */ +mk_recursive (photo_copy_source, cdr_grid_t) + +/** @brief Once a photoionization term is computed, we add it to d_dens. + * + * Note that we already copied the contents of d_dens[ions] into + * charge, so when we solve again the Helholtz equation, the source + * is still the same. + */ +void +photo_add_term (photo_term_t *term, cdr_grid_t *cdr) +{ + int s, ir, iz, itheta; + int updated[2] = {electrons, photo_ions}; + + debug (3, "photo_add_term (" photo_printf_str ", " grid_printf_str ")\n", + photo_printf_args(term), grid_printf_args(cdr)); + +#pragma omp parallel + { +#pragma omp for private (ir, iz, s) + iter_grid_3d_n (cdr, ir, iz, itheta, 2) { + for (s = 0; s < 2; s++) { + RZT (cdr->d_dens[updated[s]], ir, iz, itheta) += + term->A * RZT (cdr->photo, ir, iz, itheta); + } + } + } +} + +/** @brief ...and the recursive version of @a photo_add_term */ +void +photo_add_term_r (photo_term_t *term, cdr_grid_t *cdr) +{ + cdr_grid_t *child; + + photo_add_term (term, cdr); + + iter_childs (cdr, child) { + photo_add_term_r (term, child); + } +} + +/** @brief photo_calc_term QQQQ */ +pois_grid_t ** +photo_calc_term (photo_term_t *term, cdr_grid_t *cdr, int i) +{ + /* Call to the generic Poisson/Helmholtz solver */ + if (i == 1) { + return pois_gen_solve_a (cdr, pois_photo_2, photo_mappers, term->lambda); + } else { + return pois_gen_solve_a (cdr, pois_photo_1, photo_mappers, term->lambda); + } +} + +/** @brief Calculates the photoionization and adds it to the derivatives + * of the species densities. */ +void +photo_calc (photo_term_t *terms, cdr_grid_t *cdr) +{ + pois_grid_t **pois_modes; + photo_term_t *term; + // photo_term_t *ptr_term; + + photo_copy_source_r (cdr); + + if (cdr->ntheta != 1) + cdr_dft_charge_r (cdr, 1); + + // for (ptr_term = terms; ptr_term != NULL; ptr_term = ptr_term->next) { + // printf("terms: A=%g lambda=%g ptr=%d\n", ptr_term->A, ptr_term->lambda, (int)ptr_term->next); + // } + + int j = 0; + for (term = terms; term; term = term->next ) { + int i; + pois_modes = photo_calc_term (term, cdr, j); + j++; + if (cdr->ntheta != 1) + photo_dft_r (cdr, -1); + + photo_add_term_r (term, cdr); + debug (3, "photo_calc (" photo_printf_str ", " grid_printf_str ")\n", + photo_printf_args(term), grid_printf_args(cdr)); + + /* Free the allocated memory. */ + for (i = 0; i < max_ntheta; i++) { + pois_free_r (pois_modes[i]); + } + free (pois_modes); + } +} + +/** @brief Loads a photoionization file, consisting in a series of rows with + @a A and @a lambda. */ +void +photo_load_file (char *fname) +{ + FILE *fp; + double A, lambda; + int c; + int i; + + printf("\n"); + printf ("Loading photoionization data from `%s'...\n", fname); + printf("\n"); + fp = fopen (fname, "r"); + + if (NULL == fp) { + warning ("Unable to open photoionization file `%s'\n", fname); + exit (-1); + return; + } + + + i=0; + do { + c = fscanf (fp, "%lf %lf", &A, &lambda); + if (c != 2) { + break; + } + + printf ("Registring photoionization term A = %.5g, lambda = %.4g\n", + A, lambda); + + photo_register (A, lambda); + i++; + } while (TRUE); + printf("\n"); + + fclose (fp); +} diff --git a/src/poisson.c b/src/poisson.c new file mode 100644 index 0000000000000000000000000000000000000000..ddde15b19c0ec17a6c1e81150c846b72c11f5710 --- /dev/null +++ b/src/poisson.c @@ -0,0 +1,1564 @@ +/** @file poisson.c + * @brief Poisson/Helmholtz solver, including the routines for + * inhomogeneous (point-plane) configurations. + */ +#include +#include +#include + +#include "cdr.h" +#include "cstream.h" +#include "fishpack.h" +#include "grid.h" +#include "interpol2.h" +#include "mapper.h" +#include "parameters.h" +#include "poisson.h" +#include "proto.h" +#include "rz_array.h" +#include "species.h" + +static void get_bound_cond (pois_grid_t *grid, pois_problem_t *prob, + int *r_bound_cond, int *z_bound_cond, + double lambda); +static int needs_refinement (pois_grid_t *grid, int ir, int iz, + double threshold); +static int refine_in (pois_grid_t *grid, int cr0, int cz0, int cr1, int cz1); + +decl_mapper_funcs(er); +decl_mapper_funcs(ez); +decl_mapper_funcs(etheta); +decl_mapper_funcs(charge); +/*!< Here we set three mapper_t objects that specify how we should do + * the mapping between the potential (once it is calculated) and the three + * components of the electric field. + */ + +/* Global variables for the computations of inhomogeneous fields: + * initialized in pois_inhom_init. */ + +int pois_gridpoints_z, pois_gridpoints_r; +/*!< Number of gridpoints at level 0 of the poisson solver + * + * if !pois_inhom, this has to be equal to the parameter gridpoins_z. + * We also allow a different extension in r, albeit this is not yet used. + */ + +double pois_inhom_L; /*!< Total length of the poisson domain. */ +double pois_inhom_z; /*!< Location of the floating charge. */ +double pois_inhom_dphi; +/*!< Potential difference between the electrodes created by a unit charge + * located at (0, pois_inhom_z) + */ + +double pois_inhom_fixed_q_t; +/*!< Time-dependent fixed charge for the inhomogeneous poisson code + * It is updated in cstream_set_field_at_time acording to the parameter + * rise_time. + */ + +extern double E_x, E_y, E_z; + +static double inhom_phi_term (double r, double z, double b); +static double inhom_e_term (double r, double z, double b); +static double inhom_er_term (double r, double z, double b); +static double inhom_ez_term (double r, double z, double b); +/*!< To calculate the potential and electric fields created by a unit charge + * between two planar electrodes, we use the "mirror charges method" + * the contribution of each mirror charge is given by these functions. + */ + +mapper_t er_mapper = mk_mapper_staggered (er, &interpol_bilin, 0, -1); +mapper_t ez_mapper = mk_mapper_staggered (ez, &interpol_bilin, -1, 0); +mapper_t etheta_mapper = mk_mapper (etheta, &interpol_quadratic); +mapper_t *e_mappers[] = {&er_mapper, &ez_mapper, ðeta_mapper, NULL}; +/*!< These are the mapper structures to translate between cdr and poisson + * grids. See mapper.c and mapper.h for more info. + */ + +mapper_t charge_mapper = mk_mapper_down(charge, &interpol_wackers); +mapper_t *charge_mappers[] = {&charge_mapper, NULL}; + +pois_problem_t *pois_electrostatic; + +/** @brief All initialization of the Poisson solver has to be here. */ +void +pois_init (void) +{ + if (pois_inhom) { + pois_inhom_init (); + } + else { + pois_gridpoints_z = gridpoints_z; + } + pois_gridpoints_r = gridpoints_r; + + pois_electrostatic = xmalloc (sizeof (pois_problem_t)); + + pois_electrostatic->max_level = pois_max_level; + pois_electrostatic->extra_levels = extra_pois_levels; + pois_electrostatic->max_error = pois_max_error; + + pois_electrostatic->bnd_right = pois_bnd_right; + pois_electrostatic->bnd_top = pois_bnd_top; + pois_electrostatic->bnd_bottom = pois_bnd_bottom; +} + +/** @brief Creates a 2D Poisson grid. */ +pois_grid_t* +pois_new_a (int r0, int z0, int r1, int z1) +{ + pois_grid_t *grid; + + grid = pois_new_3d_a (r0, z0, r1, z1, 1); + + return grid; +} + +/** @brief Creates a new 3D Poisson grid. + * + * @a r0, @a z0, @a r1, @a z1 are in GRID units + */ +pois_grid_t* +pois_new_3d_a (int r0, int z0, int r1, int z1, int ntheta) +{ + rz_array_t *phi, *charge, *error; + pois_grid_t *grid; + + debug (2, "pois_new_a (r0 = %d, z0 = %d, r1 = %d, z1 = %d)\n", + r0, z0, r1, z1); + + phi = rz_new_3d_a (r0, z0, r1, z1, ntheta); + error = rz_new_3d_a (r0, z0, r1, z1, ntheta); + +#ifdef F_PHI_SAME_AS_CHARGE + charge = phi; +#else + charge = rz_new_3d_a (r0, z0, r1, z1, ntheta); +#endif /* F_PHI_SAME_AS_CHARGE */ + + grid = (pois_grid_t *) xmalloc (sizeof (pois_grid_t)); + + grid->r0 = r0; + grid->r1 = r1; + grid->z0 = z0; + grid->z1 = z1; + grid->ntheta = ntheta; + + grid->phi = phi; + grid->charge = charge; + grid->error = error; + + /* By default, the array does not have any external boundary. */ + grid->ext_bound = BND_NONE; + + /* Initially, a grid does not have any relatives. */ + init_leaf (grid); + + return grid; +} + +/** @brief Frees the memory allocated by pois_new_a */ +void +pois_free (pois_grid_t *grid) +{ + debug (3, "pois_free (...)\n"); + + /* The decission of whether to use the same memory for the charge and + * the potential can be made elsewhere. + */ + if (grid->phi != grid->charge) + rz_free (grid->charge); + rz_free (grid->phi); + rz_free (grid->error); + + free (grid); +} + +/** @brief Recursively frees a tree of Poisson grids. */ +void +pois_free_r (pois_grid_t *grid) +{ + pois_grid_t *leaf; + + debug (3, "pois_free_r (" grid_printf_str ")\n", grid_printf_args (grid)); + + free_childs (grid, leaf, pois_free_r); + + pois_free (grid); +} + +/** @brief Creates a new Poisson grid. + * + * @a r0, @a r1... are in global units (i.e. independent of the grid level). + */ +pois_grid_t* +pois_new_glob_a (int r0, int z0, int r1, int z1, int level) +{ + debug (3, "pois_new_glob_a (%d, %d, %d, %d)\n", r0, r1, z0, z1); + pois_grid_t *grid; + + if (level >= 0) { + grid = pois_new_a (r0 << level, z0 << level, + r1 << level, z1 << level); + } else { + level = -level; + grid = pois_new_a (r0 >> level, z0 >> level, + r1 >> level, z1 >> level); + } + return grid; +} + +/** @brief Starts the tree of Poisson grids with the two coarsest ones. + * + * Receives the grid dimensions at level 0. + */ +pois_grid_t* +pois_init_tree_a (int r0, int z0, int r1, int z1) +{ + pois_grid_t *coarsest, *sub_coarsest; + int level; + + debug (3, "pois_init_tree_a (%d, %d, %d, %d)\n", r0, z0, r1, z1); + + level = -extra_pois_levels; + + coarsest = pois_new_glob_a (r0, z0, r1, z1, level); + coarsest->ext_bound = BND_MASK_ALL; + coarsest->level = level; + + sub_coarsest = pois_new_glob_a (r0, z0, r1, z1, level + 1); + + add_child (coarsest, sub_coarsest); + grid_inherit_ext_bound ((grid_t *) sub_coarsest); + + return coarsest; +} + +/** @brief Is it possible to use a single function to handle all four + * boundaries? + * + * Maybe this should be rewritten to use the interpol2 module? + */ +REAL* +pois_boundary_a (pois_grid_t *grid, int boundary) +{ + pois_grid_t *parent; + + /* Forget the 0s, they are there to shut up the compiler. */ + int stride = 0, ortho_stride = 0, icells, invert, n; + int rb, zb; + double interp_array[3][3] = {{-4.0, 1.0, 18.0}, + {-2.0, 78.0, 14.0}, + {-6.0, -7.0, 4.0}}; + + const double prefactor = 1 / 96.0; + REAL *bnd, *p, *lstart; + + debug (3, "pois_boundary_a (..., %d)\n", boundary); + + parent = grid->parent; + + /* First we check if the boundary is in r or in z. */ + if (boundary & BND_AT_Z) { + icells = grid->r1 - grid->r0; + zb = 1; rb = 0; + if (NULL != parent) { + stride = parent->phi->strides[R_INDX]; + ortho_stride = parent->phi->strides[Z_INDX]; + } + } else { + zb = 0; rb = 1; + icells = grid->z1 - grid->z0; + if (NULL != parent) { + stride = parent->phi->strides[Z_INDX]; + ortho_stride = parent->phi->strides[R_INDX]; + } + } + + debug (3, " grid->ext_bound = %d\n", grid->ext_bound); + + if (grid->ext_bound & BND_MASK (boundary)) { + /* If the boundary is external, we apply homogeneous Dirichlet/Neumann. */ + bnd = (REAL *) xcalloc (sizeof (REAL), icells); + debug (3, "pois_boundary_a (...) -> [0.0] * %d\n", icells); + + assert (grid->r1 != 0); + return bnd; + } else { + bnd = (REAL *) xmalloc (sizeof (REAL) * icells); + } + /* If the grid is root it should have returned in the previous if */ + assert (NULL != parent); + + /* Now we check if the boundary is at {r,z} minimum or {r,z} maximum */ + if (boundary & BND_MAX) { + lstart = RZP (parent->phi, + (grid->r1 >> 1) - 1 + rb, + (grid->z1 >> 1) - 1 + zb); + stride = -stride; + ortho_stride = -ortho_stride; + invert = TRUE; + } else { + lstart = RZP (parent->phi, (grid->r0 >> 1) - rb, (grid->z0 >> 1) - zb); + invert = FALSE; + } + + for (p = lstart, n = 0; n < icells; p += stride, n += 2) { + /* p points to the cell in the parent grid and p + stride points to + an adjacent cell. */ + double s = 0.0, s2 = 0.0; + int i, j; + for (i = -1; i <= 1; i++) { + for (j = -1; j <= 1; j++) { + s += *(p + i * stride + j * ortho_stride) * interp_array[i + 1][j + 1]; + s2 += *(p - i * stride + j * ortho_stride) * interp_array[i + 1][j + 1]; + } + } + if (!invert) { + bnd[n] = prefactor * s; + if (n < icells - 1) bnd[n + 1] = prefactor * s2; + } else { + bnd[icells - n - 1] = prefactor * s; + if (n < icells - 1) bnd[icells - n - 2] = prefactor * s2; + } + } + return bnd; +} + +/** @brief Solves the Poisson equation, calling the FISHPACK routine. + * + * Assumes that grid->charge is already set. + */ +void +pois_solve_grid (pois_grid_t *grid, pois_problem_t *prob, + double lambda, double s) +{ + REAL *boundaries[4]; + int i, z_bound_cond, r_bound_cond; + double rmin, rmax, zmin, zmax; + + debug (3, "pois_solve_grid (..., lambda = %f, s = %f)\n", lambda, s); + + for (i = 0; i < 4; i++) { + boundaries[i] = pois_boundary_a (grid, i); + debug (3, "boundaries[%d] = %p\n", i, boundaries[i]); + } + +#ifndef F_PHI_SAME_AS_CHARGE + rz_copy (grid->charge, grid->r0, grid->z0, + grid->phi, grid->r0, grid->z0, + grid->r1 - grid->r0, grid->z1 - grid->z0); +#endif + + rmin = grid->r0 * dr[grid->level]; + rmax = grid->r1 * dr[grid->level]; + zmin = grid->z0 * dz[grid->level]; + zmax = grid->z1 * dz[grid->level]; + + debug (3, "HSTCYL/HSTCRT in a grid %d x %d\n", grid->r1 - grid->r0, + grid->z1 - grid->z0); + + get_bound_cond (grid, prob, &r_bound_cond, &z_bound_cond, lambda); + +#ifndef TRUE2D + fish_hstcyl (rmin, rmax, grid->r1 - grid->r0, + r_bound_cond, boundaries[BND_LEFT], boundaries[BND_RIGHT], + zmin, zmax, grid->z1 - grid->z0, + z_bound_cond, boundaries[BND_BOTTOM], boundaries[BND_TOP], + lambda, s, + RZP (grid->phi, grid->r0, grid->z0), + grid->phi->strides[Z_INDX]); +#else + fish_hstcrt (rmin, rmax, grid->r1 - grid->r0, + r_bound_cond, boundaries[BND_LEFT], boundaries[BND_RIGHT], + zmin, zmax, grid->z1 - grid->z0, + z_bound_cond, boundaries[BND_BOTTOM], boundaries[BND_TOP], + lambda, + RZP (grid->phi, grid->r0, grid->z0), + grid->phi->strides[Z_INDX]); +#endif + debug (3, "Finished HSTCYL/HSTCRT in a grid %d x %d\n", grid->r1 - grid->r0, + grid->z1 - grid->z0); + + pois_set_phi_boundaries (grid, boundaries, + (grid->ext_bound & BND_MASK (BND_LEFT)) + && 0. == lambda, + + prob->bnd_right == BND_CND_HNEUMANN + && (grid->ext_bound & BND_MASK (BND_RIGHT)), + + prob->bnd_bottom == BND_CND_HNEUMANN + && (grid->ext_bound & BND_MASK (BND_BOTTOM)), + + prob->bnd_top == BND_CND_HNEUMANN + && (grid->ext_bound & BND_MASK (BND_TOP))); + + for (i = 0; i < 4; i++) { + debug (3, "boundaries[%d] = %p\n", i, boundaries[i]); + free (boundaries[i]); + } + debug (3, " <- pos_solve_grid (...)\n"); +} + +/** @brief Gets the boundary conditions that we pass to FISHPACK. + * + * Note that we use the same conditions for the Poisson equation + * and for the Helmholtz equation used to find the photoionization + * source. From my point of view, it doesn't make sense to use different + * conditions, so that will simply add an unneccesary complication. + */ +static void +get_bound_cond (pois_grid_t *grid, pois_problem_t *prob, + int *r_bound_cond, int *z_bound_cond, double lambda) +{ + static int right_inside[] = {FISH_UNS_DIR, FISH_NEU_DIR, FISH_DIR_DIR}; + static int right_ext_neu[] = {FISH_UNS_NEU, FISH_NEU_NEU, FISH_DIR_NEU}; + static int *right_ext_dir = right_inside; + static int fish_order[4] = { FISH_DIR_DIR, FISH_DIR_NEU, + FISH_NEU_DIR, FISH_NEU_NEU}; + + int bottom, top; + int *right_sel; + + if ((grid->ext_bound & BND_MASK (BND_TOP)) + && prob->bnd_top == BND_CND_HNEUMANN) + top = 1; + else top = 0; + + if ((grid->ext_bound & BND_MASK (BND_BOTTOM)) + && prob->bnd_bottom == BND_CND_HNEUMANN) + bottom = 1; + else bottom = 0; + + *z_bound_cond = fish_order[(bottom << 1) + top]; + + if ((grid->ext_bound & BND_MASK (BND_RIGHT))) { + if (prob->bnd_right == BND_CND_HNEUMANN) + right_sel = right_ext_neu; + else + right_sel = right_ext_dir; + } else { + right_sel = right_inside; + } + +#ifndef TRUE2D + *r_bound_cond = ((grid->ext_bound & BND_MASK (BND_LEFT)) && 0. == lambda)? + right_sel[0]: right_sel[2]; +#else + *r_bound_cond = ((grid->ext_bound & BND_MASK (BND_LEFT))? + right_sel[1]: right_sel[2]); +#endif + +} + +/** @brief Uses the @a boundaries[] vectors to set the boundaries by + * interpolation for the phi array of a grid. + * + * (in the extra space we allocated when we created the array). + * xxx_neu tells us if the xxx boundary has Neumann b.c. + * (or unspecified, as FISHPACK calls them if they are applied in the axis) + * + * TODO: Please rewrite this mess. + */ +void +pois_set_phi_boundaries (pois_grid_t *grid, REAL *boundaries[], + int left_neu, int right_neu, int bottom_neu, + int top_neu) +{ + int i; + + debug (3, "pois_set_phi_boundaries (...)\n"); + + if ((grid->ext_bound & BND_MASK(BND_BOTTOM)) && bottom_neu) { + for (i = grid->r0; i < grid->r1; i++) { + RZ (grid->phi, i, grid->z0 - 1) = RZ (grid->phi, i, grid->z0); + } + } else { + for (i = grid->r0; i < grid->r1; i++) { + RZ (grid->phi, i, grid->z0 - 1) = + 2 * boundaries[BND_BOTTOM][i - grid->r0] - RZ (grid->phi, i, grid->z0); + } + } + + if ((grid->ext_bound & BND_MASK(BND_TOP)) && top_neu) { + for (i = grid->r0; i < grid->r1; i++) { + RZ (grid->phi, i, grid->z1) = RZ (grid->phi, i, grid->z1 - 1); + } + } else { + for (i = grid->r0; i < grid->r1; i++) { + RZ (grid->phi, i, grid->z1) = 2 * boundaries[BND_TOP][i - grid->r0] + - RZ(grid->phi, i, grid->z1 - 1); + } + } + + if (left_neu) { + for (i = grid->z0; i < grid->z1; i++) { + RZ (grid->phi, grid->r0 - 1, i) = RZ(grid->phi, grid->r0, i); + } + } else { + for (i = grid->z0; i < grid->z1; i++) { + RZ(grid->phi, grid->r0 - 1, i) = 2 * boundaries[BND_LEFT][i - grid->z0] + - RZ(grid->phi, grid->r0, i); + } + } + + if (right_neu) { + for (i = grid->z0; i < grid->z1; i++) { + RZ (grid->phi, grid->r1, i) = RZ(grid->phi, grid->r1 - 1, i); + } + } else { + for (i = grid->z0; i < grid->z1; i++) { + RZ(grid->phi, grid->r1, i) = 2 * boundaries[BND_RIGHT][i - grid->z0] + - RZ(grid->phi, grid->r1 - 1, i); + } + } + + /* This is quite nightmarish. Think about rewritting. */ + if ((grid->ext_bound & BND_MASK(BND_RIGHT)) && right_neu) { + RZ(grid->phi, grid->r1, grid->z0 - 1) = RZ(grid->phi, grid->r1 - 1, + grid->z0 - 1); + RZ(grid->phi, grid->r1, grid->z1) = RZ(grid->phi, grid->r1 - 1, + grid->z1); + } else { + RZ(grid->phi, grid->r1, grid->z0 - 1) = + RZ(grid->phi, grid->r1 - 1, grid->z0 - 1) + + RZ(grid->phi, grid->r1, grid->z0) + - 0.5 * (RZ(grid->phi, grid->r1 - 2, grid->z0 - 1) + + RZ(grid->phi, grid->r1, grid->z0 + 1)); + + RZ(grid->phi, grid->r1, grid->z1) = + RZ(grid->phi, grid->r1 - 1, grid->z1) + + RZ(grid->phi, grid->r1, grid->z1 - 1) + - 0.5 * (RZ(grid->phi, grid->r1 - 2, grid->z1) + + RZ(grid->phi, grid->r1, grid->z1 - 2)); + } + + if ((grid->ext_bound & BND_MASK(BND_LEFT)) && left_neu) { + RZ(grid->phi, grid->r0 - 1, grid->z0 - 1) = RZ(grid->phi, grid->r0, + grid->z0 - 1); + RZ(grid->phi, grid->r0 - 1, grid->z1) = RZ(grid->phi, grid->r0, + grid->z1); + } else { + RZ(grid->phi, grid->r0 - 1, grid->z0 - 1) = + RZ(grid->phi, grid->r0, grid->z0 - 1) + + RZ(grid->phi, grid->r0 - 1, grid->z0) + - 0.5 * (RZ(grid->phi, grid->r0 + 1, grid->z0 - 1) + + RZ(grid->phi, grid->r0 - 1, grid->z0 + 1)); + + RZ(grid->phi, grid->r0 - 1, grid->z1) = + RZ(grid->phi, grid->r0, grid->z1) + + RZ(grid->phi, grid->r0 - 1, grid->z1 - 1) + - 0.5 * (RZ(grid->phi, grid->r0 + 1, grid->z1) + + RZ(grid->phi, grid->r0 - 1, grid->z1 - 2)); + } +} + +/** @brief Estimates the error on this grid by comparing with the calculations + * for his parent and performing a Richardson extrapolation. + */ +void +pois_set_error (pois_grid_t *grid) +{ + pois_grid_t *parent; + interpol_t *interpol; + int pr, pz; + + debug (3, "pois_set_error(...)\n"); + + parent = grid->parent; + assert (NULL != parent); + + interpol = interpol_new_a (2.0, 2.0, &interpol_wackers); + + iter_grid_parent (grid, pr, pz) { + int i, j; + + interpol_set_stencil_at ((grid_t *) grid, interpol, + pr * 2.0 + 1, pz * 2.0 + 1, + parent->phi, pr, pz, 0); + for (i = 0; i < 2; i++) + for (j = 0; j < 2; j++) { + int cr, cz; + double v; + + cr = (pr << 1) + i; + cz = (pz << 1) + j; + + v = interpol_apply (interpol, (double) cr + 0.5, (double) cz + 0.5); + + /* The error will only be used as its abs value. Therefore + we calculate it here and forever. */ + RZ (grid->error, cr, cz) = fabs (RZ (grid->phi, cr, cz) - v); + + } + } + interpol_free (interpol); +} + +/** @brief The refinement routine. + * + * Threshold is initially pois_max_error, but if we get too large refinement + * it can be increased (after warning the user that we are not reaching + * the accuracy that he asked for). + */ +int +pois_refine (pois_grid_t *grid, double threshold) +{ + int ir, iz; + int zmin, zmax, rmin, rmax; + /* Be careful: cz1 and cr1 are inclusive: when the child is actually + created, one has to increse them by 1. */ + int cr0, cr1, cz0, cz1; + int all_ok = TRUE; + + int tainted_line = FALSE; + + debug (3, "pois_refine(...)\n"); + + /* Initially we set values out of the grid, so the first comparisons + * always change the values. + */ + cr0 = grid->r1; cr1 = grid->r0 - 1; + cz0 = grid->z1; cz1 = grid->z0 - 1; + + /* The boundary can only coincide with the parent's boundary if this + * is an external boundary. + */ + rmin = (grid->ext_bound & BND_MASK(BND_LEFT))? grid->r0: (grid->r0 + 1); + rmax = (grid->ext_bound & BND_MASK(BND_RIGHT))? grid->r1: (grid->r1 - 1); + zmin = (grid->ext_bound & BND_MASK(BND_BOTTOM))? grid->z0: (grid->z0 + 1); + zmax = (grid->ext_bound & BND_MASK(BND_TOP))? grid->z1: (grid->z1 - 1); + + for (iz = zmin; iz < zmax && all_ok; iz++) { + tainted_line = FALSE; + for (ir = rmin; ir < rmax; ir++) { + if (needs_refinement (grid, ir, iz, threshold)) { + tainted_line = TRUE; + if (ir < cr0) cr0 = ir; + if (ir > cr1) cr1 = ir; + } + } + if (tainted_line) { + if (iz < cz0) cz0 = iz; + if (iz > cz1) cz1 = iz; + } else if (cr1 >= cr0 && cz1 >= cz0) { + all_ok = all_ok && refine_in (grid, cr0, cz0, cr1, cz1); + cr0 = grid->r1; cr1 = grid->r0 - 1; + cz0 = grid->z1; cz1 = grid->z0 - 1; + } + } + + if (cr1 >= cr0 && cz1 >= cz0) { + all_ok = all_ok && refine_in (grid, cr0, cz0, cr1, cz1); + } + + /* If there was some error with some refinement, we delete the created + * sub-grids and go back to the caller, which has to increase the refinement + * threshold. + */ + if (!all_ok) { + pois_grid_t *leaf; + free_childs (grid, leaf, pois_free_r); + set_childless (grid); + } + return all_ok; +} + +#define REFINE_IN_MAX_WARN_CNT 20; + +/** @brief Refines and creates a new grid according to the coordinates given. + * + * (if the FISHPACK limit allows it). Returns TRUE if the refinement + * succeeded, FALSE otherwise (if the FISHPACK limit was exceeded). +*/ +static int +refine_in (pois_grid_t *grid, int cr0, int cz0, int cr1, int cz1) +{ + pois_grid_t *child; + int nr0, nr1, nz0, nz1; + static int warn_cnt = REFINE_IN_MAX_WARN_CNT; + + nr0 = cr0 << 1; + nz0 = cz0 << 1; + nr1 = (++cr1) << 1; + nz1 = (++cz1) << 1; + + if ((nr1 - nr0) > FISH_MAX_GRIDPOINTS || + (nz1 - nz0) > FISH_MAX_GRIDPOINTS) { + if (warn_cnt > 0) { + warning ("FISHPACK limit exceeded. Not refining grid " + grid_printf_str ".\n", nr0, nz0, nr1, nz1, grid->level + 1); + warn_cnt --; + } + if (warn_cnt == 0) { + warning ("No more warnings about FISHPACK limit.\n"); + warn_cnt --; + } + return FALSE; + } + + child = pois_new_a (nr0, nz0, nr1, nz1); + + add_child (grid, child); + grid_inherit_ext_bound ((grid_t *) child); + debug (3, "new child created {r0 = %d, z0 = %d, r1 = %d, z1 = %d, " + "level = %d}\n", child->r0, child->z0, child->r1, child->z1, + child->level); + + return TRUE; +} + +/** @brief Calculates the error measure of this grid. + * + * For debug/testing purposes + */ +void +pois_error_measures (pois_grid_t *grid, double *L1, double *L2, double *Lmax) +{ + int ir, iz, i; + double err; + *L2 = 0.0; + *L1 = 0.0; + *Lmax = 0.0; + i = 0; + + iter_grid (grid, ir, iz) { + i++; + err = RZ (grid->error, ir, iz); + if (err > *Lmax) *Lmax = err; + *L1 += err; + *L2 += err * err; + } + + *L1 /= i; + *L2 = sqrt (*L2 / i); + +} + +/** @brief Writes some error measures of this grid and its descendants + * into @a fp + */ +void +pois_write_error_r (pois_grid_t *grid, FILE *fp) +{ + double L1, L2, Lmax; + pois_grid_t *child; + + pois_error_measures (grid, &L1, &L2, &Lmax); + + fprintf (fp, "%d %g %g %g %g %g\n", grid->level, dr[grid->level], + dz[grid->level], L1, L2, Lmax); + + iter_childs (grid, child) { + pois_write_error_r (child, fp); + } +} + +/** @brief Takes a @a cdr tree and solves the Poisson equation for it. + * + * Returns a poisson tree. + */ +pois_grid_t ** +pois_solve_a (cdr_grid_t *cdr, pois_problem_t *prob) +{ + /* Call to the generic Poisson/Helmholtz solver */ + return pois_gen_solve_a (cdr, prob, e_mappers, 0.0); +} + +/** @brief Solves a Poisson/Helmholtz equation with FISHPACK and maps + * the result using a given set of mapper. + * + * From this method downwards (in the sense of calling order, not file + * organization), all the code is shared by the Poisson solver and the + * Photoionization (Helmholtz) solver. + */ +pois_grid_t ** +pois_gen_solve_a (cdr_grid_t *cdr, pois_problem_t *prob, + mapper_t **mappers, double es) +{ + cdr_grid_t *tree; + pois_grid_t **pois_modes; + int mode; + + pois_modes = (pois_grid_t**) xmalloc (sizeof(pois_grid_t*) * max_ntheta); + assert (0 == cdr->level); + tree = cdr_add_coarser_grids_a (cdr, prob->extra_levels); + + /* This is the high-level parallelizable loop! */ +#pragma omp parallel + { +#pragma omp for schedule(dynamic) + for (mode = 0; mode < max_ntheta; mode++) { + pois_modes[mode] = pois_solve_mode (tree, cdr, prob, mode, es); + + if (pois_inhom && es == 0.0 && mode == 0) { + /* Add the inhomogeneous laplacian potential to phi. + * It has only to be added to the zero mode. + */ + double q_factor; + q_factor = pois_inhom_q_factor (pois_modes[0]); + + /* Was: + pois_add_inhom_phi_r (pois_modes[0], q_factor); + */ + pois_add_inhom_phi_r (pois_modes[0], -q_factor); + } + + /* For the interpolation, we require an extra buffer cell + * in some boundaries and we check for overflows inside the + * mapper methods. + */ + map_trees_r (mappers, (grid_t*) pois_modes[mode], (grid_t*) cdr, + mode, FALSE, TRUE, FALSE, + /*s_buf = */ 2, + /*t_buf = */ 4); + map_trees_r (mappers, (grid_t*) pois_modes[mode], (grid_t*) cdr, + mode, TRUE, FALSE, TRUE, + /*s_buf = */ 1, + /*t_buf = */ 2); + } + } + cdr_free_coarser_grids (tree, extra_pois_levels); + + return pois_modes; +} + +/** @brief Solves a single Fourier mode. + * + * @a tree is the root of the @a cdr tree with extra_pois_levels added. + * @a cdr is the cdr grid at level 0, contained in tree: + * + * cdr = tree->first_child->firts_child...->first_child + * \_________ extra_pois_levels __________/ + */ +pois_grid_t * +pois_solve_mode (cdr_grid_t *tree, cdr_grid_t *cdr, pois_problem_t *prob, + int mode, double es) +{ + pois_grid_t *pois; + + pois = pois_init_tree_a (0, 0, pois_gridpoints_r, pois_gridpoints_z); + + /* Solves the coarsest Poisson grid. */ + /* Changed Wed Mar 19 13:50:23 2008: was s_buf = 1. */ + map_trees_r (charge_mappers, (grid_t *) tree, (grid_t *) pois, + mode, TRUE, TRUE, FALSE, 0, 2); + pois_solve_grid (pois, prob, -w2k[mode], es); + + /* Wed May 14 11:00:30 2008: + * I divide pois_max_error by abs(wk[mode]) because in the calculation + * of e_theta, the errors get multiplied by wk[mode]. Hence if we + * want to get similar errors in all modes, we have to remove it from the + * threshold. The 1 is because wk[0] = 0, but we do not want to have + * a \inf threshold. + */ + pois_solve_r (pois->first_child, tree, prob, mode, es, + prob->max_error / (1 + abs(wk[mode]))); + + return pois; +} + +#define POIS_SOLVE_R_MAX_WARN 50 + +/** @brief Recursively solves one Poisson grid. */ +void +pois_solve_r (pois_grid_t *pois, cdr_grid_t *cdr, pois_problem_t *prob, + int mode, double es, double threshold) +{ + pois_grid_t *child; + int succeeded = FALSE; + static int warn_cnt = POIS_SOLVE_R_MAX_WARN; + + /* Changed Wed Mar 19 13:51:00 2008: was s_buf = 1 */ + map_grid_r (charge_mappers, (grid_t *) cdr, (grid_t *) pois, + mode, TRUE, TRUE, FALSE, 0, 2); + debug(3, "w2k[mode = %d] = %f\n", mode, w2k[mode]); + + pois_solve_grid (pois, prob, -w2k[mode], es); + + if (pois->level >= prob->max_level) return; + + pois_set_error (pois); + + while (!succeeded) { + succeeded = pois_refine (pois, threshold); + + if (!succeeded) { + threshold *= 2; + if (warn_cnt > 0) { + warning ("Poisson error threshold was too small: trying %g.\ + Consider increasing pois_max_error\n", + threshold); + if (warn_cnt >= 0) warn_cnt --; + } + } + } + iter_childs (pois, child) { + pois_solve_r (child, cdr, prob, mode, es, threshold); + } +} + +/** @brief Returns 1 if the given cell has to be refined. + * + * which means that it satisfies at least one of the following: + * a. The error in the cell is larger than the threshold. + * b. The cell has a neightbour with an error larger than the threshold + */ +static int +needs_refinement (pois_grid_t *grid, int ir, int iz, double threshold) +{ + int i, j; + int r = FALSE; + int irmin, irmax, izmin, izmax; + + irmin = ir > grid->r0 + 3? ir - 1: grid->r0; + irmax = ir < grid->r1 - 4? ir + 1: grid->r1 - 1; + izmin = iz > grid->z0 + 3? iz - 1: grid->z0; + izmax = iz < grid->z1 - 4? iz + 1: grid->z1 - 1; + + for (i = irmin; i <= irmax && !r; i++) + for (j = izmin; j <= izmax; j++) + if (RZ(grid->error, i, j) > threshold) { + r = TRUE; + break; + } + + return r; +} + +/***************************************************************************** + * Functions for the implemetation of a needle-plate discharge. * + * The method used here is that of the "floating charge": * + * A charge is located at pois_inhom_z, which is used to keep the potential * + * at L_z constant. * + ****************************************************************************/ + +/** @brief pois_inhom_init QQQQ */ +void +pois_inhom_init (void) +{ + /* The domain of solution of the Poisson equation will be different + * from that of the CDR equation. The difference between them is + * given by the parameter needle_length, but has to be rounded + * to a multiple of the grid size at level 0. + */ + pois_gridpoints_z = (gridpoints_z + + (int) nearbyint (needle_length / dz[0])); + pois_inhom_L = pois_gridpoints_z * dz[0]; + + pois_inhom_z = L_z + needle_radius; + pois_inhom_dphi = pois_inhom_phi (0, pois_inhom_L) - pois_inhom_phi (0, L_z); + +} + +/* We use the following functions to calculate the fields and potential + * created by a unit charge located at (r = 0, z = b). + * These are created by the method of mirror charges, with a total of + * pois_inhom_reflections charges. + */ + +/* Single term of phi. */ +static double +inhom_phi_term (double r, double z, double b) +{ + double insqrt; + + insqrt = (SQ(z - b) + SQ(r)); + + return invfourpi / sqrt (insqrt); +} + +/** @brief Common decay factor for the electric fields. */ +static double +inhom_e_term (double r, double z, double b) +{ + double insqrt; + + insqrt = (SQ(z - b) + SQ(r)); + insqrt = insqrt * insqrt * insqrt; + + return invfourpi / sqrt (insqrt); +} + +/** @brief Single term of E_r. */ +static double +inhom_er_term (double r, double z, double b) +{ + return r * inhom_e_term (r, z, b); +} + +/** @brief Single term of E_z */ +static double +inhom_ez_term (double r, double z, double b) +{ + return (z - b) * inhom_e_term (r, z, b); +} + +/* Since we have to sum over the same locations of the mirror charges + * but with different "field functions", we use the following macro. + * + * Note that using a single function for inhom_phi, inhom_er, and inhom_ez + * would not be a good idea since they are evaluated at different points. + * Passing that function a pointer to another function would have been somewhat + * slower and, I think, not so readable. + */ +#define sum_reflections(total_, field_, r_, z_) \ + do { \ + int i__; \ + total_ = (field_ (r_, z_, pois_inhom_z) - \ + field_ (r_, z_, -pois_inhom_z)); \ + \ + for (i__ = 2; i__ <= pois_inhom_reflections; i__ += 2) { \ + total_ += (field_ (r_, z_, pois_inhom_z + i__ * pois_inhom_L) + \ + field_ (r_, z_, pois_inhom_z - i__ * pois_inhom_L)); \ + \ + total_ -= (field_ (r_, z_, -pois_inhom_z + i__ * pois_inhom_L) + \ + field_ (r_, z_, -pois_inhom_z - i__ * pois_inhom_L)); \ + } \ + } while (0) + +/** @brief Returns the potential created by a unit charge located at pois_inhom_z + * between an electrode at 0 and a second one at pois_inhom_L. + */ +double +pois_inhom_phi (double r, double z) +{ + double res; + + sum_reflections (res, inhom_phi_term, r, z); + + return res; +} + +/** @brief Radial component of the field. */ +double +pois_inhom_er (double r, double z) +{ + double res; + + sum_reflections (res, inhom_er_term, r, z); + + return res; +} + +/** @brief Axial component of the field. */ +double +pois_inhom_ez (double r, double z) +{ + double res; + + sum_reflections (res, inhom_ez_term, r, z); + + return res; +} + +/** @brief Once we have the electrostatic potential created by the space charges, + * we use this function to compute the multiplying factor of the floating + * charge. + * + * One can also forget about keeping the potential fixed somewhere and impose + * a constant (non-floating, but may depend on time) charge pois_inhom_fixed_q, + * which is used if nonzero. The use of that is to simulate a charged cloud + * close to the earth, which acts as an electrode: usually you would also combine + * that with the sprite module, that allows varing neutral densities. + */ +double +pois_inhom_q_factor (pois_grid_t *pois) +{ + double u; + /* Note that the signs preceding the numerical potentials are inverted since + * in our notation, we use the opposite of the physical one, in order + * to use the charge as the source of the Poisson equation. + */ + + if (pois_inhom_fixed_q != 0.0) { + return pois_inhom_fixed_q_t; + } + + /* Was: + u = - E_z * (pois_inhom_L - L_z) + pois_phi_at (pois, 0.0, L_z, 0.0); + */ + + u = E_z * (L_z - pois_inhom_L) + pois_phi_at (pois, 0.0, L_z, 0.0); + + return -u / pois_inhom_dphi; +} + +/** @brief Adds the potential created by the needle to a Poisson grid and their + * descendants. + * + * Note that \f$\phi\f$ here is in Fourier space and the Laplacian + * potential is always axi-symmetric, so you only have to call this function + * with the zero-mode of the Poisson grids. + * + * The reason that it is better to add the inhomogeneous field to the potential + * and not later to the electric fields is that if we do that, we will + * have to substract two large and very curved functions that give something + * close to zero: the error we make then will be comparable to the result. + */ +void +pois_add_inhom_phi_r (pois_grid_t *grid, double q) +{ + int ir, iz; + pois_grid_t *child; + double res; + + debug (2, "pois_add_inhom_phi_r (" grid_printf_str ", q = %f)\n", + grid_printf_args(grid), q); + + /* Note that there is no factor grid->ntheta coming from thr FFT + un-normalization. The reason is that actually q is sqrt(N) smaller + than it has to be and later, in the inverse FFT we will multiply by + sqrt(N). So everything is correct, I believe. */ + iter_grid_n (grid, ir, iz, 2) { + + sum_reflections (res, inhom_phi_term, r_at(ir, grid->level), z_at(iz, grid->level)); + + + RZ(grid->phi, ir, iz) += q * res; + } + + iter_childs (grid, child) { + pois_add_inhom_phi_r (child, q); + } +} + +/*************************************************************** + * Mapper functions for the components of the electric field. * + * See mapper.h for an explanation of each of these methods. * + ***************************************************************/ + +/** @brief er_copy QQQQ */ +void +er_copy (mapper_t *mapper, grid_t *source, grid_t *target, + int ir, int iz, int itheta) +{ + cdr_grid_t *cdr; + pois_grid_t *pois; + + cdr = (cdr_grid_t*) target; + pois = (pois_grid_t*) source; + + if (ir < pois->r1) + RZT (cdr->er, ir, iz, itheta) = ER_RZ (pois, ir, iz); +} + +/** @brief ez_copy QQQQ */ +void +ez_copy (mapper_t *mapper, grid_t *source, grid_t *target, + int ir, int iz, int itheta) +{ + cdr_grid_t *cdr; + pois_grid_t *pois; + + cdr = (cdr_grid_t*) target; + pois = (pois_grid_t*) source; + + if (iz < pois->z1) + RZT (cdr->ez, ir, iz, itheta) = EZ_RZ (pois, ir, iz); +} + +/** @brief etheta_copy QQQQ */ +void +etheta_copy (mapper_t *mapper, grid_t *source, grid_t *target, + int ir, int iz, int itheta) +{ + cdr_grid_t *cdr; + pois_grid_t *pois; + + cdr = (cdr_grid_t*) target; + pois = (pois_grid_t*) source; + + RZT (cdr->etheta, ir, iz, itheta) = RZ (pois->phi, ir, iz); +} + +/** @brief er_coarsen QQQQ */ +void +er_coarsen (mapper_t *mapper, grid_t *source, grid_t *target, + int ir, int iz, int itheta) +{ + cdr_grid_t *cdr; + pois_grid_t *pois; + int level_diff, er_ir, er_iz; + + cdr = (cdr_grid_t*) target; + pois = (pois_grid_t*) source; + + level_diff = pois->level - cdr->level; + + er_iz = (iz << level_diff) + (1 << (level_diff - 1)); + er_ir = ((ir + 1) << level_diff) - 1; + + if (grid_contains (source, er_ir, er_iz - 1, GRID_INSIDE) && + grid_contains (source, er_ir, er_iz, GRID_INSIDE)) { + + RZT (cdr->er, ir, iz, itheta) = 0.5 * (ER_RZ(pois, er_ir, er_iz) + + ER_RZ(pois, er_ir, er_iz - 1)); + } +} + +/** @brief ez_coarsen QQQQ */ +void +ez_coarsen (mapper_t *mapper, grid_t *source, grid_t *target, + int ir, int iz, int itheta) +{ + cdr_grid_t *cdr; + pois_grid_t *pois; + int level_diff, ez_ir, ez_iz; + + cdr = (cdr_grid_t*) target; + pois = (pois_grid_t*) source; + + level_diff = pois->level - cdr->level; + + ez_iz = ((iz + 1) << level_diff) - 1; + ez_ir = (ir << level_diff) + (1 << (level_diff - 1)); + + if (grid_contains (source, ez_ir - 1, ez_iz, GRID_INSIDE) && + grid_contains (source, ez_ir, ez_iz, GRID_INSIDE)) { + + RZT(cdr->ez, ir, iz, itheta) = 0.5 * (EZ_RZ(pois, ez_ir, ez_iz) + + EZ_RZ(pois, ez_ir - 1, ez_iz)); + } +} + +/** @brief etheta_coarsen QQQQ */ +void +etheta_coarsen (mapper_t *mapper, grid_t *source, grid_t *target, + int ir, int iz, int itheta) +{ + cdr_grid_t *cdr; + pois_grid_t *pois; + int level_diff, ez_ir, er_iz; + + cdr = (cdr_grid_t*) target; + pois = (pois_grid_t*) source; + + level_diff = pois->level - cdr->level; + + er_iz = (iz << level_diff) + (1 << (level_diff - 1)); + ez_ir = (ir << level_diff) + (1 << (level_diff - 1)); + + if (grid_contains (source, ez_ir, er_iz, GRID_INSIDE) && + grid_contains (source, ez_ir - 1, er_iz, GRID_INSIDE) && + grid_contains (source, ez_ir, er_iz - 1, GRID_INSIDE) && + grid_contains (source, ez_ir - 1, er_iz - 1, GRID_INSIDE)) { + + RZT (cdr->etheta, ir, iz, itheta) = 0.25 * + (RZ (pois->phi, ez_ir, er_iz) + + RZ (pois->phi, ez_ir - 1, er_iz) + + RZ (pois->phi, ez_ir, er_iz - 1) + + RZ (pois->phi, ez_ir - 1, er_iz - 1)); + } +} + +/** @brief er_interpol QQQQ */ +int +er_interpol_set (mapper_t *mapper, grid_t *source, interpol_t *interpol, + int pr, int pz, int itheta) +{ + pois_grid_t *pois; + + pois = (pois_grid_t*) source; + + /* When we set Neumann b.c. in one boundary and Dirichlet in the opposite + * a larger-than-usual error appears in the boundaries because we are + * matching potetntials in one side and fields in the other. The only way + * I see of avoiding this is to forget about the extrapolated values of + * the grids. But we still need those values on the external boundaries. + */ + if (pr < pois->r0 || pz < pois->z0 + || pr > pois->r1 - 1 || pz > pois->z1) + return FALSE; + + interpol_set_stencil (interpol, + er_r_at (pr - 1, pois->level), + er_z_at (pz - 1, pois->level), + ER_RZ (pois, pr - 1, pz - 1), + ER_RZ (pois, pr - 1, pz), + ER_RZ (pois, pr, pz - 1), + ER_RZ (pois, pr, pz)); + + return TRUE; +} + +/** @brief ez_interpol_set QQQQ */ +int +ez_interpol_set (mapper_t *mapper, grid_t *source, interpol_t *interpol, + int pr, int pz, int itheta) +{ + pois_grid_t *pois; + + pois = (pois_grid_t*) source; + + if (pr < pois->r0 || pz < pois->z0 + || pr > pois->r1 || pz > pois->z1 - 1) + return FALSE; + + interpol_set_stencil (interpol, + ez_r_at (pr - 1, pois->level), + ez_z_at (pz - 1, pois->level), + EZ_RZ (pois, pr - 1, pz - 1), + EZ_RZ (pois, pr - 1, pz), + EZ_RZ (pois, pr, pz - 1), + EZ_RZ (pois, pr, pz)); + return TRUE; +} + +/** @brief etheta_interpol_set QQQQ */ +int +etheta_interpol_set (mapper_t *mapper, grid_t *source, interpol_t *interpol, + int pr, int pz, int itheta) +{ + pois_grid_t *pois; + + pois = (pois_grid_t*) source; + + if (pr < pois->r0 || pz < pois->z0 + || pr > pois->r1 - 1|| pz > pois->z1 - 1) + return FALSE; + + interpol_set_stencil_at (source, interpol, + r_at (pr, pois->level), + z_at (pz, pois->level), + pois->phi, pr, pz, 0); + return TRUE; +} + +/** @brief er_interpol QQQQ */ +void +er_interpol (mapper_t *mapper, grid_t *source, grid_t *target, + interpol_t *interpol, int ir, int iz, int itheta) +{ + double er_r, er_z; + cdr_grid_t *cdr; + pois_grid_t *pois; + int level_diff; + + cdr = (cdr_grid_t *) target; + pois = (pois_grid_t *) source; + + level_diff = cdr->level - pois->level; + + /* Note that when pr = pois->r1, the electric field is calculated + * from the extrapolation of phi and it is hence less accurate. + * The same applies below to pz and pois->z1. + */ + if ((ir >> level_diff) >= pois->r1) return; + + er_r = er_r_at (ir, cdr->level); + er_z = er_z_at (iz, cdr->level); + + RZT (cdr->er, ir, iz, itheta) = interpol_apply (interpol, er_r, er_z); +} + +/** @brief ez_interpol QQQQ */ +void +ez_interpol (mapper_t *mapper, grid_t *source, grid_t *target, + interpol_t *interpol, int ir, int iz, int itheta) +{ + double ez_r, ez_z; + cdr_grid_t *cdr; + pois_grid_t *pois; + int level_diff; + + cdr = (cdr_grid_t *) target; + pois = (pois_grid_t *) source; + + level_diff = cdr->level - pois->level; + + if ((iz >> level_diff) >= pois->z1) return; + + ez_r = ez_r_at (ir, cdr->level); + ez_z = ez_z_at (iz, cdr->level); + + RZT (cdr->ez, ir, iz, itheta) = interpol_apply (interpol, ez_r, ez_z); +} + +/** @brief etheta_interpol QQQQ */ +void +etheta_interpol (mapper_t *mapper, grid_t *source, grid_t *target, + interpol_t *interpol, int ir, int iz, int itheta) +{ + double eth_r, eth_z; + cdr_grid_t *cdr; + + cdr = (cdr_grid_t *) target; + + eth_r = r_at (ir, cdr->level); + eth_z = z_at (iz, cdr->level); + + RZT (cdr->etheta, ir, iz, itheta) = + interpol_apply (interpol, eth_r, eth_z); +} + +/** @brief Mapping of the charge. */ +void +charge_copy (mapper_t *mapper, grid_t *source, grid_t *target, + int ir, int iz, int itheta) +{ + cdr_grid_t *cdr; + pois_grid_t *pois; + + pois = (pois_grid_t*) target; + cdr = (cdr_grid_t*) source; + + RZ (pois->charge, ir, iz) = RZT (cdr->charge, ir, iz, itheta); +} + +/** @brief charge_interpol_set QQQQ. */ +int +charge_interpol_set (mapper_t *mapper, grid_t *source, interpol_t *interpol, + int pr, int pz, int itheta) +{ + cdr_grid_t *cdr; + + cdr = (cdr_grid_t*) source; + + if (pr < cdr->r0 || pz < cdr->z0 + || pr > cdr->r1 - 1|| pz > cdr->z1 - 1) + return FALSE; + + interpol_set_stencil_at (source, interpol, + r_at (pr, cdr->level), + z_at (pz, cdr->level), + cdr->charge, pr, pz, itheta); + return TRUE; +} + +/** @brief charge_interpol QQQQ. */ +void +charge_interpol (mapper_t *mapper, grid_t *source, grid_t *target, + interpol_t *interpol, + int ir, int iz, int itheta) +{ + double r, z; + pois_grid_t *pois; + + pois = (pois_grid_t *) target; + + r = r_at (ir, pois->level); + z = z_at (iz, pois->level); + + RZT (pois->charge, ir, iz, 0) = interpol_apply (interpol, r, z); +} + +/** @brief Finds the best-possible approximation for the potential at a given + * point (@a r, @a z, @a theta) by interpolating from the finest grid that covers + * that point. + */ +double +pois_phi_at (pois_grid_t *grid, double r, double z, double theta) +{ + int ir, iz, itheta, it, itn; + REAL phi_it[2]; + interpol_t *phi_at_interpol = NULL; + + debug (3, "pois_phi_at (" grid_printf_str ", r = %g, z = %g, theta = %g)\n", + grid_printf_args (grid), r, z, theta); + + grid = (pois_grid_t *) grid_finest_containing_r ((grid_t*) grid, r, z); + + if (NULL == grid) { + fatal ("In pois_phi_at: potential outside the grid"); + } + + phi_at_interpol = interpol_new_a (dr[grid->level], dz[grid->level], + &interpol_quadratic); + + ir = (int) (r / dr[grid->level]); + iz = (int) (z / dz[grid->level]); + + /* If r == 0, it doesn't matter which theta we use, so we use 0. + * also if we are in a 2D simulation. + */ + if (grid->ntheta > 1 && r > 0.0) { + itheta = (int) (theta / dtheta); + itn = 2; + } else { + itheta = 0; + itn = 1; + } + + for (it = 0; it < itn; it++) { + interpol_set_stencil_at ((grid_t *) grid, phi_at_interpol, + r_at (ir, grid->level), + z_at (iz, grid->level), + grid->phi, ir, iz, itheta + it); + + phi_it[it] = interpol_apply (phi_at_interpol, r, z); + } + + interpol_free (phi_at_interpol); + + if (grid->ntheta > 1 && r > 0.0) { + return (phi_it[0] * (theta - theta_at (itheta)) + + phi_it[1] * (theta_at (itheta + 1) - theta)) / dtheta; + } else { + return phi_it[0]; + } +} + +/** @brief Dumps all the contents of the given grid into filenames given by + * prefix and name + */ +void +pois_dump (pois_grid_t *grid, const char *prefix, const char *name) +{ + char *fname; + int m = pois_output_margin; + + asprintf (&fname, "%s/r.%s.tsv", prefix, name); + rz_axis_dump (fname, grid->r0 - m, grid->r1 + m, dr[grid->level]); + free (fname); + + asprintf (&fname, "%s/z.%s.tsv", prefix, name); + rz_axis_dump (fname, grid->z0 - m, grid->z1 + m, dz[grid->level]); + free (fname); + + asprintf (&fname, "%s/phi.%s.tsv", prefix, name); + rz_dump (grid->phi, fname, "w", grid->r0 - m, grid->z0 - m, + grid->r1 + m, grid->z1 + m); + free (fname); + + asprintf (&fname, "%s/charge.%s.tsv", prefix, name); + rz_dump (grid->charge, fname, "w", grid->r0 - m, grid->z0 - m, + grid->r1 + m, grid->z1 + m); + free (fname); + + asprintf (&fname, "%s/error.%s.tsv", prefix, name); + rz_dump (grid->error, fname, "w", grid->r0 - m, grid->z0 - m, + grid->r1 + m, grid->z1 + m); + free (fname); +} + +/** @brief Dumps all the contents of the given grid into filenames given by + * prefix and name + */ +void +pois_dump_r (pois_grid_t *grid, const char *prefix, const char *name) +{ + pois_grid_t *child; + char *cname; + int i = 0, nchilds; + char codes[] = "abcdefghijklmnopqrstuvwxyz"; + + pois_dump (grid, prefix, name); + + nchilds = grid_howmany_children ((grid_t *) grid); + + for (i = 0; i < nchilds; i++) { + child = (pois_grid_t *) grid_get_child ((grid_t*) grid, nchilds - i - 1); + + assert (NULL != child); + + if (i > sizeof(codes) - 2) + asprintf (&cname, "%s{%d}", name, i); + else + asprintf (&cname, "%s%c", name, codes[i]); + + pois_dump_r (child, prefix, cname); + free (cname); + } +} diff --git a/src/react_table.c b/src/react_table.c new file mode 100644 index 0000000000000000000000000000000000000000..34fe381774f1948b48e3b5654652fe7be7a4f9eb --- /dev/null +++ b/src/react_table.c @@ -0,0 +1,150 @@ +/** @file react_table.c + * @brief Handles the communication between the main code and the reaction tables. + * + * Rather than hardcoding a different function for each possible dependence + * of the reaction-rate on the electric field, these rate/field dependencies + * are written in a table. This allows reactions to be added/changed/removed + * without recompiling the source. + */ + +/* Structure of the reaction table file between ----- + +------ +Optional comments, maximum line length of 100 chars! +START +is_log +e_min +e_step +points +underflow +overflow +value(0) +value(1) +... +value(points-1) +----- + +Anything before 'START' is ignored. 'START' denotes the start of the actual data +and is case-sensitive. 'is_log' equals one if the electric field values are spaced +logarithmically. 'e_min' denotes the lowest value of the electric field for +which a data-point exists. 'e_step' is the difference in fieldstrength between +consecutive data-points and 'points' is the number of data-points. 'value(x)' are +the actual data-points. Note that anything after 'points' points is ignored. + +Underflow and overflow are reaction rates that are returned when the supplied field +strength is out of the bounds of the table. + +IMPORTANT: electric field values are 10-logarithmic. So instead of 'e_min' actually +denotes log10(e_min)! +IMPORTANT: electric field values must be (logarithmically) equi-distant! */ + +/* Example file + +----- +Sample reaction table. k(E) = E. 4 points are defined at E = 10^i, i \in {-2,-1,0,1}. +So the 'e_min' value is -2, 'e_step' is 1 and 'points' is 4. Overflow (100) and +underflow (0) values are added in case E-input values fall outside the bounds, in +this case E < 10^-2 or E > 10^1. +START +-2.0 +1 +4 +0.0 +100.0 +0.01 +0.1 +1.0 +10.0 +This bit is ignored by the program, so can be used for comments. Though if i had anything +useful to say, it would've probably been better placed at the start of the file! +----- +*/ + +#include +#include +#include + +#include "react_table.h" + +/** @brief Reads a reaction rate table from file @a filename and stores the + * table in the form of a 'react_table' at location @a r. +*/ +void +react_table_read(char *filename, react_table *r) +{ + FILE *fp; + char *comments, buffer[101]; + double e_min, e_step, underflow, overflow; + + int cnt; + + double values[MAX_TABLE_SIZE]; + + fp = fopen(filename,"r"); + if (fp == NULL) + { + fprintf(stderr,"Unable to load reaction table in file: %s -- Shutting down\n",filename); + exit(1); + } + + while (strncmp(buffer,"START",5) != 0) + fgets(buffer,100,fp); + + fgets(buffer,100,fp); + r->e_min = atof(buffer); + fgets(buffer,100,fp); + r->e_step = atof(buffer); + fgets(buffer,100,fp); + r->steps = atoi(buffer) - 1; + fgets(buffer,100,fp); + r->underflow = atof(buffer); + fgets(buffer,100,fp); + r->overflow = atof(buffer); + + for (cnt = 0; cnt <= r->steps; cnt++) + { + fgets(buffer,100,fp); + r->values[cnt] = atof(buffer); + } + + fclose(fp); +} + +/** @brief Computes an approximation for the reaction rate. + * + * Computes an approximation for the reaction rate at field-strength @a e + * by interpolating reaction rates from lookup table @a r. Stores the result + * in @a ra. + */ +void +react_table_lookup(react_table *r, double e, double *ra) +{ + int pos; + double e1, e2, val1, val2, log_e, res; + + // e == 0 is possible at initialization. + log_e = (e > 0) ? log10(e) : -1000.0; + + /* If the supplied fieldstrength falls outside the boundaries of the table, + return predetermined under-/overflow values. In most cases the underflow(overflow) + will be equal to the lowest(highest) of the specified values in the table. */ + if (log_e < r->e_min) { *ra = r->underflow; return; } + if (log_e > r->e_min + r->e_step * r->steps) { *ra = r->overflow; return; } + + pos = floor((log_e - r->e_min) / r->e_step); + val1 = r->values[pos]; + val2 = r->values[pos+1]; + e1 = pow(10, r->e_min + r->e_step * (double) pos); + e2 = e1 * pow(10, r->e_step); + + /* Linear interpolation of the 2 table values closest to e. + Note that the field-values in the table are logarithmic! */ + + res = val1 + ((val2 - val1) / (e2 - e1)) * (e - e1); + + /* Dirty tricks with pointers to get the return value right. The normal 'return' + statement would give a completely different value on the "other side". + + It's not pretty, but it works, so who cares? :) */ + *ra = res; +} diff --git a/src/reaction.c b/src/reaction.c new file mode 100644 index 0000000000000000000000000000000000000000..ebc92632a5711b1ff424b77f44350333e1f459bb --- /dev/null +++ b/src/reaction.c @@ -0,0 +1,231 @@ +/** @file reaction.c + * @brief Functions to handle the "reaction" part of + * convection-diffusion-reaction equation. + */ +#include +#include +#include + +#include "cdr.h" +#include "grid.h" +#include "parameters.h" +#include "photo.h" +#include "proto.h" +#include "react_table.h" +#include "species.h" +#include "reaction.h" + +static void fill_react_gaps (); + +reaction_t *reactions_list = NULL; +extern double z_cutoff; +double species_written[20]; + +/** @brief Returns the position in the species-array of a given species. + * + * Returns -1 if not found. */ +int +find_species_by_name(const char *spec_name) +{ + int res = -1; + int cnt; + + for (cnt = 0; cnt < no_species; cnt++) + { + if (strcmp(spec_index[cnt]->name, spec_name) == 0) + res = cnt; + } + + if (res == -1) { + printf("Species-lookup-failure: %s!\n",spec_name); + assert(1 == 0); + } + return res; +} + +/** @brief Adds a given reaction to the reaction list */ +void +react_add (reaction_t *react) +{ + react_table *rt; + + debug (3, "react_add (...)\n"); + + printf("Adding reaction with table: %s\n",react->tablefile); + + rt = (react_table *) xmalloc (sizeof(react_table)); + + if (react->tablefile != NULL) { + react_table_read(react->tablefile, rt); + react->rt = rt; + } + + react->next = reactions_list; + reactions_list = react; +} + +/** @brief Applies a reaction to the given @a grid */ +void +react_apply (reaction_t *react, cdr_grid_t *grid, int overwrite) +{ + int i, ir, iz, itheta; + rz_array_t *grid_in[REACTION_MAX_IN], *grid_out[REACTION_MAX_IN + REACTION_MAX_OUT], + *grid_eabs; + double *in = NULL, *out = NULL, eabs; + double test; + double rate; + int pos; + double e1, e2, val1, val2, log_e, res, r_mod; + int cnt, curr_species; + + debug (3, "react_apply (..., " grid_printf_str ")\n", + grid_printf_args (grid)); + + grid_eabs = grid->dens[no_species]; + + for (i = 0; i < react->nin; i++) { + grid_in[i] = grid->dens[react->input[i]]; + grid_out[i] = grid->d_dens[react->input[i]]; + } + + for (i = react->nin; i < react->nin + react->nout; i++) { + grid_out[i] = grid->d_dens[react->output[i - react->nin]]; + } + +#pragma omp parallel private(ir, iz, i, in, out) + { + /* malloc(0) is legal, but I do not want to play with fire. */ + if (react->nin > 0) { + in = (double *) xmalloc (sizeof(double) * react->nin); + } + + /* Do not know what use nout == 0 may have, (perhaps some debugging?) + but we leave it here as theoretically possible. */ + if (react->nout > 0) { + out = (double *) xmalloc (sizeof(double) * (react->nout + react->nin)); + } + + + #pragma omp for + iter_grid_theta(grid, itheta) { //ITER3 + iter_grid_z(grid, iz) { //ITER2 + double back_dens; + if (sprite_module) { + back_dens = spr_density_at (z_at (iz, grid->level)); + } else { + back_dens = 1.0; + } + + + iter_grid_r(grid, ir) { //ITER1 + if ( z_at (iz, grid->level) < z_cutoff ) { //IF1 + eabs = fabs (RZT(grid_eabs, ir, iz, itheta)); + for (i = 0; i < react->nin; i++) { + in[i] = fabs (RZT(grid_in[i], ir, iz, itheta)); + } + + log_e = log10(eabs); + + /* If the supplied fieldstrength falls outside the boundaries of the table, + return predetermined under-/overflow values */ + if (log_e < react->rt->e_min) { + rate = react->rt->underflow; + } else if (log_e > react->rt->e_min + react->rt->e_step * react->rt->steps) { + rate = react->rt->overflow; + } else { + pos = floor((log_e - react->rt->e_min) / react->rt->e_step); + val1 = react->rt->values[pos]; + val2 = react->rt->values[pos+1]; + e1 = pow(10, react->rt->e_min + react->rt->e_step * (double) pos); + e2 = e1 * pow(10, react->rt->e_step); + + rate = val1 + ((val2 - val1) / (e2 - e1)) * (eabs - e1); + } + + for (i = 0; i < react->nin; i++){ rate *= MYMAX(0, in[i]); } + + for (i = 0; i < react->nin + react->nout; i++) { //FOR1 + if (i < react->nin) { + curr_species = react->input[i]; r_mod = -rate; + } else { curr_species = react->output[i - react->nin]; r_mod = rate; } + + if (spec_index[curr_species]->charge != 0.0) { + RZT(grid_out[i], ir, iz, itheta) += r_mod; + } + } //FOR1 + } //IF1 + } //ITER1 + } //ITER2 + } //ITER3 + free (in); + free (out); + } +} + +/** @brief Recursive version of @a react_apply */ +void +react_apply_r (reaction_t *react, cdr_grid_t *grid, int overwrite) +{ + cdr_grid_t *child; + + react_apply (react, grid, overwrite); + + iter_childs (grid, child) { + react_apply_r (react, child, overwrite); + } +} + +/** @brief Sets the d_dens field of a grid to zero */ +void +zero_fill (cdr_grid_t* grid) +{ + int ir, iz, itheta, i; + + iter_grid_3d (grid, ir, iz, itheta) + for (i = 0; i < no_species; i++) { + RZT(grid->d_dens[i], ir, iz, itheta) = 0.0; + } +} + +/** @brief Applies all reactions to the given @a grid and his descendants */ +void +react_apply_all (cdr_grid_t *grid) +{ + reaction_t *react; + int overwrite; + int last = -1; + int cnt; + + zero_fill(grid); + + overwrite = TRUE; + + for (react = reactions_list; react; react = react->next) { + if (react->is_photo) { + photo_calc (photo_terms, grid); + } else { + react_apply_r (react, grid, overwrite); + } + overwrite = FALSE; + } +} + +/** @brief Fill in the gaps that we left in the definitions */ +static void +fill_react_gaps () +{ +} + +/** @brief Initializes the list of reactions. */ +void +react_init () +{ + /* Note that the reactions are applied in inverse order than listed here. */ + /* Rest of the kinetic model: */ + kinetic_init (); + +} + +/** Below this electric field, we do not waste time calculating anything. + Besides, this avoid NaNs for eabs == 0. */ +#define EPS_EABS 1e-6 diff --git a/src/rt.c b/src/rt.c new file mode 100644 index 0000000000000000000000000000000000000000..b8930553c3af4d05387e807f04c8458fe9be7988 --- /dev/null +++ b/src/rt.c @@ -0,0 +1,185 @@ +/** @file rt.c + * @brief Module of the Kinetics. */ + +#include +#include +#include +#include +#include + +#include "parameters.h" +#include "proto.h" +#include "species.h" +#include "reaction.h" + +#define MAX_SPECIES 15 +#define MAX_REACTIONS 30 +#define MAX_SEEDS 15 + +/** @brief Photoionization */ +reaction_t react_photo = {TRUE, 0, 0, {0}, {0}, {""}, {""}, NULL, NULL, NULL, 0.0, NULL}; + +species_t *spec_index[MAX_SPECIES]; +reaction_t *reaction_index[MAX_REACTIONS]; +seed_t *seed_index[MAX_SEEDS]; +int no_reactions; + +/** @brief Any initialization required by the kinetic model, has to be done + * in this function. + */ +void +kinetic_init (void) +{ + int cnt; + const char *filename; + + read_input_file(kin_input,filename); + + if (has_photoionization == 1) + { + react_add(&react_photo); + ions = find_species_by_name("dummyplus"); + photo_ions = find_species_by_name("xplus"); + } + + printf("\n"); + for (cnt = no_reactions; cnt > 0; cnt--) + react_add(reaction_index[cnt-1]); + + electrons = find_species_by_name("electrons"); +} + +/** @brief Reads the kinetic parameters (species, reactions) from file + * @a filename */ +void +read_input_file(const char *f_kinetic_name, const char *filename) +{ + config_t cfg_kinetic; + config_setting_t *setting; + species_t *temp_s; + reaction_t *temp_r; + seed_t *temp_se; + int i,cnt,cnt2; + + config_init(&cfg_kinetic); + + /* Read the file f_kinetic_name. If there is an error, report it and exit. */ + if(! config_read_file(&cfg_kinetic,f_kinetic_name)) + { + fprintf(stderr, "%s:%d - %s\n", config_error_file(&cfg_kinetic), + config_error_line(&cfg_kinetic), config_error_text(&cfg_kinetic)); + config_destroy(&cfg_kinetic); + exit(EXIT_FAILURE); + } + + /* Get the program name. */ + if(config_lookup_string(&cfg_kinetic, "filename", &filename)) + printf("Example : %s\n\n", filename); + else + fprintf(stdout, "No ' program name' setting in configuration file.\n"); + + /* Output a list of all species parameters in the file. */ + setting = config_lookup(&cfg_kinetic, "species"); + if(setting != NULL) + { + no_species = config_setting_length(setting); + + printf("# species = %i\n",no_species); + + for(i = 0; i < no_species; ++i) + { + temp_s = (species_t*) malloc(sizeof(species_t)); + temp_s->charge = 0.0; + temp_s->mass = 0.0; + temp_s->name = ""; + if (read_specie(setting,i,temp_s)) + spec_index[i]=temp_s; + printf("Species '%10s' has mass %10.1e and charge %10.1e\n", + spec_index[i]->name, + spec_index[i]->mass, + spec_index[i]->charge); + continue; + } + } + + /* Output a list of all seed parameters in the file. */ + setting = config_lookup(&cfg_kinetic, "seed"); + if(setting != NULL) + { + no_seed = config_setting_length(setting); + + printf("# seed = %i\n",no_seed); + printf("\n"); + + for(i = 0; i < no_seed; ++i) + { + temp_se = (seed_t*) malloc(sizeof(seed_t)); + temp_se->species = -1; + temp_se->value = 0.0; + temp_se->type = -1; + temp_se->x0 = 0.0; + temp_se->y0 = 0.0; + temp_se->z0 = 0.0; + temp_se->sigma_x = 0.0; + temp_se->sigma_y = 0.0; + temp_se->sigma_z = 0.0; + if (read_seed(setting,i,temp_se)) + seed_index[i]=temp_se; + printf("Found a seed of species %s and type %s\n", + seed_index[i]->kind_species, + seed_index[i]->kind_type); + printf("It has value %10.1e, z-position %10.1e and y-sigma %10.1e\n", + seed_index[i]->value, + seed_index[i]->z0, + seed_index[i]->sigma_y); + continue; + } + } + + /* Output a list of all reaction parameters in the file. */ + setting = config_lookup(&cfg_kinetic, "reactions"); + if(setting != NULL) + { + no_reactions = config_setting_length(setting); + + printf("# reactions = %i\n",no_reactions); + + for(i = 0; i < no_reactions; ++i) + { + temp_r = (reaction_t*) malloc(sizeof(reaction_t)); + temp_r->is_photo = 0; + temp_r->nin = 0; + temp_r->nout = 0; + temp_r->f = NULL; + temp_r->rt = NULL; + temp_r->tablefile = ""; + temp_r->k = 0.0; + temp_r->next = NULL; + if (read_reaction(setting,i,temp_r)) + reaction_index[i]=temp_r; + + continue; + } + } + + printf("\n"); + for (cnt = 0; cnt < no_reactions; cnt++) + { + printf("Reaction #%i has %i input-species, %i output-species.\n", + cnt,reaction_index[cnt]->nin,reaction_index[cnt]->nout); + printf("The rates are defined in %s\n", + reaction_index[cnt]->tablefile); + printf("Input species are:\t"); + for (cnt2 = 0; cnt2 < reaction_index[cnt]->nin; cnt2++) { + printf("(%i) %s\t", + reaction_index[cnt]->input[cnt2], + reaction_index[cnt]->inname[cnt2]); + } + printf("\nOutput species are:\t"); + for (cnt2 = 0; cnt2 < reaction_index[cnt]->nout; cnt2++) { + printf("(%i) %s\t",reaction_index[cnt]->output[cnt2], + reaction_index[cnt]->outname[cnt2]); + } + printf("\n"); + } +} diff --git a/src/rz_array.c b/src/rz_array.c new file mode 100644 index 0000000000000000000000000000000000000000..828bfc3768d347e692a30724480823f9399cb1ee --- /dev/null +++ b/src/rz_array.c @@ -0,0 +1,444 @@ +/** @file rz_array.c + * @brief General functions to work with FORTRAN-compatible 2d/3d arrays. + */ +#include +#include +#include + +#include "parameters.h" +#include "proto.h" +#include "rz_array.h" +#include "species.h" + +long int used_disk_space = 0; +/*!< This is the total disk space used so far for the array dumps. + It is used to limit the disk space used by a simulation and thus + avoid that one simulation gets crazy and stops other simulations + that are sharing the same disk space. */ + +static void check_disk_space(void); + +/** @brief Creates a new 3D array structure. */ +rz_array_t * +rz_new_3d_a (int r0, int z0, int r1, int z1, int ntheta) +{ + int rmax, zmax; + rz_array_t *array; + + debug (3, "rz_new_3d_a (%d, %d, %d, %d, %d)\n", r0, z0, r1, z1, ntheta); + + /* We allow a margin of two cells to set the boundary conditions (see below)*/ + r0 -= 2; z0 -= 2; r1 += 2; z1 += 2; + + rmax = r1 - r0; + zmax = z1 - z0; + + assert (rmax > 0 && zmax > 0 && ntheta > 0); + + debug (3, "r0 = %d, z0 = %d, r1 = %d, z1 = %d\n", r0, z0, r1, z1); + + array = (rz_array_t *) xmalloc (sizeof(rz_array_t)); + + if (ntheta != 1) { + array->len = rmax * zmax * (ntheta + 4); + array->theta0 = -2; + } else { + array->len = rmax * zmax; + array->theta0 = 0; + } + + /* Initially all arrays are zeroed. */ + array->data = (REAL *) xcalloc (array->len, sizeof(REAL)); + + + /* These strides are to make the array compatible with array(ir, iz) + in FORTRAN. */ + array->strides[R_INDX] = 1; + array->strides[Z_INDX] = rmax; + array->strides[THETA_INDX] = rmax * zmax; + + array->dim = ntheta == 1? 2: 3; + + debug (3, "rmax = %d\n", rmax); + debug (3, "strides = {%d, %d}\n", array->strides[0], array->strides[1]); + + array->r0 = r0; + array->z0 = z0; + /* 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. + */ + + array->nr = r1 - r0 - 4; + array->nz = z1 - z0 - 4; + array->ntheta = ntheta; + + array->host = NULL; + + return array; +} + +/** @brief Creates guest array: This is an array that contains + * part of another one. + * + * We use the memory of the original array and do not allocate + * new memory. + */ +rz_array_t * +rz_guest (rz_array_t *host, int r0, int z0, int r1, int z1) +{ + int ntheta, rmax, zmax; + rz_array_t *array; + + ntheta = host->ntheta; + array = (rz_array_t *) xmalloc (sizeof(rz_array_t)); + + rmax = r1 - r0; + zmax = z1 - z0; + + if (ntheta != 1) { + array->len = rmax * zmax * (ntheta + 4); + } else { + array->len = rmax * zmax; + } + + array->r0 = r0; + array->z0 = z0; + + array->theta0 = host->theta0; + + array->strides[R_INDX] = host->strides[R_INDX]; + array->strides[Z_INDX] = host->strides[Z_INDX]; + array->strides[THETA_INDX] = host->strides[THETA_INDX]; + + array->dim = host->dim; + + array->nr = r1 - r0 - 4; + array->nz = z1 - z0 - 4; + array->ntheta = host->ntheta; + + array->data = RZTP (host, r0, z0, array->theta0); + array->host = host; + + return array; +} + +/** @brief Sets the data of an array to zero */ +void +rz_set_zero (rz_array_t *array) +{ + debug (3, "rz_set_zero\n"); + memset (array->data, 0, array->len * sizeof(REAL)); +} + +/** @brief Sets periodic boundary conditions for theta in an array.*/ +void +rz_set_periodic (rz_array_t *array) +{ + /* If the array is 2D, we do nothing. */ + if (array->ntheta == 1) return; + + rz_copy_modes (array, array->r0, array->z0, + array, array->r0, array->z0, + array->nr + 4, array->nz + 4, array->ntheta - 1, -1); + + rz_copy_modes (array, array->r0, array->z0, + array, array->r0, array->z0, + array->nr + 4, array->nz + 4, array->ntheta - 2, -2); + + rz_copy_modes (array, array->r0, array->z0, + array, array->r0, array->z0, + array->nr + 4, array->nz + 4, 0, array->ntheta); + + rz_copy_modes (array, array->r0, array->z0, + array, array->r0, array->z0, + array->nr + 4, array->nz + 4, 1, array->ntheta + 1); + +} + + +/** @brief Sets boundaries for one array reading data from other array + * (but both can be the same: see rz_set_bnd). + * + * Starting at *start_xxx, it sweeps a 2-dimensional subspace of the grid + * in dimensions dim1 and dim2 (and perpendicular to dim0). There + * it sets the boudary conditions. + * + * The value of from is multiplied by sign. + * Thus, if the boundary is itself, is -1 for homogeneous dirichlet + * and 1 for homogeneous Neumann (though you should better use + * BND_CND_HNEUMANN and BND_CND_HDIRICHLET) + * + * @a inout is -1 if we look/set the values on smaller values + * of dim0 1 if we look at larger values. + * (though it is better to use BND_INWARD=-1 and BND_OUTWARD=1). + * + * Note: it is better to call this function _before_ rz_set_periodic. + */ +void +rz_copy_bnd (rz_array_t *from, rz_array_t *to, + int sign, REAL *start_from, REAL *start_to, + int dim0, int inout_from, int inout_to, + int dim1, int dim1_0, int dim1_1, + int dim2, int dim2_0, int dim2_1) +{ + int i, j; + REAL *pfrom, *pto; + + for (i = dim1_0; i < dim1_1; i++) { + for (j = dim2_0; j < dim2_1; j++) { + pfrom = start_from + i * from->strides[dim1] + j * from->strides[dim2]; + pto = start_to + i * to->strides[dim1] + j * to->strides[dim2]; + + *(pto + inout_to * to->strides[dim0]) = sign * (*pfrom); + + *(pto + 2 * inout_to * to->strides[dim0]) = + sign * (*(pfrom + inout_from * from->strides[dim0])); + } + } +} + + +/** @brief Sets boundary conditions (Neumann/Dirichlet) reading from + * the array itself. + * + * For example, to set Neumann conditions at r = 0 (dim0 = R_INDX), + * we call it as + * + * rz_set_bnd (array, 1, RZTP (array, 0, 0, 0), R_INDX, 1, + * Z_INDX, z0, z1, THETA_INDX, 0, ntheta); + */ +void +rz_set_bnd (rz_array_t *array, int sign, REAL *astart, int dim0, int inout, + int dim1, int dim1_0, int dim1_1, + int dim2, int dim2_0, int dim2_1) +{ + rz_copy_bnd (array, array, sign, astart, astart, dim0, -inout, inout, + dim1, dim1_0, dim1_1, dim2, dim2_0, dim2_1); +} + + +/** @brief Frees an array */ +void +rz_free (rz_array_t *array) +{ + debug (3, "rz_free\n"); + + if (NULL == array->host) free (array->data); + free (array); +} + +/** @brief Copies a sub-array of @a rn x @a zn from @a fro + * (starting at (@a rfro, z@a fro)) to @a to (starting at + * (@a rto, @a zto)). */ +void +rz_copy (rz_array_t *fro, int rfro, int zfro, + rz_array_t *to, int rto, int zto, + int rn, int zn) +{ + int i; + REAL *pfro, *pto; + + debug (3, "rz_copy\n"); + + pfro = RZP (fro, rfro, zfro); + pto = RZP (to, rto, zto); + + for (i = 0; i < zn; i++) { + memcpy (pto, pfro, sizeof(REAL) * rn); + + pfro += fro->strides[Z_INDX]; + pto += to->strides[Z_INDX]; + } +} + +/** @brief Copies a sub-array of the mode nmode of @a rn x @a zn from + * @a fro (starting at (@a rfro, @a zfro)) to @a to (starting at + * (@a rto, @a zto)). +*/ +void +rz_copy_modes (rz_array_t *fro, int rfro, int zfro, + rz_array_t *to, int rto, int zto, + int rn, int zn, int nmode_fro, int nmode_to) +{ + int i, j; + REAL *pfro, *pto; + + debug (3, "rz_copy\n"); + + pfro = RZTP (fro, rfro, zfro, nmode_fro); + pto = RZTP (to, rto, zto, nmode_to); + + for (i = 0; i < zn; i++) { + /* memcpy (pto, pfro, sizeof(REAL) * rn); Maybe not thread safe? */ + for (j = 0; j < rn; j++ ) *(pto + j) = *(pfro + j); + + pfro += fro->strides[Z_INDX]; + pto += to->strides[Z_INDX]; + } +} + + +/** @brief Reads or writes a @a rz_array, depending on the string mode, + * "r" for reading, "w" for writing. + * + * Note however that we must already have the dimensions of the array in it. + */ +void +rz_dump (rz_array_t *rz_array, const char *fname, const char *mode, + int r0, int z0, int r1, int z1) +{ + FILE *fp; + int ir, iz; + int writing; + double f; + + debug (3, "rz_dump(\"%s\", \"%s\", %d, %d, %d, %d)\n", fname, mode, + r0, z0, r1, z1); + + if (0 == strcmp (mode, "w")) { + writing = TRUE; + } else if (0 == strcmp (mode, "r")) { + writing = FALSE; + } else { + fatal ("Unknown mode for rz_dump\n"); + } + + fp = fopen (fname, mode); + + if (fp == NULL) { + warning("Unable to open %s for %s\n", fname, + writing? "writing": "reading"); + return; + } + + for (ir = r0; ir < r1; ir++) + for (iz = z0; iz < z1; iz++) { + if (writing) + fprintf (fp, "%15.5e\n", RZ(rz_array, ir, iz)); + else { + if (fscanf (fp, "%lf", &f) != 1) { + warning ("Error reading file %s, at line %d, (ir, iz) = (%d, %d)\n", + fname, iz + ir * (z1 - z0), ir, iz); + f = 0.0; + } + *RZP (rz_array, ir, iz) = f; + } + } + + used_disk_space += ftell (fp); + fclose(fp); + + check_disk_space (); +} + +/** @brief rz_dump_3d QQQQ */ +void +rz_dump_3d (rz_array_t *rz_array, const char *fname, const char *mode, + int r0, int z0, int r1, int z1, int ntheta) +{ + FILE *fp; + int ir, iz, itheta; + int writing; + double f; + + debug (3, "rz_dump_3d(\"%s\", \"%s\", %d, %d, %d, %d, %d)\n", + fname, mode, r0, z0, r1, z1, ntheta); + + if (0 == strcmp (mode, "w")) { + writing = TRUE; + } else if (0 == strcmp (mode, "r")) { + writing = FALSE; + } else { + fatal ("Unknown mode for rz_dump_3d\n"); + } + + fp = fopen (fname, mode); + + if (fp == NULL) { + warning ("Unable to open %s for %s\n", fname, + writing? "writing": "reading"); + return; + } + + for (itheta = 0; itheta < ntheta; itheta++) { + for (ir = r0; ir < r1; ir++) { + for (iz = z0; iz < z1; iz++) { + if (writing) + fprintf (fp, "%15.5e\n", RZT (rz_array, ir, iz, itheta)); + else { + if (fscanf (fp, "%lf", &f) != 1) { + warning ("Error reading file %s, at line %d, " + "(ir, iz, itheta) = (%d, %d, %d)\n", + fname, iz + (ir + itheta * (r1 - r0)) * (z1 - z0), + ir, iz, itheta); + f = 0.0; + } + *RZTP (rz_array, ir, iz, itheta) = f; + } + } + } + } + + /* Add the disk space used to the total disk space that we have used so far + */ + + used_disk_space += ftell (fp); + fclose(fp); + + check_disk_space (); +} + +/** @brief rz_axis_dump QQQQ */ +void + rz_axis_dump (const char *fname, int x0, int x1, double delta) +{ + FILE *fp; + int i; + + debug (3, "rz_axis_dump(\"%s\", %d, %d, %f)\n", fname, x0, x1, delta); + + fp = fopen (fname, "w"); + + if (fp == NULL) { + warning ("Unable to open %s\n", fname); + return; + } + + for (i = x0; i < x1; i++) + fprintf (fp, "%15.5e\n", ((double) i + 0.5) * delta); + + + used_disk_space += ftell (fp); + fclose(fp); + + check_disk_space (); +} + +/** @brief check_disk_space QQQQ */ +static void +check_disk_space (void) +{ + if (used_disk_space > (((long int) max_disk_space_mb) << 20)) { + fatal ("The disk space limit has been surpassed. " + "Increase max_disk_space_mb if you really need more space\n"); + } +} + diff --git a/src/sprites.c b/src/sprites.c new file mode 100644 index 0000000000000000000000000000000000000000..e5ff181c796fbae8d089d41e00d19dacd14ce3ab --- /dev/null +++ b/src/sprites.c @@ -0,0 +1,124 @@ +/** @file sprites.c + * @brief Routines for the "sprites module." + * + * The idea here is to cope with strongly varying densities along + * the streamer propagation. + * + * For photoionization we use a "local maximum approximation", i.e. the + * quenching and absorption lengths for all the volume are taken as those + * corresponding to the streamer head. + */ + +#include +#include +#include +#include + +#include "cdr.h" +#include "parameters.h" +#include "photo.h" +#include "proto.h" +#include "rz_array.h" +#include "species.h" + +static int var_max_axis (cdr_grid_t *grid, rz_array_t *var, int sign); + +double spr_nu_a, spr_nu_d, spr_nu_rt; +photo_term_t *spr_photo_terms; +extern photo_term_t *photo_terms; + +/** @brief The density at a given height, assuming dens = 1.0 at height = 0.0. + * + * We are assuming an exponential profile here but in principle any other + * profile would also do. + */ +double +spr_density_at (double altitude) +{ + return exp (-altitude / dens_decay_len); +} + + +/** @brief Initialize the sprite module. + * + * We have to remember the values of the global variables that we will adapt + * to altitude. + */ +void +spr_init () +{ + /* We make the Courant numbers depend on the altitude: this is because + when we apply the Courant-Levy criterium we assume v = -E, which is not + true if the mobility now is != 1.0 */ + spr_nu_a = nu_a; + spr_nu_d = nu_d; + spr_nu_rt = nu_rt; + + photo_copy_list (photo_terms, &spr_photo_terms); +} + +/** @brief Hook to update the variables that depend on the head altitude. + * + * Has to be called AFTER the charge is calculated. + */ +void +spr_hook (cdr_grid_t *grid) +{ + double altitude; + + altitude = spr_head_altitude (grid, sprite_sign); + + spr_update (altitude); +} + +/** @brief Updates the magnitudes that we are tracking according to a + * given altitude. + */ +void +spr_update (double altitude) +{ + double back_dens = spr_density_at (altitude); + photo_term_t *p0, *p; + + nu_a = spr_nu_a; + nu_d = spr_nu_d * back_dens; + nu_rt = spr_nu_rt; + + for (p0 = spr_photo_terms, p = photo_terms; p0; p0 = p0->next, p = p->next) { + p->lambda = p0->lambda * back_dens * back_dens; + p->A = p0->A * (sprite_dens_0 + sprite_dens_q) + / (back_dens + sprite_dens_q); + } + +} + +/** @brief Finds the position of the streamer head by locating the maximum + * (or -maximum) of the charge along the streamer axis. + * + * @a sign has to be +1 for positive streamers and -1 for negative streamers. + */ +double +spr_head_altitude (cdr_grid_t *grid, int sign) +{ + int ih; + ih = var_max_axis (grid, grid->charge, sign); + if (0 == ih) ih = var_max_axis (grid, grid->dens[electrons], 1); + return z_at (ih, grid->level); +} + +/** @brief var_max_axis QQQQ */ +static int +var_max_axis (cdr_grid_t *grid, rz_array_t *var, int sign) +{ + int iz, iz_max = 0; + double var_max = 0.0; + + iter_grid_z (grid, iz) { + if (sign * RZT (var, 0, iz, 0) > var_max) { + iz_max = iz; + var_max = RZT (var, 0, iz, 0); + } + } + + return iz_max; +} diff --git a/src/tree.c b/src/tree.c new file mode 100644 index 0000000000000000000000000000000000000000..2317823a6aec3c0e03e799602e42436973c267aa --- /dev/null +++ b/src/tree.c @@ -0,0 +1,47 @@ +/** @file tree.c + * @brief Functions to handle tree structures. + */ + +#include +#include + +#include "species.h" + +#include "tree.h" + +/** @brief Allocates new memory for a leaf and gives it the corresponding + * values. + */ +leaf_t* +leaf_new_a (leaf_t *parent, leaf_t *next, leaf_t *first_child, void *data) +{ + leaf_t *leaf; + + debug (2, "leaf_new_a\n"); + + leaf = (leaf_t*) xmalloc (sizeof(leaf_t)); + + leaf->parent = parent; + leaf->next = next; + leaf->first_child = first_child; + leaf->data = data; + + return leaf; +} + +/** @brief Creates a new child of @a parent with the given @a data. */ +leaf_t* +leaf_new_child_a (leaf_t *parent, void *data) +{ + leaf_t *leaf; + + debug (2, "leaf_new_child_a\n"); + + leaf = leaf_new_a (parent, parent->first_child, NULL, data); + + parent->first_child = leaf; + + leaf->level = parent->level + 1; + + return leaf; +}