Skip to content

Commit

Permalink
#177: Included beta* calculations in getdiff
Browse files Browse the repository at this point in the history
  • Loading branch information
JoschD committed Nov 1, 2018
1 parent 8abc4f1 commit 8fa00d7
Show file tree
Hide file tree
Showing 7 changed files with 191 additions and 25 deletions.
20 changes: 14 additions & 6 deletions check_calculated_corrections.py
Original file line number Diff line number Diff line change
Expand Up @@ -21,6 +21,9 @@

RESULTS_DIR = "Results" # name of the (temporary) results folder
BASE_ID = ".tmpbasefile" # extension of the (temporary) base files
LOG_FILE = "check_corrections.log"
MADX_FILE = "job.corrections.madx"
MADXLOG_FILE = "job.corrections.log"


def get_params():
Expand Down Expand Up @@ -184,7 +187,7 @@ def main(opt, accel_opt):
opt.corrections_dir = os.path.join(opt.meas_dir, "Corrections")
logging_tools.add_module_handler(
logging_tools.file_handler(
os.path.join(opt.corrections_dir, "check_corrections.log")
os.path.join(opt.corrections_dir, LOG_FILE)
)
)

Expand Down Expand Up @@ -283,9 +286,9 @@ def _plot(corrections, source_dir, show_plots, change_marker, auto_scale, masks)
meas = column_map[data]['meas']
expect = column_map[data]['expect']
error = column_map[data]['error']
filename = column_map[data]['file']
filename = getdiff.get_diff_filename(column_map[data]['file'])

files_c = [os.path.join(folder, RESULTS_DIR, filename + ".out") for folder in sort_correct]
files_c = [os.path.join(folder, RESULTS_DIR, filename) for folder in sort_correct]

try:
file_base = _create_base_file(source_dir, files_c[0], meas, error, expect, data)
Expand Down Expand Up @@ -355,8 +358,8 @@ def _call_madx(accel_inst, corrections):

madx_wrapper.resolve_and_run_string(
job_content,
output_file=os.path.join(dir_out, "job.corrections.madx"),
log_file=os.path.join(dir_out, "job.corrections.log"),
output_file=os.path.join(dir_out, MADX_FILE),
log_file=os.path.join(dir_out, MADXLOG_FILE),
)


Expand All @@ -366,14 +369,18 @@ def _get_madx_job(accel_inst):
job_content += (
"select, flag=twiss, clear;\n"
"select, flag=twiss, pattern='^BPM.*\.B{beam:d}$', "
"column=NAME,S,BETX,ALFX,BETY,ALFY,DX,DY,DPX,DPY,X,Y,K1L,MUX,MUY,R11,R12,R21,R22;\n\n"
"column=NAME,S,BETX,ALFX,BETY,ALFY,DX,DY,DPX,DPY,X,Y,K1L,MUX,MUY,R11,R12,R21,R22;\n"
"select, flag=twiss, pattern='^IP[1-8]$', "
"column=NAME,S,BETX,ALFX,BETY,ALFY,DX,DY,DPX,DPY,X,Y,K1L,MUX,MUY,R11,R12,R21,R22;\n"
"\n"
).format(beam=accel_inst.get_beam())
return job_content


# Helper #####################################################################



def _create_base_file(source_dir, source_file, meas, error, expect, outname):
""" Copy Measurement into a base-file. """
data = tfs_pandas.read_tfs(source_file)
Expand Down Expand Up @@ -429,6 +436,7 @@ def _log_rms(files, legends, column_name, mask):
l, collected[l]["rms"], collected[l]["mean"]))
return collected


def _rms(data):
return np.sqrt(np.mean(np.square(data)))

Expand Down
105 changes: 91 additions & 14 deletions correction/getdiff.py
Original file line number Diff line number Diff line change
Expand Up @@ -23,12 +23,20 @@
Expected values after correction to be put in, little tricky with phase column names
No coupling in twiss_no.dat? not used
Some hints:
MEA, MODEL, EXPECT are usually the names for the differences between the values and the model.
Apart from phase, where these differences are called DIFF and DIFF_MDL (EXPECT is still the
same) while MEA and MODEL are the actual measurement and model values respectively.
Don't look into the coupling and chromatic coupling namings.
"""
from __future__ import print_function
import numpy as np
import pandas as pd
import sys
import os
import re
from os.path import abspath, join, dirname, isdir, exists, split, pardir

new_path = abspath(join(dirname(abspath(__file__)), pardir))
Expand All @@ -38,7 +46,7 @@
from optics_measurements.io_filehandler import OpticsMeasurement
from twiss_optics.optics_class import TwissOptics
from tfs_files.tfs_pandas import read_tfs, write_tfs
from utils import logging_tools
from utils import logging_tools, beta_star_from_twiss

LOG = logging_tools.get_logger(__name__)

Expand All @@ -51,6 +59,10 @@
# Main invocation ############################################################


def get_diff_filename(id):
return "diff_{:s}.out".format(id)


def getdiff(meas_path=None, beta_file_name="getbeta"):
""" Calculates the differences between measurement, corrected and uncorrected model.
Expand Down Expand Up @@ -83,19 +95,20 @@ def getdiff(meas_path=None, beta_file_name="getbeta"):
coupling_model['NAME'] = coupling_model.index.values

for plane in ['x', 'y']:
_write_beta_diff_file(meas_path, meas, model, plane, beta_file_name)
_write_betabeat_diff_file(meas_path, meas, model, plane, beta_file_name)
_write_phase_diff_file(meas_path, meas, model, plane)
_write_disp_diff_file(meas_path, meas, model, plane)
_write_coupling_diff_file(meas_path, meas, coupling_model)
_write_norm_disp_diff_file(meas_path, meas, model)
_write_chromatic_coupling_files(meas_path, corrected_model_path)
_write_betastar_diff_file(meas_path, meas, twiss_cor, twiss_no)
LOG.debug("Finished 'getdiff'.")


# Writing Functions ##########################################################


def _write_beta_diff_file(meas_path, meas, model, plane, betafile):
def _write_betabeat_diff_file(meas_path, meas, model, plane, betafile):
LOG.debug("Calculating beta diff.")
if betafile == "getbeta":
meas_beta = meas.beta[plane]
Expand All @@ -114,7 +127,7 @@ def _write_beta_diff_file(meas_path, meas, model, plane, betafile):
tw['MODEL'] = ((tw.loc[:, 'BET' + up + '_c'] - tw.loc[:, 'BET' + up + '_n'])
/ tw.loc[:, 'BET' + up + '_n'])
tw['EXPECT'] = tw['MEA'] - tw['MODEL']
write_tfs(join(meas_path, 'bb' + plane + '.out'),
write_tfs(join(meas_path, get_diff_filename('bb' + plane)),
tw.loc[:, ['NAME', 'S', 'MEA', 'ERROR', 'MODEL', 'EXPECT']])


Expand All @@ -128,39 +141,41 @@ def _write_phase_diff_file(meas_path, meas, model, plane):
tw['DIFF'] = tw.loc[:, 'PHASE' + up] - tw.loc[:, 'PH' + up + 'MDL']
tw['DIFF_MDL'] = tw.loc[:, 'MODEL'] - tw.loc[:, 'PH' + up + 'MDL']
tw['EXPECT'] = tw['DIFF'] - tw['DIFF_MDL']
write_tfs(join(meas_path, 'phase' + plane + '.out'),
write_tfs(join(meas_path, get_diff_filename('phase' + plane)),
tw.loc[tw.index[:-1],
['NAME', 'S', 'MEA', 'ERROR', 'MODEL', 'DIFF', 'DIFF_MDL', 'EXPECT']])


def _write_disp_diff_file(meas_path, meas, model, plane):
LOG.debug("Calculating dispersion diff.")
up = plane.upper()
try:
up = plane.upper()
tw = pd.merge(meas.disp[plane], model, how='inner', on='NAME')
except IOError:
LOG.debug("Dispersion measurements not found. Skipped.")
else:
tw['MEA'] = tw.loc[:, 'D' + up] - tw.loc[:, 'D' + up + 'MDL']
tw['ERROR'] = tw.loc[:, 'STDD' + up]
tw['MODEL'] = tw.loc[:, 'D' + up + '_c'] - tw.loc[:, 'D' + up + '_n']
tw['EXPECT'] = tw['MEA'] - tw['MODEL']
write_tfs(join(meas_path, 'd' + plane + '.out'),
write_tfs(join(meas_path, get_diff_filename('d' + plane)),
tw.loc[:, ['NAME', 'S', 'MEA', 'ERROR', 'MODEL', 'EXPECT']])
except IOError:
LOG.debug("Dispersion measurements not found. Skipped.")


def _write_norm_disp_diff_file(meas_path, meas, model):
LOG.debug("Calculating normalized dispersion diff.")
try:
tw = pd.merge(meas.norm_disp, model, how='inner', on='NAME')
except IOError:
LOG.debug("Normalized dispersion measurements not found. Skipped.")
else:
tw['MEA'] = tw.loc[:, 'NDX'] - tw.loc[:, 'NDXMDL']
tw['ERROR'] = tw.loc[:, 'STDNDX']
tw['MODEL'] = (tw.loc[:, 'DX_c'] / np.sqrt(tw.loc[:, 'BETX_c'])
- tw.loc[:, 'DX_n'] / np.sqrt(tw.loc[:, 'BETX_n']))
tw['EXPECT'] = tw['MEA'] - tw['MODEL']
write_tfs(join(meas_path, 'ndx.out'),
tw.loc[:, ['NAME', 'S', 'MEA', 'ERROR', 'MODEL', 'EXPECT']])
except IOError:
LOG.debug("Normalized dispersion measurements not found. Skipped.")


def _write_coupling_diff_file(meas_path, meas, model):
Expand All @@ -185,7 +200,7 @@ def _write_coupling_diff_file(meas_path, meas, model):

tw['in_use'] = 1
out_columns += ['in_use']
write_tfs(join(meas_path, 'couple.out'), tw.loc[:, out_columns])
write_tfs(join(meas_path, get_diff_filename('couple')), tw.loc[:, out_columns])


def _write_chromatic_coupling_files(meas_path, cor_path):
Expand All @@ -194,6 +209,9 @@ def _write_chromatic_coupling_files(meas_path, cor_path):
try:
twiss_plus = read_tfs(join(split(cor_path)[0], TWISS_CORRECTED_PLUS), index='NAME')
twiss_min = read_tfs(join(split(cor_path)[0], TWISS_CORRECTED_MINUS), index='NAME')
except IOError:
LOG.debug("Chromatic coupling measurements not found. Skipped.")
else:
deltap = np.abs(twiss_plus.DELTAP - twiss_min.DELTAP)
plus = TwissOptics(twiss_plus, quick_init=True).get_coupling(method='cmatrix')
minus = TwissOptics(twiss_min, quick_init=True).get_coupling(method='cmatrix')
Expand All @@ -210,14 +228,73 @@ def _write_chromatic_coupling_files(meas_path, cor_path):
tw['Cf1001i_model'] = np.imag(cf1001)
tw['Cf1001r_prediction'] = tw.loc[:, 'Cf1001r'] - tw.loc[:, 'Cf1001r_model']
tw['Cf1001i_prediction'] = tw.loc[:, 'Cf1001i'] - tw.loc[:, 'Cf1001i_model']
write_tfs(join(meas_path, 'chromatic_coupling.out'),
write_tfs(join(meas_path, get_diff_filename('chromatic_coupling')),
tw.loc[:, ['NAME', 'S',
'Cf1001r', 'Cf1001rERR',
'Cf1001i', 'Cf1001iERR',
'Cf1001r_model', 'Cf1001i_model',
'Cf1001r_prediction', 'Cf1001i_prediction']])


def _write_betastar_diff_file(meas_path, meas, twiss_cor, twiss_no):
LOG.debug("Calculating betastar diff at the IPs.")
try:
meas = meas.kmod_betastar.set_index(beta_star_from_twiss.RES_COLUMNS[0])
except IOError:
LOG.debug("Chromatic coupling measurements not found. Skipped.")
LOG.debug("Beta* measurements not found. Skipped.")
else:
# get all IPs
ip_map = {}
beam = ''
for label in meas.index.values:
ip, beam = re.findall(r'\d', label)[-2:] # beam should be the same for all
if ip not in "1258":
raise NotImplementedError(
"Beta-Star comparison is not yet implemented for measurements in IP" + ip)
ip_label = "IP" + ip
ip_map[label] = ip_label

beam = int(beam)
all_ips = set(ip_map.values())
try:
# calculate waist and so on
model = beta_star_from_twiss.get_beta_star_and_waist_from_ip(twiss_cor, beam, all_ips)
design = beta_star_from_twiss.get_beta_star_and_waist_from_ip(twiss_no, beam, all_ips)
except KeyError:
LOG.warn("Can't find all IPs in twiss files. Skipped beta* calculations.")
else:
# extract data
tw = pd.DataFrame()
for label in meas.index:
plane = label[-1]
ip_name = beta_star_from_twiss.get_full_label(ip_map[label], beam, plane)
tw.loc[label, "S"] = model.loc[ip_name, "S"]
for attr in beta_star_from_twiss.RES_COLUMNS[2:]:
# default diff parameter
tw.loc[label, attr + "_MEA"] = (meas.loc[label, attr]
- design.loc[ip_name, attr])
tw.loc[label, attr + "_ERROR"] = meas.loc[label, attr + "_ERR"]
tw.loc[label, attr + "_MODEL"] = (model.loc[ip_name, attr]
- design.loc[ip_name, attr])
tw.loc[label, attr + "_EXPECT"] = (tw.loc[label, attr + "_MEA"]
- tw.loc[label, attr + "_MODEL"])
# additional for debug reasons
tw.loc[label, attr + "_MEAVAL"] = meas.loc[label, attr]
tw.loc[label, attr + "_DESIGN"] = design.loc[ip_name, attr]
tw.loc[label, attr + "_EXPECTVAL"] = (design.loc[ip_name, attr]
+ tw.loc[label, attr + "_EXPECT"])
# and the beatings
if "BETA" in attr:
tw.loc[label, "B{}_MEA".format(attr)] = (tw.loc[label, attr + "_MEA"]
/ design.loc[ip_name, attr])
tw.loc[label, "B{}_MODEL".format(attr)] = (tw.loc[label, attr + "_MODEL"]
/ design.loc[ip_name, attr])
tw.loc[label, "B{}_EXPECT".format(attr)] = (
tw.loc[label, "B{}_MEA".format(attr)]
- tw.loc[label, "B{}_MODEL".format(attr)])

write_tfs(join(meas_path, get_diff_filename('betastar')), tw,
save_index=beta_star_from_twiss.RES_COLUMNS[0])


# Script Mode ################################################################
Expand Down
9 changes: 8 additions & 1 deletion kmod/gui2beta/get_kmod_files.py
Original file line number Diff line number Diff line change
Expand Up @@ -42,13 +42,20 @@ def merge_and_copy_kmod_output(beam, kmod_dir, res_dir, mod_path):

# copy beta data
for plane in "xy":
up = plane.upper()
new_data = tfs_pandas.TfsDataFrame()
for ip_dir_name in ip_dir_names:
src = join(kmod_dir, ip_dir_name, get_beta_filename(plane))
data = _load_source_data(src, "NAME")
if data is not None:
new_data = new_data.append(data.loc[data.index.isin(model_twiss.index), :])
in_model = data.index.isin(model_twiss.index)
new_data = new_data.append(data.loc[in_model, :])

# Todo: Let Kmod fill these columns in the future
new_data["S"] = model_twiss.loc[new_data.index, "S"]
new_data["BET{}MDL".format(up)] = model_twiss.loc[new_data.index, "BET{}".format(up)]
new_data = new_data.rename(columns={"BET{}STD".format(up): "ERRBET{}".format(up)})

dst = join(res_dir, get_beta_merged_filename(plane))
tfs_pandas.write_tfs(dst, new_data, save_index="NAME")

Expand Down
1 change: 1 addition & 0 deletions kmod/gui2beta/gui2kmod.py
Original file line number Diff line number Diff line change
Expand Up @@ -26,6 +26,7 @@
# TODO: Immediately: Use a logger for logging
# TODO: Immediately: get rid of repetive code and use loops and functions
# TODO: Immediately: Use tfs_pandas instead of metaclass
# TODO: Immediately: Make result columns visible from outside (for other functions to use)

def parse_args():
parser = argparse.ArgumentParser()
Expand Down
11 changes: 7 additions & 4 deletions model/accelerators/lhc/job.twiss_general_java.madx
Original file line number Diff line number Diff line change
Expand Up @@ -11,13 +11,16 @@ option, echo;
exec, match_tunes(%QMX, %QMY, %NUM_BEAM);


!!!!! nominal
exec, coupling_knob(%NUM_BEAM);
select, flag=twiss, clear;
select, flag=twiss, pattern='^BPM.*\.B%NUM_BEAM$', column=NAME,S,BETX,ALFX,BETY,ALFY,DX,DY,DPX,DPY,X,Y,K1L,MUX,MUY,R11,R12,R21,R22;
select, flag=twiss, pattern='^IP[1-8]$', column=NAME,S,BETX,ALFX,BETY,ALFY,DX,DY,DPX,DPY,X,Y,K1L,MUX,MUY,R11,R12,R21,R22;

exec, do_twiss_monitors(LHCB%NUM_BEAM, "%PATH/twiss_no.dat", 0.0);
!!!!! nominal
twiss, file= "%PATH/twiss_no.dat";

exec, coupling_knob(%NUM_BEAM);
%COR

exec, do_twiss_monitors(LHCB%NUM_BEAM, "%PATH/twiss_cor.dat", 0.0);
twiss, file= "%PATH/twiss_cor.dat";
%CHROMtwiss, chrom,sequence=LHCB%NUM_BEAM, deltap=%DELTAPM, file="%PATH/twiss_cor_dpm.dat";
%CHROMtwiss, chrom,sequence=LHCB%NUM_BEAM, deltap=%DELTAPP, file="%PATH/twiss_cor_dpp.dat";
1 change: 1 addition & 0 deletions optics_measurements/io_filehandler.py
Original file line number Diff line number Diff line change
Expand Up @@ -16,6 +16,7 @@ class OpticsMeasurement(TfsCollection):
beta = Tfs("getbeta")
amp_beta = Tfs("getampbeta")
kmod_beta = Tfs("getkmodbeta")
kmod_betastar = Tfs("getkmodbetastar", two_planes=False)
phase = Tfs("getphase")
phasetot = Tfs("getphasetot")
disp = Tfs("getD")
Expand Down
Loading

0 comments on commit 8fa00d7

Please sign in to comment.