Difference between revisions of "Dx map"

From relax wiki
Jump to navigation Jump to search
Line 55: Line 55:
 
relax cpmg_synthetic.py
 
relax cpmg_synthetic.py
 
</source>
 
</source>
Here is the script '''cpmg_synthetic.py'''
 
<source lang="Python">
 
 
# Script for calculating synthetics CPMG data.
 
# Script for calculating synthetics CPMG data.
  
Line 383: Line 381:
 
# To map the hypersurface of chi2, when altering kex, dw and pA.
 
# To map the hypersurface of chi2, when altering kex, dw and pA.
 
if ds.opendx:
 
if ds.opendx:
 +
    # First switch pipe, since dx.map will go through parameters and end up a "bad" place. :-9
 +
    pipe_name_MODEL_MAP = "%s_%s_map"%(pipe_name, model_analyse)
 +
    pipe.copy(pipe_from=pipe_name_MODEL, pipe_to=pipe_name_MODEL_MAP, bundle_to = pipe_bundle)
 +
    pipe.switch(pipe_name=pipe_name_MODEL_MAP)
 +
 
     for cur_spin, mol_name, resi, resn, spin_id in spin_loop(full_info=True, return_id=True, skip_desel=True):
 
     for cur_spin, mol_name, resi, resn, spin_id in spin_loop(full_info=True, return_id=True, skip_desel=True):
 
         cur_spin_id = spin_id
 
         cur_spin_id = spin_id
Line 389: Line 392:
 
         #vp_exec:  A flag specifying whether to execute the visual program automatically at start-up.
 
         #vp_exec:  A flag specifying whether to execute the visual program automatically at start-up.
 
         #dx.execute(file_prefix=file_name, dir=ds.resdir, dx_exe='dx', vp_exec=True)
 
         #dx.execute(file_prefix=file_name, dir=ds.resdir, dx_exe='dx', vp_exec=True)
 +
 +
# Switch back to model pipe.
 +
pipe.switch(pipe_name=pipe_name_MODEL)
  
 
# Remove insignificant
 
# Remove insignificant

Revision as of 22:24, 7 May 2014

Code to generate map

# See relax help in prompt
help(dx.map)

from pipe_control.mol_res_spin import return_spin, spin_loop

for cur_spin, mol_name, resi, resn, spin_id in spin_loop(full_info=True, return_id=True, skip_desel=True):
    file_name = "map%s" % (cur_spin_id .replace('#', '_').replace(':', '_').replace('@', '_'))
    dx.map(params=['dw', 'pA', 'kex'], map_type='Iso3D', spin_id=":1@N", inc=70, lower=None, upper=None, axis_incs=5, file_prefix=file_name, dir=ds.resdir, point=None, point_file='point', remap=None)
    #vp_exec:  A flag specifying whether to execute the visual program automatically at start-up.
    dx.execute(file_prefix=file_name, dir=ds.resdir, dx_exe='dx', vp_exec=True)

How to install dx

See install dx

How to use dx

  • Run 'dx',

In teh Data explorer or DE.

  • Click on Edit Visual Programs....
  • Select the map.net program created by relax,

Now in the Visual Program Editor or VPE.

  • Select the menu entry 'Execute->Execute on change'.

That's it.

You now have a 3D frame, but nothing in it.
Therefore the contour levels must be too low or high.
From the map file, the values are in the hundreds of thousands.

Then:

  • In the main program window, double click on the 'Isosurface elements'.
  • Change the values until you see surfaces. In the first the value is 500. I changed this to 500,000. Multiply all by 1000.
  • In the second, 100 -> 100000.
  • In the third, 20 -> 20000.
  • In the last, 7 -> 7000.

This should maybe be performed by the dx.map user function, determining reasonable contour levels.

With a bit of zooming, clicking on 'File -> Save image' in the "Surface" window, "allowing rendering", and outputting to a large TIFF file, "save current", then "apply".

An example image cropped and converted to PNG in the GIMP at
https://gna.org/bugs/download.php?file_id=20641.

Note that for a good resolution plot, you will need many more increments.
Using the lower and upper dx.map arguments will be useful to zoom into the space.

Code to generate map

This script will generate data that can help visualize the different models and the minimisation algorithms in relax.

Call the script cpmg_synthetic.py or similar. Remember .py ending

relax cpmg_synthetic.py
  1. Script for calculating synthetics CPMG data.
  1. Python module imports.

from os import sep from tempfile import mkdtemp from math import sqrt

  1. relax module imports.

from auto_analyses.relax_disp import Relax_disp from lib.io import open_write_file from data_store import Relax_data_store; ds = Relax_data_store() from pipe_control.mol_res_spin import return_spin, spin_loop from specific_analyses.relax_disp.data import generate_r20_key, loop_exp_frq, loop_offset_point from specific_analyses.relax_disp import optimisation from status import Status; status = Status()

  1. The variables already defined in relax.

from specific_analyses.relax_disp.variables import EXP_TYPE_CPMG_SQ, MODEL_PARAMS

  1. Analytical

from specific_analyses.relax_disp.variables import MODEL_CR72, MODEL_IT99, MODEL_TSMFK01, MODEL_B14

  1. Analytical full

from specific_analyses.relax_disp.variables import MODEL_CR72_FULL, MODEL_B14_FULL

  1. NS : Numerical Solution

from specific_analyses.relax_disp.variables import MODEL_NS_CPMG_2SITE_3D, MODEL_NS_CPMG_2SITE_STAR, MODEL_NS_CPMG_2SITE_EXPANDED

  1. NS full

from specific_analyses.relax_disp.variables import MODEL_NS_CPMG_2SITE_3D_FULL, MODEL_NS_CPMG_2SITE_STAR_FULL

  1. Analysis variables.
  2. The dispersion model to test.

if not hasattr(ds, 'data'):

   ### Take a numerical model to create the data.
   ## The "NS CPMG 2-site 3D full" is here the best, since you can define both r2a and r2b.
   #model_create = MODEL_NS_CPMG_2SITE_3D
   #model_create = MODEL_NS_CPMG_2SITE_3D_FULL
   #model_create = MODEL_NS_CPMG_2SITE_STAR
   #model_create = MODEL_NS_CPMG_2SITE_STAR_FULL
   model_create = MODEL_NS_CPMG_2SITE_EXPANDED
   #model_create = MODEL_CR72
   #model_create = MODEL_CR72_FULL
   #model_create = MODEL_B14
   #model_create = MODEL_B14_FULL
   ### The select a model to analyse with.
   ## Analytical : r2a = r2b
   model_analyse = MODEL_CR72
   #model_analyse = MODEL_IT99
   #model_analyse = MODEL_TSMFK01
   #model_analyse = MODEL_B14
   ## Analytical full : r2a != r2b
   #model_analyse = MODEL_CR72_FULL
   #model_analyse = MODEL_B14_FULL
   ## NS : r2a = r2b
   #model_analyse = MODEL_NS_CPMG_2SITE_3D
   #model_analyse = MODEL_NS_CPMG_2SITE_STAR
   #model_analyse = MODEL_NS_CPMG_2SITE_EXPANDED
   ## NS full : r2a = r2b
   #model_analyse = MODEL_NS_CPMG_2SITE_3D_FULL
   #model_analyse = MODEL_NS_CPMG_2SITE_STAR_FULL
   ## Experiments
   # Exp 1
   sfrq_1 = 599.8908617*1E6
   r20_key_1 = generate_r20_key(exp_type=EXP_TYPE_CPMG_SQ, frq=sfrq_1)
   time_T2_1 = 0.06
   ncycs_1 = [28, 4, 32, 60, 2, 10, 16, 8, 20, 50, 18, 40, 6, 12, 24]
   # Here you define the direct R2eff errors (rad/s), as being added or subtracted for the created R2eff point in the corresponding ncyc cpmg frequence.
   #r2eff_errs_1 = [0.05, -0.05, 0.05, -0.05, 0.05, -0.05, 0.05, -0.05, 0.05, -0.05, 0.05, -0.05, 0.05, -0.05, 0.05]
   r2eff_errs_1 = [0.0] * len(ncycs_1)
   exp_1 = [sfrq_1, time_T2_1, ncycs_1, r2eff_errs_1]
   sfrq_2 = 499.8908617*1E6
   r20_key_2 = generate_r20_key(exp_type=EXP_TYPE_CPMG_SQ, frq=sfrq_2)
   time_T2_2 = 0.04
   ncycs_2 = [20, 16, 10, 36, 2, 12, 4, 22, 18, 40, 14, 26, 8, 32, 24, 6, 28 ]
   # Here you define the direct R2eff errors (rad/s), as being added or subtracted for the created R2eff point in the corresponding ncyc cpmg frequence.
   #r2eff_errs_2 = [0.05, -0.05, 0.05, -0.05, 0.05, -0.05, 0.05, -0.05, 0.05, -0.05, 0.05, -0.05, 0.05, -0.05, 0.05, -0.05, 0.05]
   r2eff_errs_2 = [0.0] * len(ncycs_2)
   exp_2 = [sfrq_2, time_T2_2, ncycs_2, r2eff_errs_2]
   # Collect all exps
   #exps = [exp_1, exp_2]
   exps = [exp_1]
   # Add more spins here.
   spins = [
           ['Ala', 1, 'N', {'r2': {r20_key_1: 20.0, r20_key_2: 20.0}, 'r2a': {r20_key_1: 20.0, r20_key_2: 20.0}, 'r2b': {r20_key_1: 20.0, r20_key_2: 20.0}, 'kex': 2200.0, 'pA': 0.993, 'dw': 1.5} ]
           #['Ala', 2, 'N', {'r2': {r20_key_1: 13.0, r20_key_2: 14.5}, 'r2a': {r20_key_1: 13.0, r20_key_2: 14.5}, 'r2b': {r20_key_1: 13.0, r20_key_2: 14.5}, 'kex': 2200.0, 'pA': 0.993, 'dw': 1.5} ]
           ]
   ds.data = [model_create, model_analyse, spins, exps]
  1. The tmp directory.

if not hasattr(ds, 'tmpdir'):

   ds.tmpdir = None
  1. The results directory.

if not hasattr(ds, 'resdir'):

   ds.resdir = None
  1. Do set_grid_r20_from_min_r2eff ?.

if not hasattr(ds, 'set_grid_r20_from_min_r2eff'):

   ds.set_grid_r20_from_min_r2eff = True
  1. Remove insignificant level.

if not hasattr(ds, 'insignificance'):

   ds.insignificance = 0.0
  1. The grid search size (the number of increments per dimension). "None" will set default values.

if not hasattr(ds, 'GRID_INC'):

   #ds.GRID_INC = None
   ds.GRID_INC = 21
  1. The do clustering.

if not hasattr(ds, 'do_cluster'):

   ds.do_cluster = False
  1. The function tolerance. This is used to terminate minimisation once the function value between iterations is less than the tolerance.
  2. The default value is 1e-25.

if not hasattr(ds, 'set_func_tol'):

   ds.set_func_tol = 1e-25
  1. The maximum number of iterations.
  2. The default value is 1e7.

if not hasattr(ds, 'set_max_iter'):

   ds.set_max_iter = 10000000
  1. The verbosity level.

if not hasattr(ds, 'verbosity'):

   ds.verbosity = 1
  1. The rel_change WARNING level.

if not hasattr(ds, 'rel_change'):

   ds.rel_change = 0.05
  1. The plot_curves.

if not hasattr(ds, 'plot_curves'):

   ds.plot_curves = True
  1. The conversion for ShereKhan at http://sherekhan.bionmr.org/.

if not hasattr(ds, 'sherekhan_input'):

   ds.sherekhan_input = False
  1. Make a dx map to be opened om OpenDX.
  2. To map the hypersurface of chi2, when altering kex, dw and pA.

if not hasattr(ds, 'opendx'):

   ds.opendx = True

if not hasattr(ds, 'dx_inc'):

   ds.dx_inc = 70
  1. The set r2eff err.

if not hasattr(ds, 'r2eff_err'):

   ds.r2eff_err = 0.1
  1. The number of Monte Carlo simulations to be used for the error analyses.

if not hasattr(ds, 'MC_NUM'):

   ds.MC_NUM = 3
  1. The print result info.

if not hasattr(ds, 'print_res'):

   ds.print_res = True
  1. Set up the data pipe.
  1. Extract the models

model_create = ds.data[0] model_analyse = ds.data[1]

  1. Create the data pipe.

pipe_name = 'base pipe' pipe_type = 'relax_disp' pipe_bundle = 'relax_disp' pipe_name_r2eff = "%s_%s_R2eff"%(model_create, pipe_name) pipe.create(pipe_name=pipe_name, pipe_type=pipe_type, bundle = pipe_bundle)

  1. Generate the sequence.

cur_spins = ds.data[2] for res_name, res_num, spin_name, params in cur_spins:

   spin.create(res_name=res_name, res_num=res_num, spin_name=spin_name)
  1. Set isotope

spin.isotope('15N', spin_id='@N')

  1. Extract experiment settings.

exps = ds.data[3]

  1. Now loop over the experiments

exp_ids = [] for exp in exps:

   sfrq, time_T2, ncycs, r2eff_errs = exp
   exp_id = 'CPMG_%3.1f' % (sfrq/1E6)
   exp_ids.append(exp_id)
   ids = []
   for ncyc in ncycs:
       nu_cpmg = ncyc / time_T2
       cur_id = '%s_%.1f' % (exp_id, nu_cpmg)
       print cur_id
       ids.append(cur_id)
       # Set the spectrometer frequency.
       spectrometer.frequency(id=cur_id, frq=sfrq)
       # Set the experiment type.
       relax_disp.exp_type(spectrum_id=cur_id, exp_type=EXP_TYPE_CPMG_SQ)
       # Set the relaxation dispersion CPMG constant time delay T (in s).
       relax_disp.relax_time(spectrum_id=cur_id, time=time_T2)
       # Set the relaxation dispersion CPMG frequencies.
       relax_disp.cpmg_setup(spectrum_id=cur_id, cpmg_frq=nu_cpmg)

print("\n\nThe experiment IDs are %s." % ids)

    1. Now prepare to calculate the synthetic R2eff values.

pipe.copy(pipe_from=pipe_name, pipe_to=pipe_name_r2eff, bundle_to = pipe_bundle) pipe.switch(pipe_name=pipe_name_r2eff)

  1. Then select model.

relax_disp.select_model(model=model_create)

  1. First loop over the spins and set the model parameters.

for res_name, res_num, spin_name, params in cur_spins:

   cur_spin_id = ":%i@%s"%(res_num, spin_name)
   cur_spin = return_spin(cur_spin_id)
   #print cur_spin.model, cur_spin.name, cur_spin.isotope
   #print as
   # Now set the parameters.
   for mo_param in cur_spin.params:
       # The R2 is a dictionary, depending on spectrometer frequency.
       if isinstance(getattr(cur_spin, mo_param), dict):
           set_r2 = params[mo_param]
           for key, val in set_r2.items():
               # Update value to float
               set_r2.update({ key : float(val) })
               print cur_spin.model, res_name, cur_spin_id, mo_param, key, float(val)
           setattr(cur_spin, mo_param, set_r2)
       else:
           before = getattr(cur_spin, mo_param)
           setattr(cur_spin, mo_param, float(params[mo_param]))
           after = getattr(cur_spin, mo_param)
           print cur_spin.model, res_name, cur_spin_id, mo_param, before


    1. Now doing the back calculation of R2eff values.
  1. First loop over the frequencies.

i = 0 for exp_type, frq, ei, mi in loop_exp_frq(return_indices=True):

   exp_id = exp_ids[mi]
   exp = exps[mi]
   sfrq, time_T2, ncycs, r2eff_errs = exp
   # Then loop over the spins.
   for res_name, res_num, spin_name, params in cur_spins:
       cur_spin_id = ":%i@%s"%(res_num, spin_name)
       cur_spin = return_spin(cur_spin_id)
       ## First do a fake R2eff structure.
       # Define file name
       file_name = "%s%s.txt" % (exp_id, cur_spin_id .replace('#', '_').replace(':', '_').replace('@', '_'))
       file = open_write_file(file_name=file_name, dir=ds.tmpdir, force=True)
       # Then loop over the points, make a fake R2eff value.
       for offset, point, oi, di in loop_offset_point(exp_type=EXP_TYPE_CPMG_SQ, frq=frq, return_indices=True):
           string = "%.15f 1.0 %.3f\n"%(point, ds.r2eff_err)
           file.write(string)
       # Close file.
       file.close()
       # Read in the R2eff file to create the structure
       relax_disp.r2eff_read_spin(id=exp_id, spin_id=cur_spin_id, file=file_name, dir=ds.tmpdir, disp_point_col=1, data_col=2, error_col=3)
       ###Now back calculate, and stuff it back.
       print("Generating data with MODEL:%s, for spin id:%s"%(model_create, cur_spin_id))
       r2effs = optimisation.back_calc_r2eff(spin=cur_spin, spin_id=cur_spin_id)
       file = open_write_file(file_name=file_name, dir=ds.resdir, force=True)
       ## Loop over the R2eff structure
       # Loop over the points.
       for offset, point, oi, di in loop_offset_point(exp_type=EXP_TYPE_CPMG_SQ, frq=frq, return_indices=True):
           # Extract the Calculated R2eff.
           r2eff = r2effs[ei][0][mi][oi][di]
           # Find the defined error setup.
           set_r2eff_err = r2eff_errs[di]
           # Add the defined error to the calculated error.
           r2eff_w_err = r2eff + set_r2eff_err
           string = "%.15f %.15f %.3f %.15f\n"%(point, r2eff_w_err, ds.r2eff_err, r2eff)
           file.write(string)
       # Close file.
       file.close()
       # Read in the R2eff file to put into spin structure.
       relax_disp.r2eff_read_spin(id=exp_id, spin_id=cur_spin_id, file=file_name, dir=ds.resdir, disp_point_col=1, data_col=2, error_col=3)
       # Add to counter.
       i += 1

print("Did following number of iterations: %i"%i)

  1. Now do fitting.
  1. Change pipe.

pipe_name_MODEL = "%s_%s"%(pipe_name, model_analyse) pipe.copy(pipe_from=pipe_name, pipe_to=pipe_name_MODEL, bundle_to = pipe_bundle) pipe.switch(pipe_name=pipe_name_MODEL)

  1. Copy R2eff, but not the original parameters

value.copy(pipe_from=pipe_name_r2eff, pipe_to=pipe_name_MODEL, param='r2eff')

  1. Then select model.

relax_disp.select_model(model=model_analyse)

print("Analysing with MODEL:%s."%(model_analyse))

  1. Do a dx map.
  2. To map the hypersurface of chi2, when altering kex, dw and pA.

if ds.opendx:

   # First switch pipe, since dx.map will go through parameters and end up a "bad" place. :-9
   pipe_name_MODEL_MAP = "%s_%s_map"%(pipe_name, model_analyse)
   pipe.copy(pipe_from=pipe_name_MODEL, pipe_to=pipe_name_MODEL_MAP, bundle_to = pipe_bundle)
   pipe.switch(pipe_name=pipe_name_MODEL_MAP)
   for cur_spin, mol_name, resi, resn, spin_id in spin_loop(full_info=True, return_id=True, skip_desel=True):
       cur_spin_id = spin_id
       file_name = "map%s" % (cur_spin_id .replace('#', '_').replace(':', '_').replace('@', '_'))
       dx.map(params=['dw', 'pA', 'kex'], map_type='Iso3D', spin_id=":1@N", inc=ds.dx_inc, lower=None, upper=None, axis_incs=5, file_prefix=file_name, dir=ds.resdir, point=None, point_file='point', remap=None)
       #vp_exec:  A flag specifying whether to execute the visual program automatically at start-up.
       #dx.execute(file_prefix=file_name, dir=ds.resdir, dx_exe='dx', vp_exec=True)
  1. Switch back to model pipe.

pipe.switch(pipe_name=pipe_name_MODEL)

  1. Remove insignificant

relax_disp.insignificance(level=ds.insignificance)

  1. Perform Grid Search.

if ds.GRID_INC:

   # Set the R20 parameters in the default grid search using the minimum R2eff value.
   # This speeds it up considerably.
   if ds.set_grid_r20_from_min_r2eff:
       relax_disp.set_grid_r20_from_min_r2eff(force=False)
   # Then do grid search.
   grid_search(lower=None, upper=None, inc=ds.GRID_INC, constraints=True, verbosity=ds.verbosity)
  1. If no Grid search, set the default values.

else:

   for param in MODEL_PARAMS[model_analyse]:
       value.set(param=param, index=None)
       # Do a grid search, which will store the chi2 value.
   #grid_search(lower=None, upper=None, inc=10, constraints=True, verbosity=ds.verbosity)


  1. Define function to store grid results.

def save_res(res_spins):

   res_list = []
   for res_name, res_num, spin_name, params in res_spins:
       cur_spin_id = ":%i@%s"%(res_num, spin_name)
       cur_spin = return_spin(cur_spin_id)
       par_dic = {}
       # Now read the parameters.
       for mo_param in cur_spin.params:
           par_dic.update({mo_param : getattr(cur_spin, mo_param) })
       # Append result.
       res_list.append([res_name, res_num, spin_name, par_dic])
   return res_list

ds.grid_results = save_res(cur_spins)

    1. Now do minimisation.

minimise(min_algor='simplex', func_tol=ds.set_func_tol, max_iter=ds.set_max_iter, constraints=True, scaling=True, verbosity=ds.verbosity)

  1. Save results

ds.min_results = save_res(cur_spins)

  1. Now do clustering

if ds.do_cluster:

   # Change pipe.
   pipe_name_MODEL_CLUSTER = "%s_%s_CLUSTER"%(pipe_name, model_create)
   pipe.copy(pipe_from=pipe_name, pipe_to=pipe_name_MODEL_CLUSTER)
   pipe.switch(pipe_name=pipe_name_MODEL_CLUSTER)
   # Copy R2eff, but not the original parameters
   value.copy(pipe_from=pipe_name_r2eff, pipe_to=pipe_name_MODEL_CLUSTER, param='r2eff')
   # Then select model.
   relax_disp.select_model(model=model_create)
   # Then cluster
   relax_disp.cluster('model_cluster', ":1-100")
   # Copy the parameters from before.
   relax_disp.parameter_copy(pipe_from=pipe_name_MODEL, pipe_to=pipe_name_MODEL_CLUSTER)
   # Now minimise.
   minimise(min_algor='simplex', func_tol=ds.set_func_tol, max_iter=ds.set_max_iter, constraints=True, scaling=True, verbosity=ds.verbosity)
   # Save results
   ds.clust_results = save_res(cur_spins)

else:

   ds.clust_results = ds.min_results
  1. Plot curves.

if ds.plot_curves:

   relax_disp.plot_disp_curves(dir=ds.resdir, force=True)
  1. The conversion for ShereKhan at http://sherekhan.bionmr.org/.

if ds.sherekhan_input:

   relax_disp.cluster('sherekhan', ":1-100")
   print(cdp.clustering)
   relax_disp.sherekhan_input(force=True, spin_id=None, dir=ds.resdir)
  1. Compare results.

if ds.print_res:

   print("\n########################")
   print("Generated data with MODEL:%s"%(model_create))
   print("Analysing with MODEL:%s."%(model_analyse))
   print("########################\n")

for i in range(len(cur_spins)):

   res_name, res_num, spin_name, params = cur_spins[i]
   cur_spin_id = ":%i@%s"%(res_num, spin_name)
   cur_spin = return_spin(cur_spin_id)
   grid_params = ds.grid_results[i][3]
   min_params = ds.min_results[i][3]
   clust_params = ds.clust_results[i][3]
   # Now read the parameters.
   if ds.print_res:
       print("For spin: '%s'"%cur_spin_id)
   for mo_param in cur_spin.params:
       # The R2 is a dictionary, depending on spectrometer frequency.
       if isinstance(getattr(cur_spin, mo_param), dict):
           grid_r2 = grid_params[mo_param]
           min_r2 = min_params[mo_param]
           clust_r2 = clust_params[mo_param]
           set_r2 = params[mo_param]
           for key, val in getattr(cur_spin, mo_param).items():
               grid_r2_frq = grid_r2[key]
               min_r2_frq = min_r2[key]
               clust_r2_frq = min_r2[key]
               set_r2_frq = set_r2[key]
               frq = float(key.split(EXP_TYPE_CPMG_SQ+' - ')[-1].split('MHz')[0])
               rel_change = sqrt( (clust_r2_frq - set_r2_frq)**2/(clust_r2_frq)**2 )
               if ds.print_res:
                   print("%s %s %s %s %.1f GRID=%.3f MIN=%.3f CLUST=%.3f SET=%.3f RELC=%.3f"%(cur_spin.model, res_name, cur_spin_id, mo_param, frq, grid_r2_frq, min_r2_frq, clust_r2_frq, set_r2_frq, rel_change) )
               if rel_change > ds.rel_change:
                   if ds.print_res:
                       print("###################################")
                       print("WARNING: %s Have relative change above %.2f, and is %.4f."%(key, ds.rel_change, rel_change))
                       print("###################################\n")
       else:
           grid_val = grid_params[mo_param]
           min_val = min_params[mo_param]
           clust_val = clust_params[mo_param]
           set_val = params[mo_param]
           rel_change = sqrt( (clust_val - set_val)**2/(clust_val)**2 )
           if ds.print_res:
               print("%s %s %s %s GRID=%.3f MIN=%.3f CLUST=%.3f SET=%.3f RELC=%.3f"%(cur_spin.model, res_name, cur_spin_id, mo_param, grid_val, min_val, clust_val, set_val, rel_change) )
           if rel_change > ds.rel_change:
               if ds.print_res:
                   print("###################################")
                   print("WARNING: %s Have relative change above %.2f, and is %.4f."%(mo_param, ds.rel_change, rel_change))
                   print("###################################\n")

</source>

See also

Install dx