S2kit  1.1
Toolkit for working with functions defined on the sphere
test_s2_semi_memo.c
Go to the documentation of this file.
1 
47 #include <math.h>
48 #include <stdio.h>
49 #include <stdlib.h>
50 #include <string.h>
51 #include <time.h>
52 
53 #include <fftw3.h>
54 
55 #include "s2kit/FST_semi_memo.h"
56 #include "s2kit/cospml.h"
57 #include "s2kit/weights.h"
58 #include "s2kit/util.h"
59 
60 #include "util/csecond.h"
61 
62 int main(int argc, char** argv) {
63  if (argc < 3) {
64  fprintf(stdout, "Usage: test_s2_semi_memo bw loops [error_file]\n");
65  exit(0);
66  }
67 
68  int bw = atoi(argv[1]);
69  int loops = atoi(argv[2]);
70 
71  int size = 2 * bw;
72 
73  // TODO more tests with dataformat 0 and cutoff
74  int cutoff = bw / 4; // = bw // seminaive all orders
75  DataFormat data_format = COMPLEX;
76 
77  double* workspace = (double*)malloc(sizeof(double) * ((8 * (bw * bw)) + (16 * bw)));
78  double* seminaive_naive_tablespace = (double*)malloc(
79  sizeof(double) * (Reduced_Naive_TableSize(bw, cutoff) + Reduced_SpharmonicTableSize(bw, cutoff)));
80  double* trans_seminaive_naive_tablespace = (double*)malloc(
81  sizeof(double) * (Reduced_Naive_TableSize(bw, cutoff) + Reduced_SpharmonicTableSize(bw, cutoff)));
82 
83  // precompute the Legendres (that's what memo suffix for)
84  fprintf(stdout, "Generating seminaive_naive tables...\n");
85  double** seminaive_naive_table = SemiNaive_Naive_Pml_Table(bw, cutoff, seminaive_naive_tablespace, workspace);
86 
87  fprintf(stdout, "Generating trans_seminaive_naive tables...\n");
88  double** trans_seminaive_naive_table = Transpose_SemiNaive_Naive_Pml_Table(
89  seminaive_naive_table, bw, cutoff, trans_seminaive_naive_tablespace, workspace);
90 
91  time_t seed;
92  time(&seed);
93  srand48(seed); // init random generator
94 
95  double* weights = (double*)malloc(sizeof(double) * 4 * bw);
96  double* rdata = (double*)malloc(sizeof(double) * (size * size));
97  double* idata = (double*)malloc(sizeof(double) * (size * size));
98 
99  // Make DCT plans. Note that I will be using the GURU interface to execute these plans within the routines
100  fftw_plan DCT_plan = fftw_plan_r2r_1d(2 * bw, weights, rdata, FFTW_REDFT10, FFTW_ESTIMATE);
101  fftw_plan inv_DCT_plan = fftw_plan_r2r_1d(2 * bw, weights, rdata, FFTW_REDFT01, FFTW_ESTIMATE);
102 
103  // fftw "preamble"
104  // Note that FFT plan places the output in a transposed array
105  int rank = 1;
106  fftw_iodim dims[rank];
107  dims[0].n = 2 * bw;
108  dims[0].is = 1;
109  dims[0].os = 2 * bw;
110 
111  int howmany_rank = 1;
112  fftw_iodim howmany_dims[howmany_rank];
113  howmany_dims[0].n = 2 * bw;
114  howmany_dims[0].is = 2 * bw;
115  howmany_dims[0].os = 1;
116 
117  fftw_plan FFT_plan = fftw_plan_guru_split_dft(rank, dims, howmany_rank, howmany_dims, rdata, idata, workspace,
118  workspace + (4 * bw * bw), FFTW_ESTIMATE);
119 
120  // Note that FFT plans assumes that I'm working with a transposed array, e.g. the inputs for a length 2*bw transform
121  // are placed every 2*bw apart, the output will be consecutive entries in the array
122 
123  rank = 1;
124  dims[0].n = 2 * bw;
125  dims[0].is = 2 * bw;
126  dims[0].os = 1;
127 
128  howmany_rank = 1;
129  howmany_dims[0].n = 2 * bw;
130  howmany_dims[0].is = 1;
131  howmany_dims[0].os = 2 * bw;
132 
133  fftw_plan inv_FFT_plan = fftw_plan_guru_split_dft(rank, dims, howmany_rank, howmany_dims, rdata, idata, workspace,
134  workspace + (4 * bw * bw), FFTW_ESTIMATE);
135 
136  GenerateWeightsForDLT(bw, weights);
137 
138  double* rcoeffs = (double*)malloc(sizeof(double) * (bw * bw));
139  double* icoeffs = (double*)malloc(sizeof(double) * (bw * bw));
140 
141  double* rresult = (double*)malloc(sizeof(double) * (bw * bw));
142  double* iresult = (double*)malloc(sizeof(double) * (bw * bw));
143 
144  double* relerror = (double*)malloc(sizeof(double) * loops);
145  double* curmax = (double*)malloc(sizeof(double) * loops);
146 
147  double fwd_time = 0.0;
148  double inv_time = 0.0;
149  double total_error = 0.0;
150  double total_relerror = 0.0;
151 
152  fprintf(stdout, "about to enter loop\n\n");
153  for (int i = 0; i < loops; ++i) {
154 
155  // generate spherical harmonic coefficients
156  for (int m = 0; m < bw; ++m)
157  for (int l = m; l < bw; ++l) {
158  double x = 2.0 * (drand48() - 0.5);
159  double y = 2.0 * (drand48() - 0.5);
160 
161  int index = IndexOfHarmonicCoeff(m, l, bw);
162  rcoeffs[index] = x;
163  icoeffs[index] = y;
164 
165  index = IndexOfHarmonicCoeff(-m, l, bw);
166  rcoeffs[index] = pow(-1.0, m) * x;
167  icoeffs[index] = pow(-1.0, m + 1) * y;
168  }
169 
170  // have to zero out the m=0 coefficients, since those are real
171  for (int m = 0; m < bw; ++m)
172  icoeffs[m] = 0.0;
173 
174  double time_start = csecond();
175  // inverse spherical transform
176  InvFSTSemiMemo(rcoeffs, icoeffs, rdata, idata, bw, trans_seminaive_naive_table, workspace, data_format, cutoff,
177  &inv_DCT_plan, &inv_FFT_plan);
178 
179  double duration = csecond() - time_start;
180  inv_time += duration;
181  fprintf(stdout, "inv time \t = %.4e\n", duration);
182 
183  time_start = csecond();
184  // forward spherical transform
185  FSTSemiMemo(rdata, idata, rresult, iresult, bw, seminaive_naive_table, workspace, data_format, cutoff,
186  &DCT_plan, &FFT_plan, weights);
187 
188  duration = csecond() - time_start;
189  fwd_time += duration;
190  fprintf(stdout, "forward time \t = %.4e\n", duration);
191 
192  // compute the error
193  relerror[i] = 0.0;
194  curmax[i] = 0.0;
195 
196  for (int j = 0; j < (bw * bw); ++j) {
197  double rtmp = rresult[j] - rcoeffs[j];
198  double itmp = iresult[j] - icoeffs[j];
199  double origmag = sqrt((rcoeffs[j] * rcoeffs[j]) + (icoeffs[j] * icoeffs[j]));
200  double tmpmag = sqrt((rtmp * rtmp) + (itmp * itmp));
201  relerror[i] = fmax(relerror[i], tmpmag / (origmag + pow(10.0, -50.0)));
202  curmax[i] = fmax(curmax[i], tmpmag);
203  }
204 
205  fprintf(stdout, "r-o error\t = %.12f\n", curmax[i]);
206  fprintf(stdout, "(r-o)/o error\t = %.12f\n\n", relerror[i]);
207 
208  total_error += curmax[i];
209  total_relerror += relerror[i];
210  }
211 
212  double avg_error = total_error / loops;
213  double avg_relerror = total_relerror / loops;
214  double stddev_error = 0.0;
215  double stddev_relerror = 0.0;
216 
217  for (int i = 0; i < loops; ++i) {
218  stddev_error += pow(avg_error - curmax[i], 2.0);
219  stddev_relerror += pow(avg_relerror - relerror[i], 2.0);
220  }
221 
222  if (loops != 1) {
223  stddev_error = sqrt(stddev_error / (loops - 1));
224  stddev_relerror = sqrt(stddev_relerror / (loops - 1));
225  }
226 
227  fprintf(stdout, "Program: test_s2_semi_memo\n");
228  fprintf(stdout, "Bandwidth = %d\n", bw);
229 
230  const char* timing_object = "cpu";
231 #ifdef WALLCLOCK
232  timing_object = "wall";
233 #endif
234 
235  double total_time = inv_time + fwd_time;
236 
237  fprintf(stdout, "Total elapsed %s time :\t\t %.4e seconds.\n", timing_object, total_time);
238  fprintf(stdout, "Average %s forward per iteration:\t %.4e seconds.\n", timing_object, fwd_time / loops);
239  fprintf(stdout, "Average %s inverse per iteration:\t %.4e seconds.\n", timing_object, inv_time / loops);
240 
241  fprintf(stdout, "Average r-o error:\t\t %.4e\t", total_error / loops);
242  fprintf(stdout, "std dev: %.4e\n", stddev_error);
243  fprintf(stdout, "Average (r-o)/o error:\t\t %.4e\t", total_relerror / loops);
244  fprintf(stdout, "std dev: %.4e\n\n", stddev_relerror);
245 
246  if (argc == 4) {
247  FILE* errorsfp = fopen(argv[3], "w");
248 
249  for (int m = 0; m < bw; ++m) {
250  for (int l = m; l < bw; ++l) {
251  int index = IndexOfHarmonicCoeff(m, l, bw);
252  fprintf(errorsfp, "index = %d\t m = %d\tl = %d\t%.10f %.10f\n", index, m, l,
253  fabs(rcoeffs[index] - rresult[index]), fabs(icoeffs[index] - iresult[index]));
254 
255  index = IndexOfHarmonicCoeff(-m, l, bw);
256  fprintf(errorsfp, "index = %d\t m = %d\tl = %d\t%.10f %.10f\n", index, -m, l,
257  fabs(rcoeffs[index] - rresult[index]), fabs(icoeffs[index] - iresult[index]));
258  }
259  }
260 
261  fclose(errorsfp);
262  }
263 
264  fftw_destroy_plan(inv_FFT_plan);
265  fftw_destroy_plan(FFT_plan);
266  fftw_destroy_plan(inv_DCT_plan);
267  fftw_destroy_plan(DCT_plan);
268 
269  free(weights);
270  free(trans_seminaive_naive_table);
271  free(seminaive_naive_table);
272  free(curmax);
273  free(relerror);
274  free(workspace);
275  free(trans_seminaive_naive_tablespace);
276  free(seminaive_naive_tablespace);
277  free(iresult);
278  free(rresult);
279  free(idata);
280  free(rdata);
281  free(icoeffs);
282  free(rcoeffs);
283 
284  return 0;
285 }
FSTSemiMemo
void FSTSemiMemo(double *, double *, double *, double *, const int, double **, double *, DataFormat, const int, fftw_plan *, fftw_plan *, double *)
Computes spherical harmonic transform using the seminaive and naive algorithms.
Definition: FST_semi_memo.c:68
Reduced_Naive_TableSize
int Reduced_Naive_TableSize(const int, const int)
Definition: cospml.c:434
main
int main(int argc, char **argv)
Definition: test_s2_semi_memo.c:62
weights.h
Transpose_SemiNaive_Naive_Pml_Table
double ** Transpose_SemiNaive_Naive_Pml_Table(double **, const int, const int, double *, double *)
Definition: cospml.c:490
IndexOfHarmonicCoeff
int IndexOfHarmonicCoeff(const int, const int, const int)
Gives the position of the coefficient f-hat(m,l) in the one-row array.
Definition: util.c:42
COMPLEX
Definition: util.h:11
GenerateWeightsForDLT
void GenerateWeightsForDLT(const int, double *)
Generates weights for both even and odd order Legendre transforms for a given bandwidth.
Definition: weights.c:32
SemiNaive_Naive_Pml_Table
double ** SemiNaive_Naive_Pml_Table(const int, const int, double *, double *)
Definition: cospml.c:451
Reduced_SpharmonicTableSize
int Reduced_SpharmonicTableSize(const int, const int)
Definition: cospml.c:107
DataFormat
DataFormat
Result data format for FST functions.
Definition: util.h:10
cospml.h
csecond.h
csecond
double csecond()
Definition: csecond.c:32
InvFSTSemiMemo
void InvFSTSemiMemo(double *, double *, double *, double *, const int, double **, double *, DataFormat, const int, fftw_plan *, fftw_plan *)
Computes inverse spherical harmonic transform.
Definition: FST_semi_memo.c:228
util.h
FST_semi_memo.h