Skip to content
Snippets Groups Projects
Commit d75d67b5 authored by Gregory Ashton's avatar Gregory Ashton
Browse files

Initial (untested) changes to proper calculation of the volume

parent 14ecd45b
Branches
Tags
No related merge requests found
...@@ -11,6 +11,7 @@ import inspect ...@@ -11,6 +11,7 @@ import inspect
import peakutils import peakutils
from functools import wraps from functools import wraps
from scipy.stats.distributions import ncx2 from scipy.stats.distributions import ncx2
import lal
import matplotlib.pyplot as plt import matplotlib.pyplot as plt
import numpy as np import numpy as np
...@@ -203,3 +204,8 @@ def run_commandline (cl): ...@@ -203,3 +204,8 @@ def run_commandline (cl):
os.system('\n') os.system('\n')
return(out) return(out)
def convert_array_to_gsl_matrix(array):
gsl_matrix = lal.gsl_matrix(*array.shape)
gsl_matrix.data = array
return gsl_matrix
...@@ -1908,7 +1908,7 @@ class MCMCFollowUpSearch(MCMCSemiCoherentSearch): ...@@ -1908,7 +1908,7 @@ class MCMCFollowUpSearch(MCMCSemiCoherentSearch):
if generate_setup: if generate_setup:
nsegs_vals, V_vals = get_optimal_setup( nsegs_vals, V_vals = get_optimal_setup(
R, Nsegs0, self.tref, self.minStartTime, R, Nsegs0, self.tref, self.minStartTime,
self.maxStartTime, DeltaOmega, DeltaFs, fiducial_freq, self.maxStartTime, self.theta_prior, fiducial_freq,
self.search.detector_names, self.earth_ephem, self.search.detector_names, self.earth_ephem,
self.sun_ephem) self.sun_ephem)
self.write_setup_input_file(run_setup_input_file, R, Nsegs0, self.write_setup_input_file(run_setup_input_file, R, Nsegs0,
...@@ -1936,7 +1936,7 @@ class MCMCFollowUpSearch(MCMCSemiCoherentSearch): ...@@ -1936,7 +1936,7 @@ class MCMCFollowUpSearch(MCMCSemiCoherentSearch):
else: else:
V = get_V_estimate( V = get_V_estimate(
rs[1], self.tref, self.minStartTime, self.maxStartTime, rs[1], self.tref, self.minStartTime, self.maxStartTime,
DeltaOmega, DeltaFs, fiducial_freq, self.theta_prior, fiducial_freq,
self.search.detector_names, self.earth_ephem, self.search.detector_names, self.earth_ephem,
self.sun_ephem) self.sun_ephem)
V_vals.append(V) V_vals.append(V)
......
...@@ -10,17 +10,18 @@ import numpy as np ...@@ -10,17 +10,18 @@ import numpy as np
import scipy.optimize import scipy.optimize
import lal import lal
import lalpulsar import lalpulsar
import helper_functions
def get_optimal_setup( def get_optimal_setup(
R, Nsegs0, tref, minStartTime, maxStartTime, DeltaOmega, R, Nsegs0, tref, minStartTime, maxStartTime, prior, fiducial_freq,
DeltaFs, fiducial_freq, detector_names, earth_ephem, sun_ephem): detector_names, earth_ephem, sun_ephem):
logging.info('Calculating optimal setup for R={}, Nsegs0={}'.format( logging.info('Calculating optimal setup for R={}, Nsegs0={}'.format(
R, Nsegs0)) R, Nsegs0))
V_0 = get_V_estimate( V_0 = get_V_estimate(
Nsegs0, tref, minStartTime, maxStartTime, DeltaOmega, DeltaFs, Nsegs0, tref, minStartTime, maxStartTime, prior, fiducial_freq,
fiducial_freq, detector_names, earth_ephem, sun_ephem) detector_names, earth_ephem, sun_ephem)
logging.info('Stage {}, nsegs={}, V={}'.format(0, Nsegs0, V_0)) logging.info('Stage {}, nsegs={}, V={}'.format(0, Nsegs0, V_0))
nsegs_vals = [Nsegs0] nsegs_vals = [Nsegs0]
...@@ -30,8 +31,8 @@ def get_optimal_setup( ...@@ -30,8 +31,8 @@ def get_optimal_setup(
nsegs_i = Nsegs0 nsegs_i = Nsegs0
while nsegs_i > 1: while nsegs_i > 1:
nsegs_i, V_i = get_nsegs_ip1( nsegs_i, V_i = get_nsegs_ip1(
nsegs_i, R, tref, minStartTime, maxStartTime, DeltaOmega, nsegs_i, R, tref, minStartTime, maxStartTime, prior, fiducial_freq,
DeltaFs, fiducial_freq, detector_names, earth_ephem, sun_ephem) detector_names, earth_ephem, sun_ephem)
nsegs_vals.append(nsegs_i) nsegs_vals.append(nsegs_i)
V_vals.append(V_i) V_vals.append(V_i)
i += 1 i += 1
...@@ -42,13 +43,13 @@ def get_optimal_setup( ...@@ -42,13 +43,13 @@ def get_optimal_setup(
def get_nsegs_ip1( def get_nsegs_ip1(
nsegs_i, R, tref, minStartTime, maxStartTime, DeltaOmega, nsegs_i, R, tref, minStartTime, maxStartTime, prior, fiducial_freq,
DeltaFs, fiducial_freq, detector_names, earth_ephem, sun_ephem): detector_names, earth_ephem, sun_ephem):
log10R = np.log10(R) log10R = np.log10(R)
log10Vi = np.log10(get_V_estimate( log10Vi = np.log10(get_V_estimate(
nsegs_i, tref, minStartTime, maxStartTime, DeltaOmega, DeltaFs, nsegs_i, tref, minStartTime, maxStartTime, prior, fiducial_freq,
fiducial_freq, detector_names, earth_ephem, sun_ephem)) detector_names, earth_ephem, sun_ephem))
def f(nsegs_ip1): def f(nsegs_ip1):
if nsegs_ip1[0] > nsegs_i: if nsegs_ip1[0] > nsegs_i:
...@@ -59,8 +60,8 @@ def get_nsegs_ip1( ...@@ -59,8 +60,8 @@ def get_nsegs_ip1(
if nsegs_ip1 == 0: if nsegs_ip1 == 0:
nsegs_ip1 = 1 nsegs_ip1 = 1
Vip1 = get_V_estimate( Vip1 = get_V_estimate(
nsegs_ip1, tref, minStartTime, maxStartTime, DeltaOmega, nsegs_ip1, tref, minStartTime, maxStartTime, prior, fiducial_freq,
DeltaFs, fiducial_freq, detector_names, earth_ephem, sun_ephem) detector_names, earth_ephem, sun_ephem)
if Vip1 is None: if Vip1 is None:
return 1e6 return 1e6
else: else:
...@@ -73,15 +74,47 @@ def get_nsegs_ip1( ...@@ -73,15 +74,47 @@ def get_nsegs_ip1(
nsegs_ip1 = 1 nsegs_ip1 = 1
if res.success: if res.success:
return nsegs_ip1, get_V_estimate( return nsegs_ip1, get_V_estimate(
nsegs_ip1, tref, minStartTime, maxStartTime, DeltaOmega, DeltaFs, nsegs_ip1, tref, minStartTime, maxStartTime, prior, fiducial_freq,
fiducial_freq, detector_names, earth_ephem, sun_ephem) detector_names, earth_ephem, sun_ephem)
else: else:
raise ValueError('Optimisation unsuccesful') raise ValueError('Optimisation unsuccesful')
def get_parallelepiped(prior):
keys = ['Alpha', 'Delta', 'F0', 'F1', 'F2']
spindown_keys = keys[3:]
sky_keys = keys[:2]
lims = []
lims_keys = []
lims_idxs = []
for i, key in enumerate(keys):
if type(prior[key]) == dict:
if prior[key]['type'] == 'unif':
lims.append([prior[key]['lower'], prior[key]['upper']])
lims_keys.append(key)
lims_idxs.append(i)
else:
raise ValueError(
"Prior type {} not yet supported".format(
prior[key]['type']))
elif key not in spindown_keys:
lims.append([prior[key], 0])
lims = np.array(lims)
lims_keys = np.array(lims_keys)
base = lims[:, 0]
p = [base]
for i in lims_idxs:
basex = base.copy()
basex[i] = lims[i, 1]
p.append(basex)
spindowns = np.sum([np.sum(lims_keys == k) for k in spindown_keys])
sky = any([key in lims_keys for key in sky_keys])
return np.array(p).T, spindowns , sky
def get_V_estimate( def get_V_estimate(
nsegs, tref, minStartTime, maxStartTime, DeltaOmega, DeltaFs, nsegs, tref, minStartTime, maxStartTime, prior, fiducial_freq,
fiducial_freq, detector_names, earth_ephem, sun_ephem): detector_names, earth_ephem, sun_ephem):
""" Returns V estimated from the super-sky metric """ Returns V estimated from the super-sky metric
Parameters Parameters
...@@ -92,11 +125,8 @@ def get_V_estimate( ...@@ -92,11 +125,8 @@ def get_V_estimate(
Reference time in GPS seconds Reference time in GPS seconds
minStartTime, maxStartTime: int minStartTime, maxStartTime: int
Minimum and maximum SFT timestamps Minimum and maximum SFT timestamps
DeltaOmega: float prior: dict
Solid angle of the sky-patch The prior dictionary
DeltaFs: array
Array of [DeltaF0, DeltaF1, ...], length determines the number of
spin-down terms.
fiducial_freq: float fiducial_freq: float
Fidicual frequency Fidicual frequency
detector_names: array detector_names: array
...@@ -105,7 +135,12 @@ def get_V_estimate( ...@@ -105,7 +135,12 @@ def get_V_estimate(
Paths to the ephemeris files Paths to the ephemeris files
""" """
spindowns = len(DeltaFs) - 1 in_phys, spindowns, sky = get_parallelepiped(prior)
out_rssky = np.zeros(in_phys.shape)
in_phys = helper_functions.convert_array_to_gsl_matrix(in_phys)
out_rssky = helper_functions.convert_array_to_gsl_matrix(out_rssky)
tboundaries = np.linspace(minStartTime, maxStartTime, nsegs+1) tboundaries = np.linspace(minStartTime, maxStartTime, nsegs+1)
ref_time = lal.LIGOTimeGPS(tref) ref_time = lal.LIGOTimeGPS(tref)
...@@ -130,15 +165,21 @@ def get_V_estimate( ...@@ -130,15 +165,21 @@ def get_V_estimate(
logging.debug('Encountered run-time error {}'.format(e)) logging.debug('Encountered run-time error {}'.format(e))
return None, None, None return None, None, None
sqrtdetG_SKY = np.sqrt(np.linalg.det( if sky:
SSkyMetric.semi_rssky_metric.data[:2, :2])) i = 0
sqrtdetG_PE = np.sqrt(np.linalg.det( else:
SSkyMetric.semi_rssky_metric.data[2:, 2:])) i = 2
Vsky = .5*sqrtdetG_SKY*DeltaOmega lalpulsar.ConvertPhysicalToSuperskyPoints(
Vpe = sqrtdetG_PE * np.prod(DeltaFs) out_rssky, in_phys, SSkyMetric.semi_rssky_transf)
if Vsky == 0:
Vsky = 1 parallelepiped = (out_rssky.data[i:, 1:].T - out_rssky.data[i:, 0]).T
if Vpe == 0:
Vpe = 1 sqrtdetG = np.sqrt(np.linalg.det(
return Vsky * Vpe SSkyMetric.semi_rssky_metric.data[i:, i:]))
dV = np.abs(np.linalg.det(parallelepiped))
V = sqrtdetG * dV
return V
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Please register or to comment