Rosetta
|
xyzVector: Fast (x,y,z)-coordinate numeric vector More...
#include <xyzVector.hh>
Public Types | |
typedef T | Value |
typedef T & | Reference |
typedef T const & | ConstReference |
typedef T * | Pointer |
typedef T const * | ConstPointer |
typedef T | value_type |
typedef T & | reference |
typedef T const & | const_reference |
typedef T * | pointer |
typedef T const * | const_pointer |
typedef void | iterator_category |
typedef void | difference_type |
Public Member Functions | |
xyzVector () | |
Default constructor. More... | |
xyzVector (xyzVector const &v) | |
Copy constructor. More... | |
template<typename U > | |
xyzVector (xyzVector< U > const &v) | |
Copy constructor. More... | |
xyzVector (Value const &t) | |
Uniform value constructor. More... | |
xyzVector (Value const &x_a, Value const &y_a, Value const &z_a) | |
Triple value constructor. More... | |
template<typename U > | |
xyzVector (U const *p) | |
Pointer to contiguous values constructor. More... | |
~xyzVector () | |
Destructor. More... | |
xyzVector & | operator= (xyzVector const &v) |
Copy assignment. More... | |
template<typename U > | |
xyzVector & | operator= (xyzVector< U > const &v) |
Copy assignment. More... | |
template<typename U > | |
xyzVector & | operator= (U const *p) |
Assignment from pointer to contiguous values. More... | |
template<typename U > | |
xyzVector & | operator+= (xyzVector< U > const &v) |
+= xyzVector More... | |
template<typename U > | |
xyzVector & | operator-= (xyzVector< U > const &v) |
-= xyzVector More... | |
template<typename U > | |
xyzVector & | scaled_assign (Value const &t, xyzVector< U > const &v) |
Assign Value * xyzVector. More... | |
template<typename U > | |
xyzVector & | scaled_add (Value const &t, xyzVector< U > const &v) |
Add Value * xyzVector. More... | |
template<typename U > | |
xyzVector & | scaled_sub (Value const &t, xyzVector< U > const &v) |
Subtract Value * xyzVector. More... | |
xyzVector & | operator= (Value const &t) |
= Value More... | |
xyzVector & | operator+= (Value const &t) |
+= Value More... | |
xyzVector & | operator-= (Value const &t) |
-= Value More... | |
xyzVector & | operator*= (Value const &t) |
*= Value More... | |
xyzVector & | operator/= (Value const &t) |
/= Value More... | |
xyzVector & | assign (Value const &x_a, Value const &y_a, Value const &z_a) |
Triple value assignment. More... | |
bool | is_finite () const |
Test if there's any non-finite (inf, NAN) values in the vector. More... | |
std::string | to_string () const |
to_string, useful for utility exits More... | |
xyzVector & | clear () |
Clear. More... | |
xyzVector & | zero () |
Zero. More... | |
xyzVector & | negate () |
Negate. More... | |
xyzVector | operator- () const |
-xyzVector (negated copy) More... | |
xyzVector | negated () const |
Negated copy. More... | |
void | negated (xyzVector &a) const |
Negated: Return via argument (slightly faster) More... | |
xyzVector & | min (xyzVector const &v) |
Set minimum coordinates wrt another xyzVector. More... | |
xyzVector & | max (xyzVector const &v) |
Set maximum coordinates wrt another xyzVector. More... | |
xyzVector & | normalize () |
Normalize. More... | |
T | minimum_value () const |
get the lowest of the three values in the vector More... | |
T | maximum_value () const |
get the highest of the three values in the vector More... | |
void | normalized (xyzVector &a) const |
Normalized. More... | |
xyzVector & | normalize_or_zero () |
Normalize: zero xyzVector if length is zero. More... | |
void | normalized_or_zero (xyzVector &a) const |
Normalized: zero xyzVector if length is zero. More... | |
xyzVector & | normalize_any () |
Normalize: arbitrary normalized xyzVector if length is zero. More... | |
void | normalized_any (xyzVector &a) const |
Normalized: arbitrary normalized xyzVector if length is zero. More... | |
xyzVector & | normalize (Value const &length_a) |
Normalize to a length. More... | |
void | normalized (Value const &length_a, xyzVector &a) const |
Normalized to a length. More... | |
xyzVector & | normalize_or_zero (Value const &length_a) |
Normalize to a length: zero xyzVector if length is zero. More... | |
void | normalized_or_zero (Value const &length_a, xyzVector &a) const |
Normalized to a length: zero xyzVector if length is zero. More... | |
xyzVector & | normalize_any (Value const &length_a) |
Normalize to a length: arbitrary normalized xyzVector if length is zero. More... | |
void | normalized_any (Value const &length_a, xyzVector &a) const |
Normalized to a length: arbitrary normalized xyzVector if length is zero. More... | |
xyzVector | normalized () const |
Normalized copy. More... | |
xyzVector | normalized_or_zero () const |
Normalized copy: Zero xyzVector if length is zero. More... | |
xyzVector | normalized_any () const |
Normalized copy: Arbitrary normalized xyzVector if length is zero. More... | |
xyzVector | normalized (Value const &length_a) const |
Normalized to a length copy. More... | |
xyzVector | normalized_or_zero (Value const &length_a) const |
Normalized to a length copy: Zero xyzVector if length is zero. More... | |
xyzVector | normalized_any (Value const &length_a) const |
Normalized to a length copy: Arbitrary normalized xyzVector if length is zero. More... | |
xyzVector & | project_normal (xyzVector const &v) |
Project normal. More... | |
xyzVector | projected_normal (xyzVector const &v) const |
Projected normal copy. More... | |
void | projected_normal (xyzVector const &v, xyzVector &a) const |
Projected normal. More... | |
xyzVector & | project_parallel (xyzVector const &v) |
Project parallel. More... | |
xyzVector | projected_parallel (xyzVector const &v) const |
Projected parallel copy. More... | |
void | projected_parallel (xyzVector const &v, xyzVector &a) |
Projected parallel. More... | |
Value | distance (xyzVector const &v) const |
Distance. More... | |
Value | distance_squared (xyzVector const &v) const |
Distance. More... | |
Value | dot (xyzVector const &v) const |
Distance squared. More... | |
Value | dot_product (xyzVector const &v) const |
Dot product. More... | |
Value | inner_product (xyzVector const &v) const |
Inner product ( == dot product ) More... | |
xyzVector | cross (xyzVector const &v) const |
Cross product. More... | |
xyzVector | cross_product (xyzVector const &v) const |
Cross product. More... | |
bool | is_zero () const |
Is zero? More... | |
bool | is_normalized () const |
Is exactly normalized? More... | |
bool | is_normalized (Value const &tol) const |
Is normalized to within a tolerance? More... | |
bool | is_unit () const |
Is exactly a unit vector? More... | |
bool | is_unit (Value const &tol) const |
Is a unit vector to within a tolerance? More... | |
Value const & | x () const |
Value x const. More... | |
Value & | x () |
Value x. More... | |
Value const & | y () const |
Value y const. More... | |
Value & | y () |
Value y. More... | |
Value const & | z () const |
Value z const. More... | |
Value & | z () |
Value z. More... | |
Value | length () const |
Length. More... | |
Value | length_squared () const |
Length squared. More... | |
Value | norm () const |
Norm. More... | |
Value | norm_squared () const |
Norm squared. More... | |
Value | magnitude () const |
Magnitude. More... | |
Value | magnitude_squared () const |
Magnitude squared. More... | |
void | x (Value const &x_a) |
x assignment More... | |
void | y (Value const &y_a) |
y assignment More... | |
void | z (Value const &z_a) |
z assignment More... | |
Value const & | operator[] (int const i) const |
xyzVector[ i ] const: 0-based index More... | |
Value & | operator[] (int const i) |
xyzVector[ i ]: 0-based index More... | |
Value const & | operator() (int const i) const |
xyzVector( i ) const: 1-based index More... | |
Value & | operator() (int const i) |
xyzVector( i ): 1-based index More... | |
bool | equal_length (xyzVector const &v) |
Equal length? More... | |
bool | not_equal_length (xyzVector const &v) |
Not equal length? More... | |
template<typename U > | |
bool | not_equal_length (xyzVector< U > const &a, xyzVector< U > const &b) |
Not equal length? More... | |
bool | longer (xyzVector const &v) |
Longer? More... | |
bool | longer_or_equal (xyzVector const &v) |
Longer or equal length? More... | |
bool | shorter (xyzVector const &v) |
Shorter? More... | |
bool | shorter_or_equal (xyzVector const &v) |
Shorter or equal length? More... | |
Static Private Member Functions | |
static Value | square (Value const &t) |
square( t ) == t * t More... | |
Private Attributes | |
Value | x_ |
Coordinates of the 3 coordinate vector. More... | |
Value | y_ |
Value | z_ |
Friends | |
template<typename > | |
class | xyzVector |
template<typename > | |
class | xyzMatrix |
xyzVector< T > | operator* (xyzMatrix< T > const &m, xyzVector< T > const &v) |
xyzVector< T > | product (xyzMatrix< T > const &m, xyzVector< T > const &v) |
xyzMatrix * xyzVector product More... | |
xyzVector< T > & | inplace_product (xyzMatrix< T > const &m, xyzVector< T > &v) |
xyzMatrix * xyzVector in-place product More... | |
xyzVector< T > | transpose_product (xyzMatrix< T > const &m, xyzVector< T > const &v) |
xyzMatrix^T * xyzVector product More... | |
xyzVector< T > & | inplace_transpose_product (xyzMatrix< T > const &m, xyzVector< T > &v) |
xyzMatrix^T * xyzVector in-place transpose product More... | |
xyzMatrix< T > | outer_product (xyzVector< T > const &a, xyzVector< T > const &b) |
xyzVector xyzVector outer product More... | |
xyzMatrix< T > | projection_matrix (xyzVector< T > const &v) |
geometric center More... | |
xyzMatrix< T > | rotation_matrix (xyzVector< T > const &axis, T const &theta) |
Rotation matrix for rotation about an axis by an angle in radians. More... | |
xyzVector | operator+ (xyzVector const &a, xyzVector const &b) |
xyzVector + xyzVector More... | |
xyzVector | operator- (xyzVector const &a, xyzVector const &b) |
xyzVector - xyzVector More... | |
xyzVector | operator+ (xyzVector const &v, Value const &t) |
xyzVector + Value More... | |
xyzVector | operator+ (Value const &t, xyzVector const &v) |
Value + xyzVector. More... | |
xyzVector | operator- (xyzVector const &v, Value const &t) |
xyzVector - Value More... | |
xyzVector | operator- (Value const &t, xyzVector const &v) |
Value - xyzVector. More... | |
xyzVector | operator* (xyzVector const &v, Value const &t) |
xyzVector * Value More... | |
xyzVector | operator* (Value const &t, xyzVector const &v) |
Value * xyzVector. More... | |
xyzVector | operator/ (xyzVector const &v, Value const &t) |
xyzVector / Value More... | |
template<typename U > | |
void | add (xyzVector< U > const &a, xyzVector< U > const &b, xyzVector< U > &r) |
Add: xyzVector + xyzVector. More... | |
template<typename U > | |
void | add (xyzVector< U > const &v, U const &t, xyzVector< U > &r) |
Add: xyzVector + Value. More... | |
template<typename U > | |
void | add (U const &t, xyzVector< U > const &v, xyzVector< U > &r) |
Add: Value + xyzVector. More... | |
template<typename U > | |
void | subtract (xyzVector< U > const &a, xyzVector< U > const &b, xyzVector< U > &r) |
Subtract: xyzVector - xyzVector. More... | |
template<typename U > | |
void | subtract (xyzVector< U > const &v, U const &t, xyzVector< U > &r) |
Subtract: xyzVector - Value. More... | |
template<typename U > | |
void | subtract (U const &t, xyzVector< U > const &v, xyzVector< U > &r) |
Subtract: Value - xyzVector. More... | |
template<typename U > | |
void | multiply (xyzVector< U > const &v, U const &t, xyzVector< U > &r) |
Multiply: xyzVector * Value. More... | |
template<typename U > | |
void | multiply (U const &t, xyzVector< U > const &v, xyzVector< U > &r) |
Multiply: Value * xyzVector. More... | |
template<typename U > | |
void | divide (xyzVector< U > const &v, U const &t, xyzVector< U > &r) |
Divide: xyzVector / Value. More... | |
template<typename U > | |
xyzVector< U > | min (xyzVector< U > const &a, xyzVector< U > const &b) |
xyzVector with min coordinates of two xyzVectors More... | |
template<typename U > | |
xyzVector< U > | max (xyzVector< U > const &a, xyzVector< U > const &b) |
xyzVector with max coordinates of two xyzVectors More... | |
template<typename U > | |
U | dot (xyzVector< U > const &a, xyzVector< U > const &b) |
Dot product. More... | |
template<typename U > | |
U | dot_product (xyzVector< U > const &a, xyzVector< U > const &b) |
Dot product. More... | |
template<typename U > | |
U | inner_product (xyzVector< U > const &a, xyzVector< U > const &b) |
Inner product ( == dot product ) More... | |
template<typename U > | |
xyzVector< U > | cross (xyzVector< U > const &a, xyzVector< U > const &b) |
Cross product. More... | |
template<typename U > | |
xyzVector< U > | cross_product (xyzVector< U > const &a, xyzVector< U > const &b) |
Cross product. More... | |
template<typename U > | |
void | cross (xyzVector< U > const &a, xyzVector< U > const &b, xyzVector< U > &c) |
Cross product: Return via argument (slightly faster) More... | |
template<typename U > | |
void | cross_product (xyzVector< U > const &a, xyzVector< U > const &b, xyzVector< U > &c) |
Cross product: Return via argument (slightly faster) More... | |
template<typename U > | |
xyzVector< U > | midpoint (xyzVector< U > const &a, xyzVector< U > const &b) |
Midpoint of 2 xyzVectors. More... | |
template<typename U > | |
void | midpoint (xyzVector< U > const &a, xyzVector< U > const &b, xyzVector< U > &m) |
Midpoint of 2 xyzVectors: Return via argument (slightly faster) More... | |
template<typename U > | |
xyzVector< U > | center (xyzVector< U > const &a, xyzVector< U > const &b) |
Center of 2 xyzVectors. More... | |
template<typename U > | |
void | center (xyzVector< U > const &a, xyzVector< U > const &b, xyzVector< U > &m) |
Center of 2 xyzVectors: Return via argument (slightly faster) More... | |
template<typename U > | |
xyzVector< U > | center (xyzVector< U > const &a, xyzVector< U > const &b, xyzVector< U > const &c) |
Center of 3 xyzVectors. More... | |
template<typename U > | |
void | center (xyzVector< U > const &a, xyzVector< U > const &b, xyzVector< U > const &c, xyzVector< U > &m) |
Center of 3 xyzVectors: Return via argument (slightly faster) More... | |
template<typename U > | |
xyzVector< U > | center (xyzVector< U > const &a, xyzVector< U > const &b, xyzVector< U > const &c, xyzVector< U > const &d) |
Center of 4 xyzVectors. More... | |
template<typename U > | |
void | center (xyzVector< U > const &a, xyzVector< U > const &b, xyzVector< U > const &c, xyzVector< U > const &d, xyzVector< U > &m) |
Center of 4 xyzVectors: Return via argument (slightly faster) More... | |
template<typename U > | |
xyzVector< U > | update_operation (xyzVector< U > const &a, xyzVector< U > const &b) |
template<typename U > | |
xyzVector< U > | update_5way_operation (xyzVector< U > const &a, xyzVector< U > const &b, xyzVector< U > const &c, xyzVector< U > const &d, xyzVector< U > const &e) |
bool | operator== (xyzVector const &a, xyzVector const &b) |
xyzVector == xyzVector More... | |
bool | operator!= (xyzVector const &a, xyzVector const &b) |
xyzVector != xyzVector More... | |
bool | operator< (xyzVector const &a, xyzVector const &b) |
xyzVector < xyzVector More... | |
bool | operator<= (xyzVector const &a, xyzVector const &b) |
xyzVector <= xyzVector More... | |
bool | operator>= (xyzVector const &a, xyzVector const &b) |
xyzVector >= xyzVector More... | |
bool | operator> (xyzVector const &a, xyzVector const &b) |
xyzVector > xyzVector More... | |
bool | operator== (xyzVector const &v, Value const &t) |
xyzVector == Value More... | |
bool | operator!= (xyzVector const &v, Value const &t) |
xyzVector != Value More... | |
bool | operator< (xyzVector const &v, Value const &t) |
xyzVector < Value More... | |
bool | operator<= (xyzVector const &v, Value const &t) |
xyzVector <= Value More... | |
bool | operator>= (xyzVector const &v, Value const &t) |
xyzVector >= Value More... | |
bool | operator> (xyzVector const &v, Value const &t) |
xyzVector > Value More... | |
bool | operator== (Value const &t, xyzVector const &v) |
Value == xyzVector. More... | |
bool | operator!= (Value const &t, xyzVector const &v) |
Value != xyzVector. More... | |
bool | operator< (Value const &t, xyzVector const &v) |
Value < xyzVector. More... | |
bool | operator<= (Value const &t, xyzVector const &v) |
Value <= xyzVector. More... | |
bool | operator>= (Value const &t, xyzVector const &v) |
Value >= xyzVector. More... | |
bool | operator> (Value const &t, xyzVector const &v) |
Value > xyzVector. More... | |
template<typename U > | |
bool | equal_length (xyzVector< U > const &a, xyzVector< U > const &b) |
Equal length? More... | |
xyzVector: Fast (x,y,z)-coordinate numeric vector
typedef T const* numeric::xyzVector< T >::const_pointer |
typedef T const& numeric::xyzVector< T >::const_reference |
typedef T const* numeric::xyzVector< T >::ConstPointer |
typedef T const& numeric::xyzVector< T >::ConstReference |
typedef void numeric::xyzVector< T >::difference_type |
typedef void numeric::xyzVector< T >::iterator_category |
typedef T* numeric::xyzVector< T >::Pointer |
typedef T* numeric::xyzVector< T >::pointer |
typedef T& numeric::xyzVector< T >::Reference |
typedef T& numeric::xyzVector< T >::reference |
typedef T numeric::xyzVector< T >::Value |
typedef T numeric::xyzVector< T >::value_type |
|
inline |
Default constructor.
|
inline |
Copy constructor.
|
inline |
Copy constructor.
|
inlineexplicit |
Uniform value constructor.
|
inline |
Triple value constructor.
|
inlineexplicit |
Pointer to contiguous values constructor.
|
inline |
Destructor.
|
inline |
Triple value assignment.
References numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by read_embeddings(), read_membrane(), and numeric::crick_equations::XYZ_BUNDLE().
|
inline |
Clear.
References numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by pyrosetta.bindings.pose.ResidueLabelAccessor::discard().
|
inline |
Cross product.
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::xyzVector, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by TCDock::__dock_base__(), numeric::xyzTransform< T >::align(), Tet4HMatchAligner::align_rot(), alignaxis(), MatchSet::cross(), numeric::deriv::distance_f1_f2_deriv(), dock(), generate_from_fiber(), numeric::HomogeneousTransform< T >::HomogeneousTransform(), ik_arg_asp_frnt(), ik_arg_asp_side(), ik_arg_glu_frnt(), ik_arg_glu_side(), ik_his_clamp(), main(), numeric::geometry::make_plane_from_three_points(), KinFunGroupTK::place_c(), run(), run_diiron_glu(), run_m8(), Arch::slide_axis(), test_chi_xform(), testone(), visualize(), and wriggle_test().
|
inline |
Cross product.
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::xyzVector, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by get_angles().
|
inline |
Distance.
References numeric::xyzVector< T >::square(), kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by BuriedUnsatPolarsFinder::acc_geom_check(), add_deviations(), Tet4HMatchAligner::align_info(), xtal_water_bunsat::atomid_is_contacting_crystallographic_water(), calculate_hASA_by_type_and_attractiveE(), HbondZincBackbone::carbonyl_hbond_search(), PoseWrap::check_scattach_res(), xtal_water_bunsat::closest_crystallographic_water_dist(), HbondZinc::constrain_zinc(), dna_nbr_radii_test(), BuriedUnsatPolarsFinder::don_geom_check(), zinc2_homodimer_setup::filter_clashes(), find_centerest_residue(), find_dsf(), find_next_repeat_inflection_point(), get_change_in_distance(), myspace::get_touched_res(), get_zn_axes(), HbondZinc::hbond_constraint(), hyd_petf_sf4_dis(), GlycanClashCheckMover::is_clashing(), loop_modeling_test(), main(), BuriedUnsatPolarsFinder::metal_check(), TCDock::min_termini_dis(), passes_quality_check(), phosphate_stats(), psI_petf_sf4_dis(), apps::pilot::momeara::HBondConformation::relax_pose_around_hbond(), run(), run_pep_prep(), run_tyr_his(), BuriedUnsatPolarsFinder::sulphur_bond_check(), and apps::public1::scenarios::chemically_conjugated_docking::ubq_ras_rotation_angle().
|
inline |
Distance.
Distance squared
References numeric::xyzVector< T >::square(), kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by RDF_Mover::apply(), brt_clash(), MatchSet::c2_linker_check_dist(), collect_stats(), compare_gpu_result_against_cpu(), MatchSet::cross(), MatchSet::cross_homodimer(), design_dyad(), dock(), fast_clash_check(), find_dsf(), get_aligned_crd(), get_atom_lk_energy_by_residue_no_count_pair(), TCDock::get_best_sub1_contact_delta_rotations(), CrystFFTDock::get_interfaces_allatom(), get_radius(), numeric::VoxelGrid< T >::GetNeighbors1D(), numeric::VoxelGrid< T >::GetNeighborsMultiDimensional(), numeric::VoxelGrid< T >::HasNeighbors1D(), numeric::VoxelGrid< T >::HasNeighborsMultiDimensional(), hbond_stats(), numeric::HomogeneousTransform< T >::HomogeneousTransform(), is_hbond(), main(), motif_score_pose(), myxdis(), BruteFunGroupTK::place_c(), BruteRotSel::place_n(), KinRotSel::place_n(), place_sf4(), place_zns(), CapriTwoBodyEnergy::residue_pair_energy(), run(), run_diiron_glu(), run_m8(), run_tyr_his(), run_zn2his(), CapriTotalEnergy::score_experimental_constraints(), slow_clash(), slow_nbcount(), slow_nbset(), SphereGrinder(), and TEST().
|
inline |
Distance squared.
Dot product
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by Tet4HMatchAligner::align_info(), Tet4HMatchAligner::align_rot(), alignaxis(), numeric::geometry::are_coplanar(), cone_cen_nc_calculator(), cone_FA_nc_anyatom_calculator(), cone_FA_nc_calculator(), count_neighbors(), MatchSet::cross(), decompose(), dock(), generate_from_fiber(), get_base_pucker(), numeric::HomogeneousTransform< T >::HomogeneousTransform(), ik_his_clamp(), line_cone_intersection(), main(), KinRotSel::place_n(), pointGroupHit::pointGroupHit(), project_line(), numeric::xyzVector< T >::project_normal(), numeric::xyzVector< T >::project_parallel(), numeric::xyzVector< T >::projected_normal(), numeric::xyzVector< T >::projected_parallel(), numeric::geometry::residual_squared_of_points_to_plane(), run(), run_diiron_glu(), run_m8(), run_sf4h(), run_tyr_his(), run_zn2his(), and wriggle_test().
|
inline |
Dot product.
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by myspace::find_best_projection(), get_angles(), and myspace::is_contacting().
|
inline |
Equal length?
References numeric::xyzVector< T >::length_squared(), and kmeans_adaptive_kernel_density_bb_dependent_rotlib::v.
|
inline |
Inner product ( == dot product )
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Test if there's any non-finite (inf, NAN) values in the vector.
References utility::isfinite(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Is exactly normalized?
References numeric::xyzVector< T >::length_squared().
|
inline |
Is normalized to within a tolerance?
References numeric::xyzVector< T >::length_squared(), and loops_kic::tol.
|
inline |
Is exactly a unit vector?
References numeric::xyzVector< T >::length_squared().
Referenced by numeric::ccd_angle().
|
inline |
Is a unit vector to within a tolerance?
References numeric::xyzVector< T >::length_squared(), and loops_kic::tol.
|
inline |
Is zero?
References numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by numeric::alignVectorSets(), and numeric::random::random_normal().
|
inline |
Length.
References numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by Tet4HMatchAligner::align_rot(), align_sf4(), align_zns(), numeric::deriv::angle_p1_deriv(), numeric::deriv::angle_p1_p2_p3_deriv(), enumerate_junctions.Design::attach_valid(), numeric::ccd_angle(), ch_o_pdbstats_from_pose(), check_jump(), numeric::deriv::dihedral_p1_cosine_deriv_first(), numeric::deriv::dihedral_p2_cosine_deriv_first(), dock(), TCDock::dump_pdb(), HelixHit::frame(), generate_from_fiber(), numeric::UniformRotationSampler::generateIcosahedralSamples(), get_contacts(), CrystFFTDock::get_interfaces_allatom(), get_RNA_binding_residues(), ik_his_clamp(), MatchLig::isbad(), main(), mg_pdbstats_from_pose(), MPframeworkTest1Mover::move_together(), numeric::xyzVector< T >::normalize(), numeric::xyzVector< T >::normalize_any(), numeric::xyzVector< T >::normalize_or_zero(), numeric::xyzVector< T >::normalized(), numeric::xyzVector< T >::normalized_any(), numeric::xyzVector< T >::normalized_or_zero(), enumerate_junctions.Design::output_string(), enumerate_junctions.Design::output_valid(), KinFunGroupTK::place_c(), enumerate_junctions.DHR::print(), enumerate_junctions.Junction::print(), rand_rot(), recenter_with_missing(), setup_symmetric_dimer(), enumerate_junctions.Junction::to_component(), enumerate_junctions.DHR::write_to_file(), and enumerate_junctions.Junction::write_to_file().
|
inline |
Length squared.
References numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by CustomMover::apply(), numeric::xyzVector< T >::equal_length(), generate_from_fiber(), get_lj_atom_score(), numeric::xyzVector< T >::is_normalized(), numeric::xyzVector< T >::is_unit(), numeric::xyzVector< T >::longer(), numeric::xyzVector< T >::longer_or_equal(), main(), numeric::xyzVector< T >::not_equal_length(), search_translations(), numeric::xyzVector< T >::shorter(), and numeric::xyzVector< T >::shorter_or_equal().
|
inline |
Longer?
References numeric::xyzVector< T >::length_squared(), and kmeans_adaptive_kernel_density_bb_dependent_rotlib::v.
|
inline |
Longer or equal length?
References numeric::xyzVector< T >::length_squared(), and kmeans_adaptive_kernel_density_bb_dependent_rotlib::v.
|
inline |
Magnitude.
References numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Magnitude squared.
References numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Set maximum coordinates wrt another xyzVector.
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by MatchSet::init_clash_check(), ClashCheck::init_clash_check(), main(), and run_sf4h().
|
inline |
get the highest of the three values in the vector
References max(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by numeric::rgb_to_hsv().
|
inline |
Set minimum coordinates wrt another xyzVector.
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by MatchSet::init_clash_check(), and ClashCheck::init_clash_check().
|
inline |
get the lowest of the three values in the vector
References min(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by numeric::rgb_to_hsv().
|
inline |
Negate.
References numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Negated copy.
References numeric::xyzVector< T >::x_, numeric::xyzVector< T >::xyzVector, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Negated: Return via argument (slightly faster)
References a, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Norm.
References numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by calculate_hASA_by_type_and_attractiveE().
|
inline |
Norm squared.
References numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalize.
References CREATE_EXCEPTION, numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by alignaxis(), numeric::alignVectorSets(), numeric::AxisRotationSampler::AxisRotationSampler(), calculate_theoretical_RNA_length_with_bond_angle_dependence(), apps::pilot::HelixMover::get_helix_center(), get_reflection_axis(), helix_axis(), numeric::HomogeneousTransform< T >::HomogeneousTransform(), InterfaceStrandFinderMover::is_strand_exposed(), main(), numeric::geometry::make_plane_from_three_points(), and slice_ellipsoid_envelope().
|
inline |
Normalize to a length.
References numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalize: arbitrary normalized xyzVector if length is zero.
References numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalize to a length: arbitrary normalized xyzVector if length is zero.
References numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalize: zero xyzVector if length is zero.
References numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalize to a length: zero xyzVector if length is zero.
References numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalized copy.
References numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::xyzVector, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalized to a length copy.
References numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::xyzVector, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalized to a length.
References a, numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalized.
References a, CREATE_EXCEPTION, numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by Tet4HMatchAligner::align_info(), Tet4HMatchAligner::align_rot(), alignaxis(), numeric::ccd_angle(), change_floating_sc_geometry(), dock(), doit(), dostuff(), generate_from_fiber(), get_lj_atom_score(), get_zn_axes(), ik_arg_asp_frnt(), ik_arg_asp_side(), ik_arg_glu_frnt(), ik_arg_glu_side(), ik_his_clamp(), intersecting_bpy_axes(), intersecting_disulfide_axes(), isctfast(), main(), KinFunGroupTK::place_c(), KinRotSel::place_n(), zinc_stats::ZincStatisticGenerator::recursively_model_rotamer_chis(), run(), run_m8(), run_sf4h(), run_tyr_his(), run_zn2his(), sicfast(), HubDenovo::stupid_ddg(), TCDock::swap_axis(), TCDock::TCDock(), and test_chi_xform().
|
inline |
Normalized copy: Arbitrary normalized xyzVector if length is zero.
References numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::xyzVector, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalized to a length copy: Arbitrary normalized xyzVector if length is zero.
References numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::xyzVector, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalized to a length: arbitrary normalized xyzVector if length is zero.
References a, numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalized: arbitrary normalized xyzVector if length is zero.
References a, numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalized copy: Zero xyzVector if length is zero.
References numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::xyzVector, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalized to a length copy: Zero xyzVector if length is zero.
References numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::xyzVector, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalized to a length: zero xyzVector if length is zero.
References a, numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Normalized: zero xyzVector if length is zero.
References a, numeric::xyzVector< T >::length(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by numeric::random::random_normal().
|
inline |
Not equal length?
References numeric::xyzVector< T >::length_squared(), and kmeans_adaptive_kernel_density_bb_dependent_rotlib::v.
bool numeric::xyzVector< T >::not_equal_length | ( | xyzVector< U > const & | a, |
xyzVector< U > const & | b | ||
) |
Not equal length?
|
inline |
xyzVector( i ): 1-based index
References create_a3b_hbs::i, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
xyzVector( i ) const: 1-based index
References create_a3b_hbs::i, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
*= Value
References predPRE::t, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
+= Value
References predPRE::t, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
|
inline |
-xyzVector (negated copy)
References numeric::xyzVector< T >::x_, numeric::xyzVector< T >::xyzVector, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
-= Value
References predPRE::t, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
|
inline |
/= Value
References predPRE::t, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Assignment from pointer to contiguous values.
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::p, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
= Value
References predPRE::t, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Copy assignment.
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Copy assignment.
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
xyzVector[ i ]: 0-based index
References create_a3b_hbs::i, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
xyzVector[ i ] const: 0-based index
References create_a3b_hbs::i, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Project normal.
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::c, numeric::xyzVector< T >::dot(), kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Project parallel.
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::c, numeric::xyzVector< T >::dot(), kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Projected normal copy.
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::c, numeric::xyzVector< T >::dot(), kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::xyzVector, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Projected normal.
References a, kmeans_adaptive_kernel_density_bb_dependent_rotlib::c, numeric::xyzVector< T >::dot(), kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Projected parallel copy.
References kmeans_adaptive_kernel_density_bb_dependent_rotlib::c, numeric::xyzVector< T >::dot(), kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, and numeric::xyzVector< T >::xyzVector.
Referenced by zinc_stats::ZincStatisticGenerator::recursively_model_rotamer_chis().
|
inline |
Projected parallel.
References a, kmeans_adaptive_kernel_density_bb_dependent_rotlib::c, numeric::xyzVector< T >::dot(), and kmeans_adaptive_kernel_density_bb_dependent_rotlib::v.
|
inline |
Add Value * xyzVector.
References predPRE::t, kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Assign Value * xyzVector.
References predPRE::t, kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Subtract Value * xyzVector.
References predPRE::t, kmeans_adaptive_kernel_density_bb_dependent_rotlib::v, numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
|
inline |
Shorter?
References numeric::xyzVector< T >::length_squared(), and kmeans_adaptive_kernel_density_bb_dependent_rotlib::v.
|
inline |
Shorter or equal length?
References numeric::xyzVector< T >::length_squared(), and kmeans_adaptive_kernel_density_bb_dependent_rotlib::v.
|
inlinestaticprivate |
square( t ) == t * t
References predPRE::t.
Referenced by numeric::xyzVector< T >::distance(), and numeric::xyzVector< T >::distance_squared().
|
inline |
to_string, useful for utility exits
References numeric::interpolation::to_string(), numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by MPFoldingMover::apply(), and check_options().
|
inline |
|
inline |
Value x const.
References numeric::xyzVector< T >::x_.
Referenced by PyMOL-Rosetta-relay-client.XYZCoord::__init__(), PyMOL-RosettaServer.XYZCoord::__init__(), PyMOL-Rosetta-relay-client.XYZCoord::__str__(), PyMOL-RosettaServer.XYZCoord::__str__(), pyrosetta.PyMOLRosettaServer.XYZCoord::__str__(), MyRotMover::apply(), HBondReporter::apply(), numeric::geometry::hashing::SixDCoordinateBinner::bin6(), ClashCheck::clash_check(), MatchSet::clash_check(), numeric::geometry::hashing::xyzStripeHash::clash_check_ball(), MatchSet::cross(), MatchSet::cross_homodimer(), numeric::deserialize(), dump_hbonds(), MatchAlignInfo::dump_pdb(), dumpsym(), fit_helix_in_map(), MyRT::from_axis(), numeric::xyzTransform< T >::from_euler_angles_rad(), get_change_in_distance(), get_cys_rts(), ClosabilityScore::get_rt_over_leap(), numeric::VoxelGrid< T >::GetSqDistanceOutsideBoundingBox(), apps::pilot::momeara::HBondConformation::hbond_param_sweep(), numeric::HomogeneousTransform< T >::HomogeneousTransform(), numeric::hsv_to_rgb(), numeric::geometry::hashing::xyzStripeHash::init(), MatchSet::init_clash_check(), ClashCheck::init_clash_check(), isctfast(), local_rms(), local_rms_window(), main(), DisulfEpos::make_farray(), mg_pdbstats_from_pose(), numeric::HomogeneousTransform< T >::operator*(), numeric::operator<<(), zinc_stats::ZincStatisticGenerator::output_file(), KinFunGroupTK::place_c(), KinRotSel::place_n(), numeric::principal_components_and_eigenvalues(), print_pep_csts(), rb_entropy_test(), read_embeddings(), read_membrane(), real6_from_rt(), ui::ui_protocols::helical_bundle::HelicalBundlePoseDrawOpenGLWidget::reset_nonparametric_translation_vect(), numeric::rgb_to_hsv(), run(), run_diiron_glu(), run_m8(), run_pep_prep(), run_tyr_his(), run_zn2his(), numeric::serialize(), set_pep_cst(), set_pep_csts(), numeric::VoxelGrid< T >::SetupGrid(), MembraneRelaxMover::show_membrane_position(), sicfast(), slice_ellipsoid_envelope(), slow_nbcount(), IsctFast::test(), numeric::geometry::hashing::xyzStripeHash::translation_real(), numeric::random::uniform_vector_sphere(), update_atom_positions(), user_overwrites_options(), numeric::geometry::vector_normal_to_ring_plane_of_best_fit(), PBPotentialMover::write_APBS_config(), and numeric::crick_equations::XYZ_BUNDLE().
|
inline |
x assignment
References numeric::xyzVector< T >::x_.
Referenced by PyMOL-Rosetta-relay-client.XYZCoord::__init__(), PyMOL-RosettaServer.XYZCoord::__init__(), PyMOL-Rosetta-relay-client.XYZCoord::__str__(), PyMOL-RosettaServer.XYZCoord::__str__(), and pyrosetta.PyMOLRosettaServer.XYZCoord::__str__().
|
inline |
|
inline |
Value y const.
References numeric::xyzVector< T >::y_.
Referenced by PyMOL-Rosetta-relay-client.XYZCoord::__init__(), PyMOL-RosettaServer.XYZCoord::__init__(), PyMOL-Rosetta-relay-client.XYZCoord::__str__(), PyMOL-RosettaServer.XYZCoord::__str__(), pyrosetta.PyMOLRosettaServer.XYZCoord::__str__(), MyRotMover::apply(), HBondReporter::apply(), numeric::geometry::hashing::SixDCoordinateBinner::bin6(), ClashCheck::clash_check(), MatchSet::clash_check(), numeric::geometry::hashing::xyzStripeHash::clash_check_ball(), MatchSet::cross(), MatchSet::cross_homodimer(), numeric::deserialize(), dump_hbonds(), MatchAlignInfo::dump_pdb(), dumpsym(), fit_helix_in_map(), MyRT::from_axis(), numeric::xyzTransform< T >::from_euler_angles_rad(), get_change_in_distance(), get_cys_rts(), ClosabilityScore::get_rt_over_leap(), numeric::VoxelGrid< T >::GetSqDistanceOutsideBoundingBox(), apps::pilot::momeara::HBondConformation::hbond_param_sweep(), numeric::HomogeneousTransform< T >::HomogeneousTransform(), numeric::hsv_to_rgb(), numeric::geometry::hashing::xyzStripeHash::init(), MatchSet::init_clash_check(), ClashCheck::init_clash_check(), isctfast(), local_rms(), local_rms_window(), main(), DisulfEpos::make_farray(), mg_pdbstats_from_pose(), numeric::HomogeneousTransform< T >::operator*(), numeric::operator<<(), zinc_stats::ZincStatisticGenerator::output_file(), KinFunGroupTK::place_c(), KinRotSel::place_n(), numeric::principal_components_and_eigenvalues(), print_pep_csts(), rb_entropy_test(), read_embeddings(), read_membrane(), real6_from_rt(), ui::ui_protocols::helical_bundle::HelicalBundlePoseDrawOpenGLWidget::reset_nonparametric_translation_vect(), numeric::rgb_to_hsv(), run(), run_diiron_glu(), run_m8(), run_pep_prep(), run_tyr_his(), run_zn2his(), numeric::serialize(), set_pep_cst(), set_pep_csts(), numeric::VoxelGrid< T >::SetupGrid(), MembraneRelaxMover::show_membrane_position(), sicfast(), slice_ellipsoid_envelope(), slow_nbcount(), IsctFast::test(), numeric::geometry::hashing::xyzStripeHash::translation_real(), numeric::random::uniform_vector_sphere(), user_overwrites_options(), numeric::geometry::vector_normal_to_ring_plane_of_best_fit(), PBPotentialMover::write_APBS_config(), and numeric::crick_equations::XYZ_BUNDLE().
|
inline |
y assignment
References numeric::xyzVector< T >::y_.
Referenced by PyMOL-Rosetta-relay-client.XYZCoord::__init__(), PyMOL-RosettaServer.XYZCoord::__init__(), PyMOL-Rosetta-relay-client.XYZCoord::__str__(), PyMOL-RosettaServer.XYZCoord::__str__(), and pyrosetta.PyMOLRosettaServer.XYZCoord::__str__().
|
inline |
|
inline |
Value z const.
References numeric::xyzVector< T >::z_.
Referenced by PyMOL-Rosetta-relay-client.XYZCoord::__init__(), PyMOL-RosettaServer.XYZCoord::__init__(), PyMOL-Rosetta-relay-client.XYZCoord::__str__(), PyMOL-RosettaServer.XYZCoord::__str__(), pyrosetta.PyMOLRosettaServer.XYZCoord::__str__(), align_sf4(), align_zns(), MyRotMover::apply(), HBondReporter::apply(), numeric::geometry::hashing::SixDCoordinateBinner::bin6(), calc_c3_rmsd(), ClashCheck::clash_check(), MatchSet::clash_check(), numeric::geometry::hashing::xyzStripeHash::clash_check_ball(), MatchSet::cross(), MatchSet::cross_homodimer(), numeric::deserialize(), dock(), dump_hbonds(), MatchAlignInfo::dump_pdb(), dumpsym(), fit_helix_in_map(), MyRT::from_axis(), numeric::xyzTransform< T >::from_euler_angles_rad(), get_change_in_distance(), get_cys_rts(), get_repl_xyz(), ClosabilityScore::get_rt_over_leap(), numeric::VoxelGrid< T >::GetSqDistanceOutsideBoundingBox(), apps::pilot::momeara::HBondConformation::hbond_param_sweep(), numeric::HomogeneousTransform< T >::HomogeneousTransform(), numeric::hsv_to_rgb(), numeric::geometry::hashing::xyzStripeHash::init(), MatchSet::init_clash_check(), ClashCheck::init_clash_check(), isctfast(), local_rms(), local_rms_window(), main(), DisulfEpos::make_farray(), mg_pdbstats_from_pose(), numeric::HomogeneousTransform< T >::operator*(), numeric::operator<<(), zinc_stats::ZincStatisticGenerator::output_file(), KinFunGroupTK::place_c(), KinRotSel::place_n(), numeric::principal_components_and_eigenvalues(), print_pep_csts(), rb_entropy_test(), read_embeddings(), read_membrane(), real6_from_rt(), ui::ui_protocols::helical_bundle::HelicalBundlePoseDrawOpenGLWidget::reset_nonparametric_translation_vect(), numeric::rgb_to_hsv(), run(), run_diiron_glu(), run_m8(), run_pep_prep(), run_tyr_his(), run_zn2his(), numeric::serialize(), set_pep_cst(), set_pep_csts(), numeric::VoxelGrid< T >::SetupGrid(), MembraneRelaxMover::show_membrane_position(), sicfast(), slice_ellipsoid_envelope(), slow_nbcount(), IsctFast::test(), numeric::geometry::hashing::xyzStripeHash::translation_real(), numeric::random::uniform_vector_sphere(), user_overwrites_options(), numeric::geometry::vector_normal_to_ring_plane_of_best_fit(), PBPotentialMover::write_APBS_config(), and numeric::crick_equations::XYZ_BUNDLE().
|
inline |
z assignment
References numeric::xyzVector< T >::z_.
Referenced by PyMOL-Rosetta-relay-client.XYZCoord::__init__(), PyMOL-RosettaServer.XYZCoord::__init__(), PyMOL-Rosetta-relay-client.XYZCoord::__str__(), PyMOL-RosettaServer.XYZCoord::__str__(), and pyrosetta.PyMOLRosettaServer.XYZCoord::__str__().
|
inline |
Zero.
References numeric::xyzVector< T >::x_, numeric::xyzVector< T >::y_, and numeric::xyzVector< T >::z_.
Referenced by avg_ca_position(), and main().
|
friend |
Add: Value + xyzVector.
Referenced by job_manager.MoveStatsWindow::__init__(), and pyrosetta.bindings.pose.ResidueLabelAccessor::discard().
|
friend |
|
friend |
Add: xyzVector + Value.
Referenced by job_manager.MoveStatsWindow::__init__(), and pyrosetta.bindings.pose.ResidueLabelAccessor::discard().
|
friend |
Center of 2 xyzVectors.
Referenced by MPFoldingMover::apply().
|
friend |
Center of 2 xyzVectors: Return via argument (slightly faster)
|
friend |
Center of 3 xyzVectors.
|
friend |
Center of 3 xyzVectors: Return via argument (slightly faster)
|
friend |
Center of 4 xyzVectors.
|
friend |
Center of 4 xyzVectors: Return via argument (slightly faster)
|
friend |
Cross product.
|
friend |
Cross product: Return via argument (slightly faster)
|
friend |
Cross product.
|
friend |
Cross product: Return via argument (slightly faster)
|
friend |
Divide: xyzVector / Value.
|
friend |
Dot product.
|
friend |
Dot product.
|
friend |
Equal length?
|
friend |
Inner product ( == dot product )
|
friend |
xyzVector with max coordinates of two xyzVectors
|
friend |
Midpoint of 2 xyzVectors.
|
friend |
Midpoint of 2 xyzVectors: Return via argument (slightly faster)
|
friend |
xyzVector with min coordinates of two xyzVectors
|
friend |
Multiply: Value * xyzVector.
|
friend |
Multiply: xyzVector * Value.
Value != xyzVector.
xyzVector != Value
Value * xyzVector.
|
friend |
xyzVector * Value
Value + xyzVector.
xyzVector + Value
Value - xyzVector.
xyzVector - Value
xyzVector / Value
Value < xyzVector.
xyzVector < Value
Value <= xyzVector.
xyzVector <= Value
Value == xyzVector.
xyzVector == Value
Value > xyzVector.
xyzVector > Value
Value >= xyzVector.
xyzVector >= Value
geometric center
Projection matrix onto the line through a vector
|
friend |
Rotation matrix for rotation about an axis by an angle in radians.
Referenced by numeric::EulerAngles< T >::EulerAngles().
|
friend |
Subtract: Value - xyzVector.
|
friend |
Subtract: xyzVector - Value.
|
friend |
xyzMatrix^T * xyzVector product
|
friend |
|
friend |
Referenced by change_docking_pose(), numeric::xyzVector< T >::cross(), numeric::xyzVector< T >::cross_product(), numeric::xyzVector< T >::negated(), numeric::xyzVector< T >::normalized(), numeric::xyzVector< T >::normalized_any(), numeric::xyzVector< T >::normalized_or_zero(), numeric::xyzVector< T >::operator-(), numeric::xyzVector< T >::projected_normal(), and numeric::xyzVector< T >::projected_parallel().
|
private |
Coordinates of the 3 coordinate vector.
Referenced by numeric::xyzMatrix< T >::add_diagonal(), numeric::xyzVector< T >::assign(), numeric::xyzVector< T >::clear(), numeric::xyzVector< T >::cross(), numeric::xyzVector< T >::cross_product(), numeric::xyzMatrix< T >::diag(), numeric::xyzVector< T >::distance(), numeric::xyzVector< T >::distance_squared(), numeric::xyzVector< T >::dot(), numeric::xyzVector< T >::dot_product(), numeric::xyzVector< T >::inner_product(), numeric::xyzVector< T >::is_finite(), numeric::xyzVector< T >::is_zero(), numeric::xyzVector< T >::length(), numeric::xyzVector< T >::length_squared(), numeric::xyzVector< T >::magnitude(), numeric::xyzVector< T >::magnitude_squared(), numeric::xyzVector< T >::max(), numeric::xyzVector< T >::maximum_value(), numeric::xyzVector< T >::min(), numeric::xyzVector< T >::minimum_value(), numeric::xyzVector< T >::negate(), numeric::xyzVector< T >::negated(), numeric::xyzVector< T >::norm(), numeric::xyzVector< T >::norm_squared(), numeric::xyzVector< T >::normalize(), numeric::xyzVector< T >::normalize_any(), numeric::xyzVector< T >::normalize_or_zero(), numeric::xyzVector< T >::normalized(), numeric::xyzVector< T >::normalized_any(), numeric::xyzVector< T >::normalized_or_zero(), numeric::xyzVector< T >::operator()(), numeric::xyzVector< T >::operator*=(), numeric::xyzVector< T >::operator+=(), numeric::xyzVector< T >::operator-(), numeric::xyzVector< T >::operator-=(), numeric::xyzVector< T >::operator/=(), numeric::xyzVector< T >::operator=(), numeric::xyzVector< T >::operator[](), numeric::xyzVector< T >::project_normal(), numeric::xyzVector< T >::project_parallel(), numeric::xyzVector< T >::projected_normal(), numeric::xyzVector< T >::scaled_add(), numeric::xyzVector< T >::scaled_assign(), numeric::xyzVector< T >::scaled_sub(), numeric::xyzMatrix< T >::set_diagonal(), numeric::xyzMatrix< T >::subtract_diagonal(), numeric::xyzMatrix< T >::to_diag(), numeric::xyzVector< T >::to_string(), numeric::update_5way_operation(), numeric::xyzVector< T >::x(), and numeric::xyzVector< T >::zero().
|
private |
Referenced by numeric::xyzMatrix< T >::add_diagonal(), numeric::xyzVector< T >::assign(), numeric::xyzVector< T >::clear(), numeric::xyzVector< T >::cross(), numeric::xyzVector< T >::cross_product(), numeric::xyzMatrix< T >::diag(), numeric::xyzVector< T >::distance(), numeric::xyzVector< T >::distance_squared(), numeric::xyzVector< T >::dot(), numeric::xyzVector< T >::dot_product(), numeric::xyzVector< T >::inner_product(), numeric::xyzVector< T >::is_finite(), numeric::xyzVector< T >::is_zero(), numeric::xyzVector< T >::length(), numeric::xyzVector< T >::length_squared(), numeric::xyzVector< T >::magnitude(), numeric::xyzVector< T >::magnitude_squared(), numeric::xyzVector< T >::max(), numeric::xyzVector< T >::maximum_value(), numeric::xyzVector< T >::min(), numeric::xyzVector< T >::minimum_value(), numeric::xyzVector< T >::negate(), numeric::xyzVector< T >::negated(), numeric::xyzVector< T >::norm(), numeric::xyzVector< T >::norm_squared(), numeric::xyzVector< T >::normalize(), numeric::xyzVector< T >::normalize_any(), numeric::xyzVector< T >::normalize_or_zero(), numeric::xyzVector< T >::normalized(), numeric::xyzVector< T >::normalized_any(), numeric::xyzVector< T >::normalized_or_zero(), numeric::xyzVector< T >::operator()(), numeric::xyzVector< T >::operator*=(), numeric::xyzVector< T >::operator+=(), numeric::xyzVector< T >::operator-(), numeric::xyzVector< T >::operator-=(), numeric::xyzVector< T >::operator/=(), numeric::xyzVector< T >::operator=(), numeric::xyzVector< T >::operator[](), numeric::xyzVector< T >::project_normal(), numeric::xyzVector< T >::project_parallel(), numeric::xyzVector< T >::projected_normal(), numeric::xyzVector< T >::scaled_add(), numeric::xyzVector< T >::scaled_assign(), numeric::xyzVector< T >::scaled_sub(), numeric::xyzMatrix< T >::set_diagonal(), numeric::xyzMatrix< T >::subtract_diagonal(), numeric::xyzMatrix< T >::to_diag(), numeric::xyzVector< T >::to_string(), numeric::update_5way_operation(), numeric::xyzVector< T >::y(), and numeric::xyzVector< T >::zero().
|
private |
Referenced by numeric::xyzMatrix< T >::add_diagonal(), numeric::xyzVector< T >::assign(), numeric::xyzVector< T >::clear(), numeric::xyzVector< T >::cross(), numeric::xyzVector< T >::cross_product(), numeric::xyzMatrix< T >::diag(), numeric::xyzVector< T >::distance(), numeric::xyzVector< T >::distance_squared(), numeric::xyzVector< T >::dot(), numeric::xyzVector< T >::dot_product(), numeric::xyzVector< T >::inner_product(), numeric::xyzVector< T >::is_finite(), numeric::xyzVector< T >::is_zero(), numeric::xyzVector< T >::length(), numeric::xyzVector< T >::length_squared(), numeric::xyzVector< T >::magnitude(), numeric::xyzVector< T >::magnitude_squared(), numeric::xyzVector< T >::max(), numeric::xyzVector< T >::maximum_value(), numeric::xyzVector< T >::min(), numeric::xyzVector< T >::minimum_value(), numeric::xyzVector< T >::negate(), numeric::xyzVector< T >::negated(), numeric::xyzVector< T >::norm(), numeric::xyzVector< T >::norm_squared(), numeric::xyzVector< T >::normalize(), numeric::xyzVector< T >::normalize_any(), numeric::xyzVector< T >::normalize_or_zero(), numeric::xyzVector< T >::normalized(), numeric::xyzVector< T >::normalized_any(), numeric::xyzVector< T >::normalized_or_zero(), numeric::xyzVector< T >::operator()(), numeric::xyzVector< T >::operator*=(), numeric::xyzVector< T >::operator+=(), numeric::xyzVector< T >::operator-(), numeric::xyzVector< T >::operator-=(), numeric::xyzVector< T >::operator/=(), numeric::xyzVector< T >::operator=(), numeric::xyzVector< T >::operator[](), numeric::xyzVector< T >::project_normal(), numeric::xyzVector< T >::project_parallel(), numeric::xyzVector< T >::projected_normal(), numeric::xyzVector< T >::scaled_add(), numeric::xyzVector< T >::scaled_assign(), numeric::xyzVector< T >::scaled_sub(), numeric::xyzMatrix< T >::set_diagonal(), numeric::xyzMatrix< T >::subtract_diagonal(), numeric::xyzMatrix< T >::to_diag(), numeric::xyzVector< T >::to_string(), numeric::update_5way_operation(), numeric::xyzVector< T >::z(), and numeric::xyzVector< T >::zero().