aboutsummaryrefslogtreecommitdiff
diff options
context:
space:
mode:
authorrhaas <rhaas@b2a53a04-0f4f-0410-87ed-f9f25ced00cf>2013-06-11 05:44:21 +0000
committerrhaas <rhaas@b2a53a04-0f4f-0410-87ed-f9f25ced00cf>2013-06-11 05:44:21 +0000
commit8bcc7054a99a7902fe75518db1de1ca0704dad79 (patch)
treea9b0e9f5b264a6bd85a2a1a98d888364c2fde254
parent3e5a7c71b5c9a4d85b7c19731a866869047b3903 (diff)
implement UIUC's speed-up in "evaluation" of spectral solution
The accompanying svn patch applies the recently released refinement of TwoPunctures by Vasileios Paschalidis and Zach Etienne at UIUC, greatly reducing the time taken to properly apply the solution of the spectral solve to all grid points. From the abstract of the notes in arXiv:1304.0457: TwoPunctures is perhaps the most widely-adopted code for generating binary black hole "puncture" initial data and interpolating these (spectral) data onto evolution grids. In typical usage, the bulk of this code's run time is spent in its spectral interpolation routine. We announce a new publicly-available spectral interpolation routine that improves the performance of the original interpolation routine by a factor of ~100, yielding results consistent with the original spectral interpolation routine to roundoff precision. This note serves as a guide for installing this routine both in the original standalone TwoPunctures code and the Einstein Toolkit supported version of this code. Patch kindly provided by Bernard Kelly Original code by Vasileios Paschalidis and Zach Etienne git-svn-id: http://svn.einsteintoolkit.org/cactus/EinsteinInitialData/TwoPunctures/trunk@133 b2a53a04-0f4f-0410-87ed-f9f25ced00cf
-rw-r--r--src/FuncAndJacobian.c143
-rw-r--r--src/TwoPunctures.c29
-rw-r--r--src/TwoPunctures.h7
3 files changed, 171 insertions, 8 deletions
diff --git a/src/FuncAndJacobian.c b/src/FuncAndJacobian.c
index 294254d..8703aa1 100644
--- a/src/FuncAndJacobian.c
+++ b/src/FuncAndJacobian.c
@@ -841,4 +841,147 @@ PunctIntPolAtArbitPosition (int ivar, int nvar, int n1,
return Ui;
}
+
+//////////////////////////////////////////////////////
+/// Fast Spectral Interpolation Routine Stuff
+//////////////////////////////////////////////////////
+
+
+/* Calculates the value of v at an arbitrary position (A,B,phi)* using the fast routine */
+CCTK_REAL
+PunctEvalAtArbitPositionFast (CCTK_REAL *v, int ivar, CCTK_REAL A, CCTK_REAL B, CCTK_REAL phi, int nvar, int n1, int n2, int n3)
+{
+ int i, j, k, N;
+ CCTK_REAL *p, *values1, **values2, result;
+ // VASILIS: Nothing should be changed in this routine. This is used by PunctIntPolAtArbitPositionFast
+
+ N = maximum3 (n1, n2, n3);
+
+ p = dvector (0, N);
+ values1 = dvector (0, N);
+ values2 = dmatrix (0, N, 0, N);
+
+ for (k = 0; k < n3; k++)
+ {
+ for (j = 0; j < n2; j++)
+ {
+ for (i = 0; i < n1; i++) p[i] = v[ivar + nvar * (i + n1 * (j + n2 * k))];
+ // chebft_Zeros (p, n1, 0);
+ values2[j][k] = chebev (-1, 1, p, n1, A);
+ }
+ }
+
+ for (k = 0; k < n3; k++)
+ {
+ for (j = 0; j < n2; j++) p[j] = values2[j][k];
+ // chebft_Zeros (p, n2, 0);
+ values1[k] = chebev (-1, 1, p, n2, B);
+ }
+
+ // fourft (values1, n3, 0);
+ result = fourev (values1, n3, phi);
+
+ free_dvector (p, 0, N);
+ free_dvector (values1, 0, N);
+ free_dmatrix (values2, 0, N, 0, N);
+
+ return result;
+ // */
+ // return 0.;
+}
+
+
+// --------------------------------------------------------------------------*/
+// Calculates the value of v at an arbitrary position (x,y,z) if the spectral coefficients are known //
/* --------------------------------------------------------------------------*/
+CCTK_REAL
+PunctIntPolAtArbitPositionFast (int ivar, int nvar, int n1,
+ int n2, int n3, derivs v, CCTK_REAL x, CCTK_REAL y,
+ CCTK_REAL z)
+{
+ DECLARE_CCTK_PARAMETERS;
+ CCTK_REAL xs, ys, zs, rs2, phi, X, R, A, B, aux1, aux2, result, Ui;
+ // VASILIS: Here the struct derivs v refers to the spectral coeffiecients of variable v not the variable v itself
+
+ xs = x / par_b;
+ ys = y / par_b;
+ zs = z / par_b;
+ rs2 = ys * ys + zs * zs;
+ phi = atan2 (z, y);
+ if (phi < 0)
+ phi += 2 * Pi;
+
+ aux1 = 0.5 * (xs * xs + rs2 - 1);
+ aux2 = sqrt (aux1 * aux1 + rs2);
+ X = asinh (sqrt (aux1 + aux2));
+ R = asin (min(1.0, sqrt (-aux1 + aux2)));
+ if (x < 0)
+ R = Pi - R;
+
+ A = 2 * tanh (0.5 * X) - 1;
+ B = tan (0.5 * R - Piq);
+
+ result = PunctEvalAtArbitPositionFast (v.d0, ivar, A, B, phi, nvar, n1, n2, n3);
+
+ Ui = (A - 1) * result;
+
+ return Ui;
+}
+
+// Evaluates the spectral expansion coefficients of v
+void SpecCoef(int n1, int n2, int n3, int ivar, CCTK_REAL *v, CCTK_REAL *cf)
+{
+ DECLARE_CCTK_PARAMETERS;
+ // VASILIS: Here v is a pointer to the values of the variable v at the collocation points and cf_v a pointer to the spectral coefficients that this routine calculates
+
+ int i, j, k, N, n, l, m;
+ double *p, ***values3, ***values4;
+
+ N=maximum3(n1,n2,n3);
+ p=dvector(0,N);
+ values3=d3tensor(0,n1,0,n2,0,n3);
+ values4=d3tensor(0,n1,0,n2,0,n3);
+
+
+
+ // Caclulate values3[n,j,k] = a_n^{j,k} = (sum_i^(n1-1) f(A_i,B_j,phi_k) Tn(-A_i))/k_n , k_n = N/2 or N
+ for(k=0;k<n3;k++) {
+ for(j=0;j<n2;j++) {
+
+ for(i=0;i<n1;i++) p[i]=v[ivar + (i + n1 * (j + n2 * k))];
+
+ chebft_Zeros(p,n1,0);
+ for (n=0;n<n1;n++) {
+ values3[n][j][k] = p[n];
+ }
+ }
+ }
+
+ // Caclulate values4[n,l,k] = a_{n,l}^{k} = (sum_j^(n2-1) a_n^{j,k} Tn(B_j))/k_l , k_l = N/2 or N
+
+ for (n = 0; n < n1; n++){
+ for(k=0;k<n3;k++) {
+ for(j=0;j<n2;j++) p[j]=values3[n][j][k];
+ chebft_Zeros(p,n2,0);
+ for (l = 0; l < n2; l++){
+ values4[n][l][k] = p[l];
+ }
+ }
+ }
+
+ // Caclulate coefficients a_{n,l,m} = (sum_k^(n3-1) a_{n,m}^{k} fourier(phi_k))/k_m , k_m = N/2 or N
+ for (i = 0; i < n1; i++){
+ for (j = 0; j < n2; j++){
+ for(k=0;k<n3;k++) p[k]=values4[i][j][k];
+ fourft(p,n3,0);
+ for (k = 0; k<n3; k++){
+ cf[ivar + (i + n1 * (j + n2 * k))] = p[k];
+ }
+ }
+ }
+
+ free_dvector(p,0,N);
+ free_d3tensor(values3,0,n1,0,n2,0,n3);
+ free_d3tensor(values4,0,n1,0,n2,0,n3);
+
+}
diff --git a/src/TwoPunctures.c b/src/TwoPunctures.c
index 8835c74..bad5465 100644
--- a/src/TwoPunctures.c
+++ b/src/TwoPunctures.c
@@ -216,7 +216,7 @@ TwoPunctures (CCTK_ARGUMENTS)
int percent10 = 0;
#endif
static CCTK_REAL *F = NULL;
- static derivs u, v;
+ static derivs u, v, cf_v;
CCTK_REAL admMass;
if (! F) {
@@ -225,6 +225,7 @@ TwoPunctures (CCTK_ARGUMENTS)
F = dvector (0, ntotal - 1);
allocate_derivs (&u, ntotal);
allocate_derivs (&v, ntotal);
+ allocate_derivs (&cf_v, ntotal);
if (use_sources) {
CCTK_INFO ("Solving puncture equation for BH-NS/NS-NS system");
@@ -236,6 +237,16 @@ TwoPunctures (CCTK_ARGUMENTS)
/* initialise to 0 */
for (int j = 0; j < ntotal; j++)
{
+ cf_v.d0[j] = 0.0;
+ cf_v.d1[j] = 0.0;
+ cf_v.d2[j] = 0.0;
+ cf_v.d3[j] = 0.0;
+ cf_v.d11[j] = 0.0;
+ cf_v.d12[j] = 0.0;
+ cf_v.d13[j] = 0.0;
+ cf_v.d22[j] = 0.0;
+ cf_v.d23[j] = 0.0;
+ cf_v.d33[j] = 0.0;
v.d0[j] = 0.0;
v.d1[j] = 0.0;
v.d2[j] = 0.0;
@@ -270,7 +281,7 @@ TwoPunctures (CCTK_ARGUMENTS)
/* Loop until both ADM masses are within adm_tol of their target */
do {
- CCTK_VInfo (CCTK_THORNSTRING, "Bare masses: mp=%g, mm=%g",
+ CCTK_VInfo (CCTK_THORNSTRING, "Bare masses: mp=%.15g, mm=%.15g",
(double)*mp, (double)*mm);
Newton (cctkGH, nvar, n1, n2, n3, v, Newton_tol, 1);
@@ -286,8 +297,8 @@ TwoPunctures (CCTK_ARGUMENTS)
/* Check how far the current ADM masses are from the target */
mp_adm_err = fabs(M_p-*mp_adm);
mm_adm_err = fabs(M_m-*mm_adm);
- CCTK_VInfo (CCTK_THORNSTRING, "ADM mass error: M_p_err=%.4g, M_m_err=%.4g",
- (double) mp_adm_err, (double) mm_adm_err);
+ CCTK_VInfo (CCTK_THORNSTRING, "ADM mass error: M_p_err=%.15g, M_m_err=%.15g",
+ (double)mp_adm_err, (double)mm_adm_err);
/* Invert the ADM mass equation and update the bare mass guess so that
it gives the correct target ADM masses */
@@ -299,10 +310,10 @@ TwoPunctures (CCTK_ARGUMENTS)
/* Set the par_m_plus and par_m_minus parameters */
sprintf (valbuf,"%.17g", (double) *mp);
- CCTK_ParameterSet ("par_m_plus", "twopunctures", valbuf);
+ CCTK_ParameterSet ("par_m_plus", "TwoPunctures", valbuf);
sprintf (valbuf,"%.17g", (double) *mm);
- CCTK_ParameterSet ("par_m_minus", "twopunctures", valbuf);
+ CCTK_ParameterSet ("par_m_minus", "TwoPunctures", valbuf);
} while ( (mp_adm_err > adm_tol) ||
(mm_adm_err > adm_tol) );
@@ -314,6 +325,8 @@ TwoPunctures (CCTK_ARGUMENTS)
F_of_v (cctkGH, nvar, n1, n2, n3, v, F, u);
+ SpecCoef(n1, n2, n3, 0, v.d0, cf_v.d0);
+
CCTK_VInfo (CCTK_THORNSTRING,
"The two puncture masses are mp=%.17g and mm=%.17g",
(double) *mp, (double) *mm);
@@ -456,8 +469,7 @@ TwoPunctures (CCTK_ARGUMENTS)
(0, nvar, n1, n2, n3, v, xx, yy, zz);
break;
case GSM_evaluation:
- U = PunctIntPolAtArbitPosition
- (0, nvar, n1, n2, n3, v, xx, yy, zz);
+ U = PunctIntPolAtArbitPositionFast(0, nvar, n1, n2, n3, cf_v, xx, yy, zz);
break;
default:
assert (0);
@@ -664,6 +676,7 @@ TwoPunctures (CCTK_ARGUMENTS)
free_dvector (F, 0, ntotal - 1);
free_derivs (&u, ntotal);
free_derivs (&v, ntotal);
+ free_derivs (&cf_v, ntotal);
}
}
diff --git a/src/TwoPunctures.h b/src/TwoPunctures.h
index 79feff3..0787978 100644
--- a/src/TwoPunctures.h
+++ b/src/TwoPunctures.h
@@ -50,6 +50,13 @@ CCTK_REAL PunctTaylorExpandAtArbitPosition (int ivar, int nvar, int n1,
CCTK_REAL PunctIntPolAtArbitPosition (int ivar, int nvar, int n1,
int n2, int n3, derivs v, CCTK_REAL x,
CCTK_REAL y, CCTK_REAL z);
+void SpecCoef(int n1, int n2, int n3, int ivar, CCTK_REAL *v, CCTK_REAL *cf);
+CCTK_REAL PunctEvalAtArbitPositionFast (CCTK_REAL *v, int ivar, CCTK_REAL A, CCTK_REAL B, CCTK_REAL phi,
+ int nvar, int n1, int n2, int n3);
+CCTK_REAL PunctIntPolAtArbitPositionFast (int ivar, int nvar, int n1,
+ int n2, int n3, derivs v, CCTK_REAL x,
+ CCTK_REAL y, CCTK_REAL z);
+
/* Routines in "CoordTransf.c"*/
void AB_To_XR (int nvar, CCTK_REAL A, CCTK_REAL B, CCTK_REAL *X,