EMAN2
|
PointArray defines a double array of points with values in a 3D space. More...
#include <pointarray.h>
Public Types | |
enum | Density2PointsArrayAlgorithm { PEAKS_SUB , PEAKS_DIV , KMEANS } |
Public Member Functions | |
PointArray () | |
PointArray (int nn) | |
~PointArray () | |
void | zero () |
PointArray * | copy () |
PointArray & | operator= (PointArray &pa) |
size_t | get_number_points () const |
void | set_number_points (size_t nn) |
bool | read_from_pdb (const char *file, const vector< int > &lines=vector< int >()) |
void | save_to_pdb (const char *file) |
FloatPoint | get_center () |
void | center_to_zero () |
Region | get_bounding_box () |
double * | get_points_array () |
Vec3f | get_vector_at (int i) |
double | get_value_at (int i) |
void | set_vector_at (int i, Vec3f vec, double value) |
void | set_vector_at (int i, vector< double >) |
void | set_points_array (double *p) |
vector< float > | get_points () |
Returns all x,y,z triplets packed into a vector<float> More... | |
EMData * | distmx (int sortrows=0) |
Calculates a (symmetrized) distance matrix for the current PointArray. More... | |
vector< int > | match_points (PointArray *to, float max_miss=-1.0) |
Will try to establish a 1-1 correspondence between points in two different PointArray objects (this and to). More... | |
Transform * | align_2d (PointArray *to, float max_dist) |
Aligns one PointArray to another in 2 dimensions. More... | |
void | mask (double rmax, double rmin=0.0) |
void | mask_asymmetric_unit (const string &sym) |
void | transform (const Transform &transform) |
void | right_transform (const Transform &transform) |
Does Transform*v as opposed to v*Transform (as in the transform function) More... | |
void | set_from (vector< float >) |
void | set_from (PointArray *source, const string &sym="", Transform *transform=0) |
void | set_from (double *source, int num, const string &sym="", Transform *transform=0) |
void | set_from_density_map (EMData *map, int num, float thresh, float apix, Density2PointsArrayAlgorithm mode=PEAKS_DIV) |
void | sort_by_axis (int axis=1) |
EMData * | pdb2mrc_by_nfft (int map_size, float apix, float res) |
EMData * | pdb2mrc_by_summation (int map_size, float apix, float res, int addpdbbfactor) |
EMData * | projection_by_nfft (int image_size, float apix, float res=0) |
EMData * | projection_by_summation (int image_size, float apix, float res) |
void | replace_by_summation (EMData *image, int i, Vec3f vec, float amp, float apix, float res) |
void | opt_from_proj (const vector< EMData * > &proj, float pixres) |
Optimizes a pointarray based on a set of projection images (EMData objects) This is effectively a 3D reconstruction algorithm. More... | |
double | sim_pointpotential (double dist, double ang, double dihed) |
Computes a potential value for a single point from a set of angles/distances using current energy settings. More... | |
double | sim_potential () |
Computes overall potential for the configuration. More... | |
double | sim_potentiald (int ind) |
Compute a single point potential value. More... | |
double | sim_potentialdxyz (int i, double dx, double dy, double dz) |
Compute a potential value for a perturbed point, including +-2 nearest neighbors which will also be impacted. More... | |
void | sim_updategeom () |
Updates the dist, ang, dihed parameters. More... | |
Vec3f | sim_descent (int i) |
returns a vector pointing downhill for a single point More... | |
void | sim_minstep (double maxshift) |
Takes a step to minimize the potential. More... | |
void | sim_minstep_seq (double meanshift) |
Takes a step to minimize the potential. More... | |
void | sim_rescale () |
rescale the entire set so the mean bond length matches dist0 More... | |
void | sim_printstat () |
prints some statistics to the screen More... | |
void | sim_set_pot_parms (double pdist0, double pdistc, double pangc, double pdihed0, double pdihedc, double pmapc, EMData *pmap, double pmindistc, double pdistpenc) |
Sets the parameters for the energy function. More... | |
void | sim_add_point_double () |
Add more points during the simulation. More... | |
void | sim_add_point_one () |
double | calc_total_length () |
Calculate total length. More... | |
vector< double > | fit_helix (EMData *pmap, int minlength, float mindensity, vector< int > edge, int twodir, size_t minl) |
Fit helix from peptide chains. More... | |
vector< float > | do_pca (int start, int end) |
Do principal component analysis to (a subset of) the point array, used in helix fitting in pathwalker. More... | |
vector< float > | do_filter (vector< float > pts, float *ft, int num) |
Filter the point array to smooth the line, used in helix fitting in pathwalker. More... | |
vector< double > | construct_helix (int start, int end, float phs, float &score, int &dir) |
Construct an ideal helix between the start and end points given phase. More... | |
void | reverse_chain () |
Reverse the pointarray chain. More... | |
void | merge_to (PointArray &pa, float thr) |
Merge to another point array. More... | |
float | calc_helicity (vector< double > pts) |
Calculate the helicity of some points. More... | |
void | save_pdb_with_helix (const char *file, vector< float > hlxid) |
Save the point array to pdb file, including helices information. More... | |
void | delete_point (int id) |
Delete one point in the array. More... | |
void | remove_helix_from_map (EMData *m, vector< float > hlxid) |
Remove the corresponding density of the helix point from a density map. More... | |
bool | read_ca_from_pdb (const char *file) |
Read only C-alpha atoms from a pdb file. More... | |
Transform | calc_transform (PointArray *p) |
Calculate the transform to another identical pointarray. More... | |
Private Attributes | |
double * | points |
size_t | n |
double * | bfactor |
double * | adist |
double * | aang |
double * | adihed |
double | dist0 |
Used for simplistic loop dynamics simulation Assumes all points are connected sequentially in a closed loop, potential includes distance, angle and dihedral terms, with optional density based terms. More... | |
double | distc |
double | angc |
double | dihed0 |
double | dihedc |
double | mapc |
double | apix |
double | mindistc |
double | distpenc |
bool | map2d |
EMData * | map |
EMData * | gradx |
EMData * | grady |
EMData * | gradz |
vector< Vec3f > | oldshifts |
int | centx |
int | centy |
int | centz |
PointArray defines a double array of points with values in a 3D space.
Definition at line 51 of file pointarray.h.
PointArray::PointArray | ( | ) |
|
explicit |
PointArray::~PointArray | ( | ) |
Transform * PointArray::align_2d | ( | PointArray * | to, |
float | max_dist | ||
) |
Aligns one PointArray to another in 2 dimensions.
to | Another PointArray to align to |
max_dist |
Definition at line 281 of file pointarray.cpp.
References EMAN::Util::calc_bilinear_least_square(), get_vector_at(), match_points(), EMAN::Transform::set(), and EMAN::Transform::set_pre_trans().
float PointArray::calc_helicity | ( | vector< double > | pts | ) |
Calculate the helicity of some points.
Used for correct the hand of the helices
Definition at line 2035 of file pointarray.cpp.
References EMAN::Vec3< Type >::dot(), and v0.
Referenced by construct_helix().
double PointArray::calc_total_length | ( | ) |
Transform PointArray::calc_transform | ( | PointArray * | p | ) |
Calculate the transform to another identical pointarray.
(The rotation part is copied from a set_rotation in transform.cpp)
Definition at line 2101 of file pointarray.cpp.
References EMAN::Vec3< Type >::cross(), EMAN::Vec3< Type >::dot(), get_center(), EMAN::Util::get_irand(), get_vector_at(), EMAN::Vec3< Type >::length(), n, EMAN::Vec3< Type >::normalize(), EMAN::Transform::set_rotation(), and EMAN::Transform::set_trans().
void PointArray::center_to_zero | ( | ) |
Definition at line 472 of file pointarray.cpp.
References get_center(), get_number_points(), and points.
vector< double > PointArray::construct_helix | ( | int | start, |
int | end, | ||
float | phs, | ||
float & | score, | ||
int & | dir | ||
) |
Construct an ideal helix between the start and end points given phase.
Definition at line 1877 of file pointarray.cpp.
References calc_helicity(), do_pca(), eigval, eigvec, EMAN::Vec3< Type >::length(), map, points, and EMAN::Util::round().
Referenced by fit_helix().
PointArray * PointArray::copy | ( | ) |
Definition at line 149 of file pointarray.cpp.
References get_number_points(), get_points_array(), PointArray(), and set_number_points().
Referenced by mask(), and mask_asymmetric_unit().
void PointArray::delete_point | ( | int | id | ) |
Delete one point in the array.
Definition at line 2190 of file pointarray.cpp.
References n, points, and set_number_points().
EMData * PointArray::distmx | ( | int | sortrows = 0 | ) |
Calculates a (symmetrized) distance matrix for the current PointArray.
sortrows | if set, will sort the values in each row. The return will no longer be a true similarity matrix. |
Definition at line 192 of file pointarray.cpp.
References cmp_float(), get_vector_at(), EMAN::length(), and n.
Referenced by match_points().
vector< float > PointArray::do_filter | ( | vector< float > | pts, |
float * | ft, | ||
int | num | ||
) |
Filter the point array to smooth the line, used in helix fitting in pathwalker.
Definition at line 1546 of file pointarray.cpp.
Referenced by fit_helix().
vector< float > PointArray::do_pca | ( | int | start = 0 , |
int | end = -1 |
||
) |
Do principal component analysis to (a subset of) the point array, used in helix fitting in pathwalker.
Definition at line 1510 of file pointarray.cpp.
References covmat, eigval, eigvec, n, and points.
Referenced by construct_helix(), and fit_helix().
vector< double > PointArray::fit_helix | ( | EMData * | pmap, |
int | minlength = 13 , |
||
float | mindensity = 4 , |
||
vector< int > | edge = vector<int>() , |
||
int | twodir = 0 , |
||
size_t | minl = 9 |
||
) |
Fit helix from peptide chains.
Definition at line 1560 of file pointarray.cpp.
References construct_helix(), do_filter(), do_pca(), eigvec, map, n, points, reverse_chain(), set_number_points(), and sqrt().
Region PointArray::get_bounding_box | ( | ) |
Definition at line 482 of file pointarray.cpp.
References get_number_points(), and points.
FloatPoint PointArray::get_center | ( | ) |
Definition at line 453 of file pointarray.cpp.
References get_number_points(), and points.
Referenced by calc_transform(), and center_to_zero().
size_t PointArray::get_number_points | ( | ) | const |
Definition at line 168 of file pointarray.cpp.
References n.
Referenced by center_to_zero(), copy(), get_bounding_box(), get_center(), mask(), mask_asymmetric_unit(), operator=(), opt_from_proj(), pdb2mrc_by_nfft(), pdb2mrc_by_summation(), projection_by_nfft(), projection_by_summation(), read_ca_from_pdb(), read_from_pdb(), save_pdb_with_helix(), save_to_pdb(), set_from(), and set_from_density_map().
vector< float > PointArray::get_points | ( | ) |
Returns all x,y,z triplets packed into a vector<float>
Definition at line 594 of file pointarray.cpp.
double * PointArray::get_points_array | ( | ) |
Definition at line 182 of file pointarray.cpp.
References points.
Referenced by copy(), mask(), mask_asymmetric_unit(), operator=(), set_from(), and set_from_density_map().
double PointArray::get_value_at | ( | int | i | ) |
Definition at line 2932 of file pointarray.cpp.
References points.
Vec3f PointArray::get_vector_at | ( | int | i | ) |
Definition at line 2927 of file pointarray.cpp.
References points.
Referenced by align_2d(), calc_transform(), and distmx().
void PointArray::mask | ( | double | rmax, |
double | rmin = 0.0 |
||
) |
Definition at line 507 of file pointarray.cpp.
References copy(), get_number_points(), get_points_array(), points, set_number_points(), x, and y.
void PointArray::mask_asymmetric_unit | ( | const string & | sym | ) |
Definition at line 534 of file pointarray.cpp.
References copy(), get_number_points(), get_points_array(), LOGERR, points, set_number_points(), sqrt(), x, and y.
vector< int > PointArray::match_points | ( | PointArray * | to, |
float | max_miss = -1.0 |
||
) |
Will try to establish a 1-1 correspondence between points in two different PointArray objects (this and to).
Returns a vector<int> where the index is addresses the points in 'this' and the value addresses points in 'to'. A value of -1 means there was no match for that point.
Definition at line 217 of file pointarray.cpp.
Referenced by align_2d().
void PointArray::merge_to | ( | PointArray & | pa, |
float | thr = 3.5 |
||
) |
Merge to another point array.
Combine close points
Definition at line 2001 of file pointarray.cpp.
References EMAN::Vec3< Type >::length(), n, points, and set_number_points().
PointArray & PointArray::operator= | ( | PointArray & | pa | ) |
Definition at line 159 of file pointarray.cpp.
References get_number_points(), get_points_array(), and set_number_points().
void PointArray::opt_from_proj | ( | const vector< EMData * > & | proj, |
float | pixres | ||
) |
Optimizes a pointarray based on a set of projection images (EMData objects) This is effectively a 3D reconstruction algorithm.
proj | A vector of EMData objects containing projections with orientations |
pixres | Size of each Gaussian in pixels |
Definition at line 2904 of file pointarray.cpp.
References get_number_points(), and LOGWARN.
EMData * PointArray::pdb2mrc_by_nfft | ( | int | map_size, |
float | apix, | ||
float | res | ||
) |
Definition at line 2534 of file pointarray.cpp.
References apix, get_number_points(), LOGWARN, map, and points.
EMData * PointArray::pdb2mrc_by_summation | ( | int | map_size, |
float | apix, | ||
float | res, | ||
int | addpdbbfactor | ||
) |
Definition at line 2276 of file pointarray.cpp.
References apix, bfactor, get_number_points(), log(), map, points, sqrt(), and x.
EMData * PointArray::projection_by_nfft | ( | int | image_size, |
float | apix, | ||
float | res = 0 |
||
) |
Definition at line 2704 of file pointarray.cpp.
References apix, get_number_points(), LOGWARN, n, and points.
EMData * PointArray::projection_by_summation | ( | int | image_size, |
float | apix, | ||
float | res | ||
) |
Definition at line 2385 of file pointarray.cpp.
References apix, get_number_points(), log(), points, sqrt(), and x.
bool PointArray::read_ca_from_pdb | ( | const char * | file | ) |
Read only C-alpha atoms from a pdb file.
Definition at line 2197 of file pointarray.cpp.
References bfactor, get_number_points(), points, set_number_points(), x, and y.
bool PointArray::read_from_pdb | ( | const char * | file, |
const vector< int > & | lines = vector<int>() |
||
) |
Definition at line 329 of file pointarray.cpp.
References bfactor, get_number_points(), points, set_number_points(), x, and y.
Referenced by EMAN::PDBReader::makePointArray().
void PointArray::remove_helix_from_map | ( | EMData * | m, |
vector< float > | hlxid | ||
) |
Remove the corresponding density of the helix point from a density map.
Definition at line 2071 of file pointarray.cpp.
References EMAN::cross(), EMAN::dot(), EMAN::Vec3< Type >::length(), EMAN::length(), x, and y.
void PointArray::replace_by_summation | ( | EMData * | image, |
int | i, | ||
Vec3f | vec, | ||
float | amp, | ||
float | apix, | ||
float | res | ||
) |
Definition at line 2456 of file pointarray.cpp.
void PointArray::reverse_chain | ( | ) |
Reverse the pointarray chain.
Definition at line 2175 of file pointarray.cpp.
Referenced by fit_helix().
void PointArray::right_transform | ( | const Transform & | transform | ) |
Does Transform*v as opposed to v*Transform (as in the transform function)
transform | an EMAN2 Transform object |
Definition at line 617 of file pointarray.cpp.
References n, points, and transform().
void PointArray::save_pdb_with_helix | ( | const char * | file, |
vector< float > | hlxid | ||
) |
Save the point array to pdb file, including helices information.
Definition at line 2053 of file pointarray.cpp.
References get_number_points(), and points.
void PointArray::save_to_pdb | ( | const char * | file | ) |
void PointArray::set_from | ( | double * | source, |
int | num, | ||
const string & | sym = "" , |
||
Transform * | transform = 0 |
||
) |
Definition at line 632 of file pointarray.cpp.
References EMAN::Transform::get_nsym(), get_number_points(), get_points_array(), EMAN::Transform::get_sym(), and set_number_points().
void PointArray::set_from | ( | PointArray * | source, |
const string & | sym = "" , |
||
Transform * | transform = 0 |
||
) |
Definition at line 627 of file pointarray.cpp.
References get_number_points(), get_points_array(), set_from(), and transform().
void PointArray::set_from | ( | vector< float > | pts | ) |
Definition at line 658 of file pointarray.cpp.
References points, and set_number_points().
Referenced by set_from().
void PointArray::set_from_density_map | ( | EMData * | map, |
int | num, | ||
float | thresh, | ||
float | apix, | ||
Density2PointsArrayAlgorithm | mode = PEAKS_DIV |
||
) |
Definition at line 663 of file pointarray.cpp.
References apix, EMAN::Util::get_frand(), get_number_points(), get_points_array(), KMEANS, log(), LOGERR, map, PEAKS_DIV, PEAKS_SUB, points, set_number_points(), set_points_array(), sort_by_axis(), sqrt(), x, y, and zero().
void PointArray::set_number_points | ( | size_t | nn | ) |
Definition at line 173 of file pointarray.cpp.
References bfactor, n, and points.
Referenced by copy(), delete_point(), fit_helix(), mask(), mask_asymmetric_unit(), merge_to(), operator=(), read_ca_from_pdb(), read_from_pdb(), set_from(), set_from_density_map(), and sim_add_point_double().
void PointArray::set_points_array | ( | double * | p | ) |
Definition at line 187 of file pointarray.cpp.
References points.
Referenced by set_from_density_map(), sim_add_point_double(), and sim_add_point_one().
void PointArray::set_vector_at | ( | int | i, |
Vec3f | vec, | ||
double | value | ||
) |
void PointArray::set_vector_at | ( | int | i, |
vector< double > | v | ||
) |
void PointArray::sim_add_point_double | ( | ) |
Add more points during the simulation.
Definition at line 1345 of file pointarray.cpp.
References aang, adihed, adist, n, points, set_number_points(), set_points_array(), and sim_updategeom().
void PointArray::sim_add_point_one | ( | ) |
Definition at line 1395 of file pointarray.cpp.
References aang, adihed, adist, apix, centx, centy, centz, map, mapc, n, points, set_points_array(), sim_pointpotential(), sim_potentiald(), and sim_updategeom().
Vec3f PointArray::sim_descent | ( | int | i | ) |
returns a vector pointing downhill for a single point
Definition at line 1108 of file pointarray.cpp.
References points, and sim_potentiald().
Referenced by sim_minstep(), and sim_minstep_seq().
void PointArray::sim_minstep | ( | double | maxshift | ) |
Takes a step to minimize the potential.
Definition at line 1140 of file pointarray.cpp.
References n, oldshifts, points, and sim_descent().
void PointArray::sim_minstep_seq | ( | double | meanshift | ) |
Takes a step to minimize the potential.
Definition at line 1166 of file pointarray.cpp.
References EMAN::Util::get_irand(), EMAN::Vec3< Type >::length(), map2d, n, points, and sim_descent().
|
inline |
Computes a potential value for a single point from a set of angles/distances using current energy settings.
Definition at line 142 of file pointarray.h.
References angc, dihed0, dihedc, dist0, and distc.
Referenced by sim_add_point_one(), sim_potential(), and sim_potentiald().
double PointArray::sim_potential | ( | ) |
Computes overall potential for the configuration.
Definition at line 988 of file pointarray.cpp.
References aang, adihed, adist, apix, centx, centy, centz, map, mapc, n, points, sim_pointpotential(), and sim_updategeom().
Referenced by sim_printstat().
double PointArray::sim_potentiald | ( | int | ind | ) |
Compute a single point potential value.
Definition at line 1003 of file pointarray.cpp.
References aang, adihed, adist, apix, centx, centy, centz, EMAN::Vec3< Type >::cross(), distpenc, EMAN::Vec3< Type >::dot(), EMAN::Vec3< Type >::length(), map, mapc, mindistc, n, points, sim_pointpotential(), and sim_updategeom().
Referenced by sim_add_point_one(), sim_descent(), and sim_potentialdxyz().
double PointArray::sim_potentialdxyz | ( | int | i, |
double | dx, | ||
double | dy, | ||
double | dz | ||
) |
Compute a potential value for a perturbed point, including +-2 nearest neighbors which will also be impacted.
Definition at line 1080 of file pointarray.cpp.
References points, and sim_potentiald().
void PointArray::sim_printstat | ( | ) |
prints some statistics to the screen
Definition at line 1275 of file pointarray.cpp.
References aang, adihed, adist, apix, centx, centy, centz, dist0, map, mapc, n, points, sim_potential(), and sim_updategeom().
void PointArray::sim_rescale | ( | ) |
rescale the entire set so the mean bond length matches dist0
Definition at line 1249 of file pointarray.cpp.
References dist0, EMAN::Vec3< Type >::length(), n, and points.
void PointArray::sim_set_pot_parms | ( | double | pdist0, |
double | pdistc, | ||
double | pangc, | ||
double | pdihed0, | ||
double | pdihedc, | ||
double | pmapc, | ||
EMData * | pmap, | ||
double | pmindistc, | ||
double | pdistpenc | ||
) |
Sets the parameters for the energy function.
Definition at line 1311 of file pointarray.cpp.
References angc, apix, centx, centy, centz, dihed0, dihedc, dist0, distc, distpenc, gradx, grady, gradz, map, map2d, mapc, and mindistc.
void PointArray::sim_updategeom | ( | ) |
Updates the dist, ang, dihed parameters.
Definition at line 945 of file pointarray.cpp.
References aang, adihed, adist, EMAN::Vec3< Type >::cross(), EMAN::Vec3< Type >::dot(), EMAN::Vec3< Type >::length(), n, and points.
Referenced by sim_add_point_double(), sim_add_point_one(), sim_potential(), sim_potentiald(), and sim_printstat().
void PointArray::sort_by_axis | ( | int | axis = 1 | ) |
Definition at line 2263 of file pointarray.cpp.
References cmp_axis_x(), cmp_axis_y(), cmp_axis_z(), cmp_val(), n, and points.
Referenced by set_from_density_map().
void PointArray::transform | ( | const Transform & | transform | ) |
void PointArray::zero | ( | ) |
Definition at line 144 of file pointarray.cpp.
Referenced by set_from_density_map().
|
private |
Definition at line 228 of file pointarray.h.
Referenced by PointArray(), sim_add_point_double(), sim_add_point_one(), sim_potential(), sim_potentiald(), sim_printstat(), sim_updategeom(), and ~PointArray().
|
private |
Definition at line 229 of file pointarray.h.
Referenced by PointArray(), sim_add_point_double(), sim_add_point_one(), sim_potential(), sim_potentiald(), sim_printstat(), sim_updategeom(), and ~PointArray().
|
private |
Definition at line 227 of file pointarray.h.
Referenced by PointArray(), sim_add_point_double(), sim_add_point_one(), sim_potential(), sim_potentiald(), sim_printstat(), sim_updategeom(), and ~PointArray().
|
private |
Definition at line 244 of file pointarray.h.
Referenced by sim_pointpotential(), and sim_set_pot_parms().
|
private |
Definition at line 244 of file pointarray.h.
Referenced by pdb2mrc_by_nfft(), pdb2mrc_by_summation(), projection_by_nfft(), projection_by_summation(), replace_by_summation(), set_from_density_map(), sim_add_point_one(), sim_potential(), sim_potentiald(), sim_printstat(), and sim_set_pot_parms().
|
private |
Definition at line 223 of file pointarray.h.
Referenced by pdb2mrc_by_summation(), PointArray(), read_ca_from_pdb(), read_from_pdb(), and set_number_points().
|
private |
Definition at line 249 of file pointarray.h.
Referenced by sim_add_point_one(), sim_potential(), sim_potentiald(), sim_printstat(), and sim_set_pot_parms().
|
private |
Definition at line 249 of file pointarray.h.
Referenced by sim_add_point_one(), sim_potential(), sim_potentiald(), sim_printstat(), and sim_set_pot_parms().
|
private |
Definition at line 249 of file pointarray.h.
Referenced by sim_add_point_one(), sim_potential(), sim_potentiald(), sim_printstat(), and sim_set_pot_parms().
|
private |
Definition at line 244 of file pointarray.h.
Referenced by sim_pointpotential(), and sim_set_pot_parms().
|
private |
Definition at line 244 of file pointarray.h.
Referenced by sim_pointpotential(), and sim_set_pot_parms().
|
private |
Used for simplistic loop dynamics simulation Assumes all points are connected sequentially in a closed loop, potential includes distance, angle and dihedral terms, with optional density based terms.
dist0 | - center distance for quadratic energy term |
distc | - quadratic distance coefficient c(dist-dist0)^2 |
angc | - quadratic angle coefficient c*(180-ang)^2 |
dihed0 | - dihedral center angle |
dihedc | - dihedral angle coefficient c*(dihed-dihed0)^2 |
mapc | - coefficient for map energy |
map | - EMData representing map to match/fit |
mindistc | - minimum distance between two points |
distpenc | - penalty for close points |
Definition at line 244 of file pointarray.h.
Referenced by sim_pointpotential(), sim_printstat(), sim_rescale(), and sim_set_pot_parms().
|
private |
Definition at line 244 of file pointarray.h.
Referenced by sim_pointpotential(), and sim_set_pot_parms().
|
private |
Definition at line 244 of file pointarray.h.
Referenced by sim_potentiald(), and sim_set_pot_parms().
|
private |
Definition at line 247 of file pointarray.h.
Referenced by PointArray(), sim_set_pot_parms(), and ~PointArray().
|
private |
Definition at line 247 of file pointarray.h.
Referenced by PointArray(), sim_set_pot_parms(), and ~PointArray().
|
private |
Definition at line 247 of file pointarray.h.
Referenced by PointArray(), sim_set_pot_parms(), and ~PointArray().
|
private |
Definition at line 246 of file pointarray.h.
Referenced by construct_helix(), fit_helix(), pdb2mrc_by_nfft(), pdb2mrc_by_summation(), PointArray(), set_from_density_map(), sim_add_point_one(), sim_potential(), sim_potentiald(), sim_printstat(), and sim_set_pot_parms().
|
private |
Definition at line 245 of file pointarray.h.
Referenced by sim_minstep_seq(), and sim_set_pot_parms().
|
private |
Definition at line 244 of file pointarray.h.
Referenced by sim_add_point_one(), sim_potential(), sim_potentiald(), sim_printstat(), and sim_set_pot_parms().
|
private |
Definition at line 244 of file pointarray.h.
Referenced by sim_potentiald(), and sim_set_pot_parms().
|
private |
Definition at line 222 of file pointarray.h.
Referenced by calc_total_length(), calc_transform(), delete_point(), distmx(), do_pca(), fit_helix(), get_number_points(), get_points(), match_points(), merge_to(), PointArray(), projection_by_nfft(), reverse_chain(), right_transform(), set_number_points(), sim_add_point_double(), sim_add_point_one(), sim_minstep(), sim_minstep_seq(), sim_potential(), sim_potentiald(), sim_printstat(), sim_rescale(), sim_updategeom(), sort_by_axis(), transform(), and zero().
|
private |
Definition at line 248 of file pointarray.h.
Referenced by sim_minstep().
|
private |
Definition at line 221 of file pointarray.h.
Referenced by calc_total_length(), center_to_zero(), construct_helix(), delete_point(), do_pca(), fit_helix(), get_bounding_box(), get_center(), get_points(), get_points_array(), get_value_at(), get_vector_at(), mask(), mask_asymmetric_unit(), merge_to(), pdb2mrc_by_nfft(), pdb2mrc_by_summation(), PointArray(), projection_by_nfft(), projection_by_summation(), read_ca_from_pdb(), read_from_pdb(), replace_by_summation(), reverse_chain(), right_transform(), save_pdb_with_helix(), save_to_pdb(), set_from(), set_from_density_map(), set_number_points(), set_points_array(), set_vector_at(), sim_add_point_double(), sim_add_point_one(), sim_descent(), sim_minstep(), sim_minstep_seq(), sim_potential(), sim_potentiald(), sim_potentialdxyz(), sim_printstat(), sim_rescale(), sim_updategeom(), sort_by_axis(), transform(), zero(), and ~PointArray().