Main Page   Namespace List   Class Hierarchy   Alphabetical List   Compound List   File List   Namespace Members   Compound Members   File Members   Related Pages  

TclMeasure.C File Reference

#include <stdlib.h>
#include <tcl.h>
#include <ctype.h>
#include <math.h>
#include "TclCommands.h"
#include "AtomSel.h"
#include "Matrix4.h"
#include "SymbolTable.h"
#include "VMDApp.h"
#include "MoleculeList.h"
#include "utilities.h"
#include "config.h"
#include "Measure.h"
#include "MeasureSymmetry.h"
#include "SpatialSearch.h"
#include "Atom.h"
#include "Molecule.h"
#include "QuickSurf.h"
#include "MDFF.h"
#include "CUDAMDFF.h"
#include "MeasureVolInterior.h"

Go to the source code of this file.

Functions

int tcl_get_weights (Tcl_Interp *interp, VMDApp *app, AtomSel *sel, Tcl_Obj *weight_obj, float *data)
 converts a Tcl string into a usable array of weights for VMD functions. More...

int atomsel_default_weights (AtomSel *sel, float *weights)
 Assign weights of 1 to all atoms in the selection, and zero otherwise. More...

int get_weights_from_tcl_list (Tcl_Interp *interp, VMDApp *app, AtomSel *sel, Tcl_Obj *weights_obj, float *weights)
 Obtain weights from a Tcl list. More...

int get_attribute_index (VMDApp *app, char const *string)
 Get the index of the given keyword in the VMD namespace (avoid having to include SymbolTable.h). More...

int get_weights_from_attribute (VMDApp *app, AtomSel *sel, char const *weights_string, float *weights)
 Obtain weights from the requested attribute. More...

int tcl_get_orders (Tcl_Interp *interp, int selnum, Tcl_Obj *order_obj, int *data)
int vmd_measure_center (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_centerperresidue (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_sumweights (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_avpos (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_dipole (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_dihed (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_angle (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_bond (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_rmsfperresidue (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_rmsf (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_rgyr (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_minmax (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_rmsdperresidue (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_rmsd (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_rmsd_qcp (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_rmsdmat_qcp (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_rmsdmat_qcp_ooc (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_fit (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_inverse (int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_contacts (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_gofr (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_rdf (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_cluster (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
 do cluster analysis for one selection. More...

int vmd_measure_clustsize (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
 compute cluster size distribution for a given selection of atoms. More...

int vmd_measure_hbonds (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_sasa (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_sasalist (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_energy (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_surface (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_pbc2onc_transform (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_pbc_neighbors (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_inertia (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_symmetry (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_trans_overlap (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int vmd_measure_volinterior (VMDApp *app, int argc, Tcl_Obj *const objv[], Tcl_Interp *interp)
int obj_measure (ClientData cd, Tcl_Interp *interp, int argc, Tcl_Obj *const objv[])


Function Documentation

int atomsel_default_weights AtomSel   sel,
float *    weights
 

Assign weights of 1 to all atoms in the selection, and zero otherwise.

Definition at line 133 of file TclMeasure.C.

References AtomSel::firstsel, AtomSel::lastsel, AtomSel::num_atoms, and AtomSel::on.

Referenced by VolMapCreateInterp::compute_frame, VolMapCreateDensity::compute_frame, and vmd_volmap_new_fromtype.

int get_attribute_index VMDApp   app,
char const *    string
 

Get the index of the given keyword in the VMD namespace (avoid having to include SymbolTable.h).

Definition at line 174 of file TclMeasure.C.

References VMDApp::atomSelParser, SymbolTable::find_attribute, and string.

Referenced by vmd_volmap_new_fromtype.

int get_weights_from_attribute VMDApp   app,
AtomSel   sel,
char const *    weights_string,
float *    weights
 

Obtain weights from the requested attribute.

Definition at line 180 of file TclMeasure.C.

References VMDApp::atomSelParser, NameList< SymbolTableElement * >::data, SymbolTable::fctns, SymbolTable::find_attribute, AtomSel::firstsel, SymbolTableElement::IS_FLOAT, SymbolTableElement::keyword_double, AtomSel::lastsel, MEASURE_ERR_BADWEIGHTPARM, MoleculeList::mol_from_id, VMDApp::moleculeList, AtomSel::molid, NULL, AtomSel::num_atoms, AtomSel::on, SymbolTableElement::returns_a, and AtomSel::which_frame.

Referenced by VolMapCreateInterp::compute_frame, VolMapCreateDensity::compute_frame, and vmd_volmap_new_fromtype.

int get_weights_from_tcl_list Tcl_Interp *    interp,
VMDApp   app,
AtomSel   sel,
Tcl_Obj *    weights_obj,
float *    weights
 

Obtain weights from a Tcl list.

Definition at line 149 of file TclMeasure.C.

References MEASURE_ERR_BADWEIGHTNUM, MEASURE_ERR_BADWEIGHTPARM, NULL, and AtomSel::num_atoms.

Referenced by vmd_volmap_new_fromtype.

int obj_measure ClientData    cd,
Tcl_Interp *    interp,
int    argc,
Tcl_Obj *const    objv[]
 

Definition at line 4514 of file TclMeasure.C.

References NULL, strupncmp, vmd_measure_angle, vmd_measure_avpos, vmd_measure_bond, vmd_measure_center, vmd_measure_centerperresidue, vmd_measure_cluster, vmd_measure_clustsize, vmd_measure_contacts, vmd_measure_dihed, vmd_measure_dipole, vmd_measure_energy, vmd_measure_fit, vmd_measure_gofr, vmd_measure_hbonds, vmd_measure_inertia, vmd_measure_inverse, vmd_measure_minmax, vmd_measure_pbc2onc_transform, vmd_measure_pbc_neighbors, vmd_measure_rdf, vmd_measure_rgyr, vmd_measure_rmsd, vmd_measure_rmsd_qcp, vmd_measure_rmsdmat_qcp, vmd_measure_rmsdmat_qcp_ooc, vmd_measure_rmsdperresidue, vmd_measure_rmsf, vmd_measure_rmsfperresidue, vmd_measure_sasa, vmd_measure_sasalist, vmd_measure_sumweights, vmd_measure_surface, vmd_measure_symmetry, vmd_measure_trans_overlap, and vmd_measure_volinterior.

int tcl_get_orders Tcl_Interp *    interp,
int    selnum,
Tcl_Obj *    order_obj,
int *    data
 

Definition at line 213 of file TclMeasure.C.

References data, MEASURE_ERR_BADORDERINDEX, MEASURE_ERR_NONNUMBERPARM, MEASURE_ERR_NOSEL, and MEASURE_NOERR.

Referenced by vmd_measure_fit.

int tcl_get_weights Tcl_Interp *    interp,
VMDApp   app,
AtomSel   sel,
Tcl_Obj *    weight_obj,
float *    data
 

converts a Tcl string into a usable array of weights for VMD functions.

Definition at line 57 of file TclMeasure.C.

References VMDApp::atomSelParser, NameList< SymbolTableElement * >::data, data, SymbolTable::fctns, SymbolTable::find_attribute, AtomSel::firstsel, SymbolTableElement::IS_FLOAT, SymbolTableElement::keyword_double, AtomSel::lastsel, MEASURE_ERR_BADWEIGHTNUM, MEASURE_ERR_BADWEIGHTPARM, MEASURE_ERR_NOMOLECULE, MEASURE_ERR_NONNUMBERPARM, MEASURE_ERR_NOSEL, MEASURE_NOERR, MoleculeList::mol_from_id, VMDApp::molecule_valid_id, VMDApp::moleculeList, AtomSel::molid, NULL, AtomSel::num_atoms, AtomSel::on, SymbolTableElement::returns_a, AtomSel::selected, and AtomSel::which_frame.

Referenced by fpbc_recenter, fpbc_wrap, vmd_measure_center, vmd_measure_centerperresidue, vmd_measure_fit, vmd_measure_rgyr, vmd_measure_rmsd, vmd_measure_rmsd_qcp, vmd_measure_rmsdmat_qcp, vmd_measure_rmsdmat_qcp_ooc, vmd_measure_rmsdperresidue, and vmd_measure_sumweights.

int vmd_measure_angle VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 666 of file TclMeasure.C.

References data, MEASURE_ANGLE, measure_error, measure_geom, VMDApp::molecule_top, VMDApp::moleculeList, NULL, ResizeArray::num, strupcmp, and strupncmp.

Referenced by obj_measure.

int vmd_measure_avpos VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 424 of file TclMeasure.C.

References measure_avpos, measure_error, VMDApp::moleculeList, NULL, AtomSel::selected, strupncmp, and tcl_commands_get_sel.

Referenced by obj_measure.

int vmd_measure_bond VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 786 of file TclMeasure.C.

References data, MEASURE_BOND, measure_error, measure_geom, VMDApp::molecule_top, VMDApp::moleculeList, NULL, ResizeArray::num, strupcmp, and strupncmp.

Referenced by obj_measure.

int vmd_measure_center VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 258 of file TclMeasure.C.

References AtomSel::coordinates, measure_center, measure_error, VMDApp::moleculeList, NULL, AtomSel::selected, tcl_commands_get_sel, and tcl_get_weights.

Referenced by obj_measure.

int vmd_measure_centerperresidue VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 309 of file TclMeasure.C.

References AtomSel::coordinates, measure_center_perresidue, measure_error, VMDApp::moleculeList, NULL, AtomSel::selected, tcl_commands_get_sel, and tcl_get_weights.

Referenced by obj_measure.

int vmd_measure_cluster VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

do cluster analysis for one selection.

Definition at line 1998 of file TclMeasure.C.

References VMDApp::atomSelParser, NameList< SymbolTableElement * >::data, SymbolTable::fctns, SymbolTable::find_attribute, SymbolTableElement::IS_FLOAT, SymbolTableElement::keyword_double, measure_cluster, MEASURE_DIST_FITRMSD, MEASURE_DIST_RGYRD, MEASURE_DIST_RMSD, MEASURE_ERR_BADWEIGHTPARM, MEASURE_ERR_NOMOLECULE, MEASURE_NOERR, MoleculeList::mol_from_id, VMDApp::molecule_valid_id, VMDApp::moleculeList, AtomSel::molid, NULL, AtomSel::num_atoms, SymbolTableElement::returns_a, tcl_commands_get_sel, and AtomSel::which_frame.

Referenced by obj_measure.

int vmd_measure_clustsize VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

compute cluster size distribution for a given selection of atoms.

Definition at line 2174 of file TclMeasure.C.

References VMDApp::atomSelParser, NameList< SymbolTableElement * >::data, SymbolTable::fctns, SymbolTable::find_attribute, AtomSel::firstsel, SymbolTableElement::IS_FLOAT, SymbolTableElement::IS_INT, AtomSel::lastsel, measure_clustsize, MEASURE_ERR_NOMOLECULE, MEASURE_NOERR, MoleculeList::mol_from_id, VMDApp::molecule_valid_id, VMDApp::moleculeList, AtomSel::molid, NULL, AtomSel::num_atoms, AtomSel::on, SymbolTableElement::returns_a, AtomSel::selected, SymbolTableElement::set_keyword_double, SymbolTableElement::set_keyword_int, tcl_commands_get_sel, and AtomSel::which_frame.

Referenced by obj_measure.

int vmd_measure_contacts VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 1670 of file TclMeasure.C.

References BaseMolecule::atom, MolAtom::bonded, AtomSel::coordinates, GridSearchPair::ind1, GridSearchPair::ind2, MoleculeList::mol_from_id, VMDApp::moleculeList, AtomSel::molid, GridSearchPair::next, NULL, AtomSel::num_atoms, AtomSel::on, result, tcl_commands_get_sel, and vmd_gridsearch3.

Referenced by obj_measure.

int vmd_measure_dihed VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 543 of file TclMeasure.C.

References data, MEASURE_DIHED, measure_error, measure_geom, VMDApp::molecule_top, VMDApp::moleculeList, NULL, ResizeArray::num, strupcmp, and strupncmp.

Referenced by obj_measure.

int vmd_measure_dipole VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 490 of file TclMeasure.C.

References measure_dipole, measure_error, VMDApp::moleculeList, NULL, and tcl_commands_get_sel.

Referenced by obj_measure.

int vmd_measure_energy VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 2632 of file TclMeasure.C.

References data, MEASURE_ANGLE, MEASURE_BOND, MEASURE_DIHED, MEASURE_ELECT, measure_energy, measure_error, MEASURE_IMPRP, MEASURE_VDW, VMDApp::molecule_top, VMDApp::moleculeList, NULL, ResizeArray::num, strupcmp, and strupncmp.

Referenced by obj_measure.

int vmd_measure_fit VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 1545 of file TclMeasure.C.

References AtomSel::coordinates, Matrix4::mat, MEASURE_ERR_NOMOLECULE, measure_error, measure_fit, VMDApp::moleculeList, NULL, num, AtomSel::selected, tcl_append_matrix, tcl_commands_get_sel, tcl_get_orders, and tcl_get_weights.

Referenced by obj_measure.

int vmd_measure_gofr VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 1729 of file TclMeasure.C.

References measure_gofr, MEASURE_NOERR, VMDApp::moleculeList, NULL, and tcl_commands_get_sel.

Referenced by obj_measure.

int vmd_measure_hbonds VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 2379 of file TclMeasure.C.

References AtomSel::coordinates, measure_hbonds, MoleculeList::mol_from_id, VMDApp::moleculeList, AtomSel::molid, NULL, AtomSel::num_atoms, result, and tcl_commands_get_sel.

Referenced by obj_measure.

int vmd_measure_inertia VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 3201 of file TclMeasure.C.

References MEASURE_ERR_NOMOLECULE, measure_error, measure_inertia, VMDApp::molecule_valid_id, VMDApp::moleculeList, AtomSel::molid, NULL, strupncmp, and tcl_commands_get_sel.

Referenced by obj_measure.

int vmd_measure_inverse int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 1650 of file TclMeasure.C.

References Matrix4::inverse, Matrix4::mat, NULL, tcl_append_matrix, and tcl_get_matrix.

Referenced by obj_measure.

int vmd_measure_minmax VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 1078 of file TclMeasure.C.

References AtomSel::coordinates, NameList< float * >::data, BaseMolecule::extraflt, measure_error, measure_minmax, MoleculeList::mol_from_id, VMDApp::moleculeList, AtomSel::molid, NULL, AtomSel::num_atoms, AtomSel::on, and tcl_commands_get_sel.

Referenced by obj_measure.

int vmd_measure_pbc2onc_transform VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 2900 of file TclMeasure.C.

References Matrix4::mat, measure_error, measure_pbc2onc, VMDApp::molecule_top, VMDApp::moleculeList, NULL, strupcmp, and strupncmp.

Referenced by obj_measure.

int vmd_measure_pbc_neighbors VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 3010 of file TclMeasure.C.

References compute_pbcminmax, Matrix4::mat, MEASURE_ERR_NOMOLECULE, measure_error, measure_pbc_neighbors, VMDApp::molecule_top, VMDApp::molecule_valid_id, VMDApp::moleculeList, AtomSel::molid, NULL, ResizeArray::num, AtomSel::selected, strupcmp, strupncmp, tcl_commands_get_sel, and tcl_get_matrix.

Referenced by obj_measure.

int vmd_measure_rdf VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 1864 of file TclMeasure.C.

References MEASURE_NOERR, measure_rdf, VMDApp::moleculeList, NULL, and tcl_commands_get_sel.

Referenced by obj_measure.

int vmd_measure_rgyr VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 1030 of file TclMeasure.C.

References measure_error, measure_rgyr, VMDApp::moleculeList, NULL, AtomSel::selected, tcl_commands_get_sel, and tcl_get_weights.

Referenced by obj_measure.

int vmd_measure_rmsd VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 1208 of file TclMeasure.C.

References AtomSel::coordinates, measure_error, measure_rmsd, VMDApp::moleculeList, NULL, AtomSel::selected, tcl_commands_get_sel, and tcl_get_weights.

Referenced by obj_measure.

int vmd_measure_rmsd_qcp VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 1269 of file TclMeasure.C.

References AtomSel::coordinates, measure_error, measure_rmsd_qcp, VMDApp::moleculeList, NULL, AtomSel::selected, tcl_commands_get_sel, and tcl_get_weights.

Referenced by obj_measure.

int vmd_measure_rmsdmat_qcp VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 1329 of file TclMeasure.C.

References measure_error, measure_rmsdmat_qcp, VMDApp::molecule_numframes, VMDApp::moleculeList, AtomSel::molid, NULL, AtomSel::selected, strupncmp, tcl_commands_get_sel, and tcl_get_weights.

Referenced by obj_measure.

int vmd_measure_rmsdmat_qcp_ooc VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 1426 of file TclMeasure.C.

References measure_error, measure_rmsdmat_qcp_ooc, VMDApp::moleculeList, NULL, AtomSel::selected, strupncmp, tcl_commands_get_sel, and tcl_get_weights.

Referenced by obj_measure.

int vmd_measure_rmsdperresidue VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 1132 of file TclMeasure.C.

References measure_error, measure_rmsd_perresidue, VMDApp::moleculeList, NULL, AtomSel::selected, tcl_commands_get_sel, and tcl_get_weights.

Referenced by obj_measure.

int vmd_measure_rmsf VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 970 of file TclMeasure.C.

References measure_error, measure_rmsf, VMDApp::moleculeList, NULL, AtomSel::selected, strupncmp, and tcl_commands_get_sel.

Referenced by obj_measure.

int vmd_measure_rmsfperresidue VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 908 of file TclMeasure.C.

References measure_error, measure_rmsf_perresidue, VMDApp::moleculeList, NULL, AtomSel::selected, strupncmp, and tcl_commands_get_sel.

Referenced by obj_measure.

int vmd_measure_sasa VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 2474 of file TclMeasure.C.

References AtomSel::coordinates, NameList< float * >::data, BaseMolecule::extraflt, measure_error, measure_sasa, MoleculeList::mol_from_id, VMDApp::moleculeList, AtomSel::molid, NULL, ResizeArray::num, and tcl_commands_get_sel.

Referenced by obj_measure.

int vmd_measure_sasalist VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 2554 of file TclMeasure.C.

References measure_error, measure_sasalist, VMDApp::moleculeList, NULL, and tcl_commands_get_sel.

Referenced by obj_measure.

int vmd_measure_sumweights VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 376 of file TclMeasure.C.

References measure_error, measure_sumweights, NULL, AtomSel::selected, tcl_commands_get_sel, and tcl_get_weights.

Referenced by obj_measure.

int vmd_measure_surface VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 2846 of file TclMeasure.C.

References AtomSel::coordinates, measure_error, measure_surface, VMDApp::moleculeList, NULL, and tcl_commands_get_sel.

Referenced by obj_measure.

int vmd_measure_symmetry VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 3384 of file TclMeasure.C.

References Symmetry::axis, Symmetry::center_of_mass, Symmetry::get_additional_elements, Symmetry::get_axisorder, Symmetry::get_axistype, Symmetry::get_element_summary, Symmetry::get_inertia_axes, Symmetry::get_inertia_eigenvals, Symmetry::get_inertia_unique, Symmetry::get_missing_elements, Symmetry::get_orientation, Symmetry::get_planetype, Symmetry::get_pointgroup, Symmetry::get_rmsd, Symmetry::get_rotreflectorder, Symmetry::get_rotrefltype, Symmetry::get_unique_atom, Symmetry::guess, Symmetry::has_inversion, Symmetry::idealpos, Symmetry::impose, Symmetry::is_spherical_top, Matrix4::mat, MEASURE_ERR_NOMOLECULE, measure_error, VMDApp::molecule_valid_id, VMDApp::moleculeList, AtomSel::molid, NULL, AtomSel::num_atoms, Symmetry::numaxes, Symmetry::numplanes, Symmetry::numrotreflect, AtomSel::on, PERPENDICULAR_AXIS, Symmetry::plane, PRINCIPAL_AXIS, Symmetry::rotreflect, Symmetry::score_axis, Symmetry::score_inversion, Symmetry::score_plane, Symmetry::score_rotary_reflection, AtomSel::selected, Symmetry::set_checkbonds, Symmetry::set_overlaptol, strupcmp, strupncmp, tcl_commands_get_sel, tcl_get_vector, and vec_copy.

Referenced by obj_measure.

int vmd_measure_trans_overlap VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
[static]
 

Definition at line 3896 of file TclMeasure.C.

References Matrix4::mat, MEASURE_ERR_NOMOLECULE, measure_error, measure_trans_overlap, VMDApp::molecule_valid_id, VMDApp::moleculeList, AtomSel::molid, NOSKIP_IDENTICAL, NULL, strupncmp, tcl_commands_get_sel, and tcl_get_matrix.

Referenced by obj_measure.

int vmd_measure_volinterior VMDApp   app,
int    argc,
Tcl_Obj *const    objv[],
Tcl_Interp *    interp
 

Definition at line 3954 of file TclMeasure.C.

References QuickSurf::calc_density_map, VolumetricData::compute_volume_gradient, AtomSel::coordinates, countIsoGrids, CreateEmptyGrid, CreateProbGrid, VolumetricData::data, EXTERIORVOXEL, BaseMolecule::get_volume_data, INTERIORVOXEL, isfloat, isovalue, markIsoGrid, BaseMolecule::modify_volume_data, MoleculeList::mol_from_id, VMDApp::molecule_add_volumetric, VMDApp::molecule_valid_id, VMDApp::moleculeList, AtomSel::molid, VolumetricData::name, normalize_pmap, Nout, NULL, VolumetricData::origin, pmap, poisson_sample_on_sphere, print_xyz, process_pmap, BaseMolecule::radius, RaycastGrid, rayDir, AtomSel::selected, tcl_commands_get_sel, vmd_cuda_calc_density, VMD_PI, VMD_RAND_MAX, vmd_random, vol_probability, volin_threaded, volin_threaded_prob, volmapA, VolumetricData::xaxis, VolumetricData::xsize, VolumetricData::yaxis, VolumetricData::ysize, z, VolumetricData::zaxis, and VolumetricData::zsize.

Referenced by obj_measure.


Generated on Wed Apr 24 02:44:01 2024 for VMD (current) by doxygen1.2.14 written by Dimitri van Heesch, © 1997-2002