SCALE = 10000;
87asnColor->SetScale_factor(SCALE);
88asnColor->SetRed((
int) (vec[0] * SCALE));
89asnColor->SetGreen((
int) (vec[1] * SCALE));
90asnColor->SetBlue((
int) (vec[2] * SCALE));
91asnColor->SetAlpha(SCALE);
136 static const intSCALE = 10000;
1661.0 * asnColor.
GetRed() / SCALE,
1671.0 * asnColor.
GetGreen() / SCALE,
1681.0 * asnColor.
GetBlue() / SCALE
213lStyle->
white=
true;
539 case 'A':
return( 0.620 + 2.530) / (1.380 + 2.530);
540 case 'R':
return(-2.530 + 2.530) / (1.380 + 2.530);
541 case 'N':
return(-0.780 + 2.530) / (1.380 + 2.530);
542 case 'D':
return(-0.900 + 2.530) / (1.380 + 2.530);
543 case 'C':
return( 0.290 + 2.530) / (1.380 + 2.530);
544 case 'Q':
return(-0.850 + 2.530) / (1.380 + 2.530);
545 case 'E':
return(-0.740 + 2.530) / (1.380 + 2.530);
546 case 'G':
return( 0.480 + 2.530) / (1.380 + 2.530);
547 case 'H':
return(-0.400 + 2.530) / (1.380 + 2.530);
548 case 'I':
return( 1.380 + 2.530) / (1.380 + 2.530);
549 case 'L':
return( 1.060 + 2.530) / (1.380 + 2.530);
550 case 'K':
return(-1.500 + 2.530) / (1.380 + 2.530);
551 case 'M':
return( 0.640 + 2.530) / (1.380 + 2.530);
552 case 'F':
return( 1.190 + 2.530) / (1.380 + 2.530);
553 case 'P':
return( 0.120 + 2.530) / (1.380 + 2.530);
554 case 'S':
return(-0.180 + 2.530) / (1.380 + 2.530);
555 case 'T':
return(-0.050 + 2.530) / (1.380 + 2.530);
556 case 'W':
return( 0.810 + 2.530) / (1.380 + 2.530);
557 case 'Y':
return( 0.260 + 2.530) / (1.380 + 2.530);
558 case 'V':
return( 1.080 + 2.530) / (1.380 + 2.530);
566 case 'R':
case 'H':
case 'K':
return1;
567 case 'D':
case 'E':
return-1;
572 #define ATOM_NOT_DISPLAYED do { \ 573 atomStyle->style = eNotDisplayed; \ 574 return true; } while (0) 586 if(!residue || !atomStyle) {
587 ERRORMSG(
"StyleManager::GetAtomStyle() got NULL residue or atomStyle");
623generalStyle = &(settings.
solvents);
627 if((!backboneStyle && !generalStyle) || (backboneStyle && generalStyle)) {
628 ERRORMSG(
"StyleManager::GetAtomStyle() - confused about style settings");
631 if(saveBackboneStyle) *saveBackboneStyle = backboneStyle;
632 if(saveGeneralStyle) *saveGeneralStyle = generalStyle;
676 if(sidechainStyle && sidechainStyle->
isOn) {
677backboneStyle =
NULL;
678generalStyle = sidechainStyle;
690 switch(backboneStyle ? backboneStyle->
style: generalStyle->
style) {
708 ERRORMSG(
"StyleManager::GetAtomStyle() - inappropriate style for atom");
715 switch(colorStyle) {
734GetAlignmentColor(molecule->
sequence, residue->
id- 1, colorStyle);
772pos = 1.0 * (residue->
id- 1) / (molecule->
NResidues() - 1);
800 object->maxTemperature !=
object->minTemperature) ?
803(
object->maxTemperature -
object->minTemperature)) :
808 doublehydrophobicity = (residue->
IsAminoAcid()) ?
818 switch(residue->
code) {
821 case 'T':
case 'U':
831 charch =
toupper((
unsigned char) residue->
code);
832 if(ch < 'A' || ch >
'Z')
846 ERRORMSG(
"StyleManager::GetAtomStyle() - inappropriate color scheme for atom");
866atomStyle->
alpha= 0.6;
870atomStyle->
alpha= 1.0;
909 ERRORMSG(
"SetBondStyleFromResidueStyle() - invalid style for bond");
915 #define BOND_NOT_DISPLAYED do { \ 916 bondStyle->end1.style = bondStyle->end2.style = eNotDisplayed; \ 917 return true; } while (0) 926 doublebondLength,
BondStyle*bondStyle)
const 932*info1 =
object->graph->GetAtomInfo(atom1),
933*info2 =
object->graph->GetAtomInfo(atom2);
939 if(!
GetAtomStyle(info1->
residue, atom1, coord1, &atomStyle1, &backboneStyle1, &generalStyle1) ||
940!
GetAtomStyle(info2->residue, atom2, coord2, &atomStyle2, &backboneStyle2, &generalStyle2))
950bondStyle->
end2.
name= info2->glName;
951bondStyle->
midCap=
false;
955 boolisSpecial =
false;
967generalStyle2 = generalStyle1;
968backboneStyle2 =
NULL;
976generalStyle1 = generalStyle2;
977backboneStyle1 =
NULL;
1005 ERRORMSG(
"StyleManager::GetBondStyle() - invalid connection style");
1019style1 = backboneStyle1->
style;
1021style1 = generalStyle1->
style;
1027style2 = backboneStyle2->
style;
1029style2 = generalStyle2->
style;
1040bondStyle->
midCap=
true;
1059bondStyle->
end2.
color= settings2.virtualDisulfideColor;
1096bondStyle->
midCap=
true;
1115&atomStyleV, &backboneStyleV, &generalStyleV) ||
1117backboneStyleV->
style!= style1 ||
1127&atomStyleV, &backboneStyleV, &generalStyleV) ||
1129backboneStyleV->
style!= style2 ||
1139 if(atomStyle1.
radius> bondLength) {
1141bondStyle->
midCap=
true;
1143 if(atomStyle2.
radius> bondLength) {
1145bondStyle->
midCap=
true;
1159 boolanyResidueVisible =
false;
1160 const Molecule*molecule =
object->graph->molecules.find(object3D.
moleculeID)->second;
1163anyResidueVisible =
true;
1167 if(!anyResidueVisible) {
1178 WARNINGMSG(
"StyleManager::GetObjectStyle() - invalid 3d-object style");
1206 ERRORMSG(
"StyleManager::GetObjectStyle() - inappropriate color scheme for 3d-object");
1270 intmoleculeID,
intresidueID)
const 1272 const Molecule*molecule =
object->graph->molecules.find(moleculeID)->second;
1280 if(!(*d)->isDisplayed)
1283ResidueMap::const_iterator residues = (*d)->residues.find(molecule->
identifier);
1284 if(residues != (*d)->residues.end() &&
1285residues->second[residueID - 1] ==
true) {
1286StyleMap::const_iterator userStyle =
userStyles.find((*d)->styleID);
1288 ERRORMSG(
"User style-id "<< (*d)->styleID <<
" not found in style dictionary!");
1290style = &(userStyle->second);
1300 const Molecule*molecule =
object->graph->molecules.find(moleculeID)->second;
1304 if(!(*d)->isDisplayed)
1307ResidueMap::const_iterator residues = (*d)->residues.find(molecule->
identifier);
1308 if(residues != (*d)->residues.end())
1317 const Molecule*molecule =
object->graph->molecules.find(moleculeID)->second;
1321 if(!(*d)->isDisplayed)
1324ResidueMap::const_iterator residues = (*d)->residues.find(molecule->
identifier);
1325 if(residues != (*d)->residues.end() && residues->second[residueID - 1] ==
true)
1334 static const Vectorblack(0,0,0);
1336 if(!molecule || !molecule->
GetParentOfType(&
object))
returnblack;
1343 return(dialog.ShowModal() == wxOK);
1354 typedeflist < int > IntList;
1356StyleMap::const_iterator s, se =
userStyles.end();
1357 for(s=
userStyles.begin(); s!=se; ++s) keys.push_back(s->first);
1361IntList::const_iterator
i, ie = keys.end();
1362 for(
i=keys.begin();
i!=ie; ++
i) {
1364entry->SetId().Set(*
i);
1365 if(!
userStyles.find(*i)->second.SaveSettingsToASN(&(entry->SetStyle())))
return NULL;
1366dictionary->SetStyle_table().push_back(entry);
1370 returndictionary.release();
1379CCn3d_style_dictionary::TStyle_table::const_iterator
t, te = styleDictionary.
GetStyle_table().end();
1381 int id= (*t)->GetId().Get();
1383 ERRORMSG(
"repeated style table id in style dictionary");
1386 if(!
userStyles[
id].LoadSettingsFromASN((*t)->GetStyle()))
return false;
1402 static const int max= 10000;
1403 for(
int i=1;
i<
max; ++
i) {
1416StyleMap::iterator u =
userStyles.find(
id);
1437 intremovedStyleID = -1;
1439 if(annotation == u->GetPointer()) {
1444removedStyleID = (*u)->styleID;
1449 if(u == ue)
return false;
1453 if((*u)->styleID == removedStyleID)
1467 if(annotation ==
a->GetPointer())
1491 if(annotation == d->GetPointer())
1496UserAnnotationList::iterator
swap;
1497 booldoSwap =
false;
1502}
else if(!moveUp) {
1527residuesASN->clear();
1529StyleManager::ResidueMap::const_iterator
r, re = residueMap.end();
1530 for(
r=residueMap.begin();
r!=re; ++
r) {
1533CCn3d_user_annotation::TResidues::iterator
l,
le= residuesASN->end();
1534 for(
l=residuesASN->begin();
l!=
le; ++
l)
1535 if((*l)->GetStructure_id().GetMmdb_id().Get() ==
r->first->mmdbID)
break;
1542mmdbID->
Set(
r->first->mmdbID);
1543loc->SetStructure_id().SetMmdb_id(*mmdbID);
1545 ERRORMSG(
"CreateObjectLocation() - MoleculeIdentifier must (currently) have MMDB ID");
1548residuesASN->push_back(loc);
1549 l= residuesASN->end();
1555molecule->SetMolecule_id().Set(
r->first->moleculeID);
1556(*l)->SetResidues().push_back(molecule);
1560 for(
i=0;
i<
r->second.size(); ++
i)
1561 if(!
r->second[
i])
break;
1564 if(
i!=
r->second.size()) {
1566 while(first < r->second.size()) {
1568 while(first < r->second.size() && !
r->second[
first]) ++
first;
1569 if(
first>=
r->second.size())
break;
1572 while(
last+ 1 <
r->second.size() &&
r->second[
last+ 1]) ++
last;
1574range->SetFrom().Set(
first+ 1);
1575range->SetTo().Set(
last+ 1);
1576molecule->SetResidues().push_back(range);
1579 if(molecule->GetResidues().size() == 0) {
1580 ERRORMSG(
"CreateObjectLocation() - no residue ranges found");
1591 if(!annotations)
return false;
1592annotations->ResetAnnotations();
1600annotation->SetName((*a)->name);
1601annotation->SetDescription((*a)->description);
1602annotation->SetStyle_id().Set((*a)->styleID);
1603annotation->SetIs_on((*a)->isDisplayed);
1607 ERRORMSG(
"StyleManager::CreateASNUserAnnotations() - error creating object location");
1611annotations->SetAnnotations().push_back(annotation);
1621CCn3d_user_annotation::TResidues::const_iterator o, oe = residuesASN.end();
1622 for(o=residuesASN.begin(); o!=oe; ++o) {
1624 if((*o)->GetStructure_id().IsMmdb_id()) {
1625mmdbID = (*o)->GetStructure_id().GetMmdb_id().Get();
1627 ERRORMSG(
"ExtractObjectLocation() - can't handle non-MMDB identifiers (yet)");
1632CCn3d_object_location::TResidues::const_iterator m, me = (*o)->GetResidues().end();
1633 for(m=(*o)->GetResidues().begin(); m!=me; ++m) {
1634 intmoleculeID = (*m)->GetMolecule_id().Get();
1639 WARNINGMSG(
"ExtractObjectLocation() - can't find identifier for molecule location");
1640 WARNINGMSG(
"structure MMDB ID "<< mmdbID <<
" not loaded?");
1645vector < bool >& residueFlags = (*residueMap)[identifier];
1646 if(residueFlags.size() == 0)
1647residueFlags.resize(identifier->
nResidues,
false);
1649 if((*m)->IsSetResidues()) {
1651CCn3d_molecule_location::TResidues::const_iterator
r, re = (*m)->GetResidues().end();
1652 for(
r=(*m)->GetResidues().begin();
r!=re; ++
r) {
1653 for(
int i=(*r)->GetFrom().Get();
i<=(*r)->GetTo().Get(); ++
i) {
1654 if(
i> 0 &&
i<= (
int)residueFlags.size()) {
1655residueFlags[
i- 1] =
true;
1657 ERRORMSG(
"ExtractObjectLocation() - residue from/to out of range");
1664 for(
unsigned int i=0;
i<residueFlags.size(); ++
i) residueFlags[
i] =
true;
1673 if(!annotations.IsSetAnnotations())
return true;
1675CCn3d_user_annotations::TAnnotations::const_iterator
a, ae = annotations.GetAnnotations().end();
1676 for(
a=annotations.GetAnnotations().begin();
a!=ae; ++
a) {
1680userAnnot->
name= (*a)->GetName();
1681 if((*a)->IsSetDescription())
1683userAnnot->
styleID= (*a)->GetStyle_id().Get();
User-defined methods of the data storage class.
User-defined methods of the data storage class.
User-defined methods of the data storage class.
User-defined methods of the data storage class.
User-defined methods of the data storage class.
User-defined methods of the data storage class.
User-defined methods of the data storage class.
User-defined methods of the data storage class.
User-defined methods of the data storage class.
User-defined methods of the data storage class.
User-defined methods of the data storage class.
User-defined methods of the data storage class.
User-defined methods of the data storage class.
User-defined methods of the data storage class.
const BlockMultipleAlignment * GetCurrentMultipleAlignment(void) const
bool IsAligned(const Sequence *sequence, unsigned int seqIndex) const
double averageTemperature
static const double NO_TEMPERATURE
const AtomCoord * GetAtom(const AtomPntr &atom, bool getAny=false, bool suppressWarning=false) const
StyleManager::eDisplayStyle style
unsigned int GetAlignmentIndex(unsigned int row, unsigned int seqIndex, eUnalignedJustification justification)
int GetRowForSequence(const Sequence *sequence) const
double GetRelativeAlignmentFraction(unsigned int alignmentIndex) const
const Bond * previousVirtual
CCn3d_backbone_label_style â.
CCn3d_backbone_style â.
CCn3d_molecule_location â.
CCn3d_object_location â.
CCn3d_style_dictionary â.
CCn3d_style_settings â.
CCn3d_style_table_item â.
CCn3d_user_annotation â.
const Residue::AtomInfo * GetAtomInfo(const AtomPntr &atom) const
const Vector & Get(eColor which) const
double arrowTipWidthProportion
bool IsHighlighted(const Molecule *molecule, int residueID) const
void PostRedrawAllStructures(void)
void PostRedrawAllSequenceViewers(void)
static const int VALUE_NOT_SET
static const MoleculeIdentifier * FindIdentifier(int mmdbID, int moleculeID)
bool IsResidueInHelix(int residueID) const
std::vector< int > residueDomains
static const int NO_DOMAIN_SET
const MoleculeIdentifier * identifier
const Sequence * sequence
bool IsResidueInStrand(int residueID) const
unsigned int NResidues(void) const
bool IsSolvent(void) const
double arrowBaseWidthProportion
StyleManager::eDisplayStyle style
const Element * GetElement(int Z) const
bool IsNucleotide(void) const
const AtomInfo * GetAtomInfo(int aID) const
bool IsAminoAcid(void) const
int NAtomsInGraph(void) const
bool OverlayConfEnsembles(void) const
bool IsHidden(const StructureBase *entity) const
bool IsVisible(const StructureBase *entity) const
bool GetParentOfType(const T **ptr, bool warnIfNotFound=true) const
const ChemicalGraph * graph
AlignmentManager * alignmentManager
ShowHideManager * showHideManager
static const unsigned int eStyleData
void SetDataChanged(unsigned int what) const
bool LoadFromASNStyleDictionary(const ncbi::objects::CCn3d_style_dictionary &styleDictionary)
bool GetStrandStyle(const StructureObject *object, const Strand3D &strand, StrandStyle *strandStyle) const
void SetGlobalRenderingStyle(StyleSettings::ePredefinedRenderingStyle style)
bool CheckStyleSettings(StyleSettings *settings)
const StyleSettings & GetStyleForResidue(const StructureObject *object, int moleculeID, int residueID) const
UserAnnotation * AddUserAnnotation(void)
std::map< const MoleculeIdentifier *, std::vector< bool > > ResidueMap
bool RemoveUserStyle(int id)
bool DisplayUserAnnotation(UserAnnotation *annotation, bool display)
const StructureSet * structureSet
ncbi::objects::CCn3d_style_dictionary * CreateASNStyleDictionary(void) const
bool MoleculeHasUserStyle(const StructureObject *object, int moleculeID) const
bool GetObjectStyle(const StructureObject *object, const Object3D &object3D, const StyleSettings::GeneralStyle &generalStyle, ObjectStyle *objectStyle) const
bool GetAtomStyle(const Residue *residue, const AtomPntr &atom, const AtomCoord *coord, AtomStyle *atomStyle, const StyleSettings::BackboneStyle **saveBackboneStyle=NULL, const StyleSettings::GeneralStyle **saveGeneralStyle=NULL) const
bool GetHelixStyle(const StructureObject *object, const Helix3D &helix, HelixStyle *helixStyle) const
bool RemoveUserAnnotation(UserAnnotation *annotation)
bool GetBondStyle(const Bond *bond, const AtomPntr &atom1, const AtomCoord *coord1, const AtomPntr &atom2, const AtomCoord *coord2, double bondLength, BondStyle *bondStyle) const
bool AddUserStyle(int *id, StyleSettings **newStyle)
bool SaveToASNUserAnnotations(ncbi::objects::CCn3d_user_annotations *annotations) const
bool SetGlobalStyle(const ncbi::objects::CCn3d_style_settings &styleASN)
StyleSettings globalStyle
bool EditUserAnnotations(wxWindow *parent)
bool ResidueHasUserStyle(const StructureObject *object, int moleculeID, int residueID) const
const Vector & GetObjectColor(const Molecule *molecule) const
bool EditGlobalStyle(wxWindow *parent)
bool LoadFromASNUserAnnotations(const ncbi::objects::CCn3d_user_annotations &annotations)
StyleManager(const StructureSet *set)
bool MoveUserAnnotation(UserAnnotation *annotation, bool moveUp)
UserAnnotationList userAnnotations
bool CheckGlobalStyleSettings(void)
void SetGlobalColorScheme(StyleSettings::ePredefinedColorScheme scheme)
LabelStyle nucleotideLabels
GeneralStyle helixObjects
@ eWeightedVarietyShortcut
@ eInformationContentShortcut
@ eHydrophobicityShortcut
@ eSecondaryStructureShortcut
bool SaveSettingsToASN(ncbi::objects::CCn3d_style_settings *styleASN) const
GeneralStyle proteinSidechains
BackboneStyle nucleotideBackbone
bool LoadSettingsFromASN(const ncbi::objects::CCn3d_style_settings &styleASN)
GeneralStyle nucleotideSidechains
double spaceFillProportion
void SetDefaultLabeling(void)
void SetRenderingStyle(ePredefinedRenderingStyle style)
ePredefinedRenderingStyle
@ eToggleSidechainsShortcut
GeneralStyle strandObjects
BackboneStyle proteinBackbone
void SetColorScheme(ePredefinedColorScheme scheme)
StyleSettings & operator=(const StyleSettings &v)
Vector virtualDisulfideColor
void Set(double xs, double ys, double zs)
const Colors * GlobalColors(void)
Include a standard set of the NCBI C++ Toolkit most basic headers.
static DLIST_TYPE *DLIST_NAME() first(DLIST_LIST_TYPE *list)
static DLIST_TYPE *DLIST_NAME() last(DLIST_LIST_TYPE *list)
void swap(NCBI_NS_NCBI::pair_base_member< T1, T2 > &pair1, NCBI_NS_NCBI::pair_base_member< T1, T2 > &pair2)
#define END_SCOPE(ns)
End the previously defined scope.
#define BEGIN_SCOPE(ns)
Define a new scope.
void SetBall_radius(TBall_radius value)
Assign a value to Ball_radius data member.
TColor_scheme GetColor_scheme(void) const
Get the Color_scheme member data.
THydrogens_on GetHydrogens_on(void) const
Get the Hydrogens_on member data.
TIs_on GetIs_on(void) const
Get the Is_on member data.
const TNucleotide_backbone & GetNucleotide_backbone(void) const
Get the Nucleotide_backbone member data.
void SetStyle(TStyle value)
Assign a value to Style data member.
void SetBackground_color(TBackground_color &value)
Assign a value to Background_color data member.
ECn3d_drawing_style
atom/bond/object rendering styles for atoms and bonds
const TConnections & GetConnections(void) const
Get the Connections member data.
const TNucleotide_labels & GetNucleotide_labels(void) const
Get the Nucleotide_labels member data.
void SetScale_factor(TScale_factor value)
Assign a value to Scale_factor data member.
const TNucleotide_sidechains & GetNucleotide_sidechains(void) const
Get the Nucleotide_sidechains member data.
TWhite GetWhite(void) const
Get the White member data.
void SetStrand_width(TStrand_width value)
Assign a value to Strand_width data member.
void SetSpace_fill_proportion(TSpace_fill_proportion value)
Assign a value to Space_fill_proportion data member.
void SetStick_radius(TStick_radius value)
Assign a value to Stick_radius data member.
void SetNucleotide_labels(TNucleotide_labels &value)
Assign a value to Nucleotide_labels data member.
void SetUser_color(TUser_color &value)
Assign a value to User_color data member.
TNumber GetNumber(void) const
Get the Number member data.
void SetHeterogens(THeterogens &value)
Assign a value to Heterogens data member.
const TProtein_backbone & GetProtein_backbone(void) const
Get the Protein_backbone member data.
TGreen GetGreen(void) const
Get the Green member data.
list< CRef< CCn3d_object_location > > TResidues
TType GetType(void) const
Get the Type member data.
const TVirtual_disulfide_color & GetVirtual_disulfide_color(void) const
Get the Virtual_disulfide_color member data.
ECn3d_color_scheme
available color schemes (not all necessarily applicable to all objects)
const TSolvents & GetSolvents(void) const
Get the Solvents member data.
TType GetType(void) const
Get the Type member data.
TTermini GetTermini(void) const
Get the Termini member data.
void SetWhite(TWhite value)
Assign a value to White data member.
void SetTermini(TTermini value)
Assign a value to Termini data member.
TRed GetRed(void) const
Get the Red member data.
TStyle GetStyle(void) const
Get the Style member data.
void SetSolvents(TSolvents &value)
Assign a value to Solvents data member.
const TUser_color & GetUser_color(void) const
Get the User_color member data.
void SetProtein_sidechains(TProtein_sidechains &value)
Assign a value to Protein_sidechains data member.
void SetColor_scheme(TColor_scheme value)
Assign a value to Color_scheme data member.
TStyle GetStyle(void) const
Get the Style member data.
void SetType(TType value)
Assign a value to Type data member.
const TUser_color & GetUser_color(void) const
Get the User_color member data.
const TProtein_labels & GetProtein_labels(void) const
Get the Protein_labels member data.
void SetNucleotide_backbone(TNucleotide_backbone &value)
Assign a value to Nucleotide_backbone data member.
TIon_labels GetIon_labels(void) const
Get the Ion_labels member data.
const THeterogens & GetHeterogens(void) const
Get the Heterogens member data.
const THelix_objects & GetHelix_objects(void) const
Get the Helix_objects member data.
TStrand_width GetStrand_width(void) const
Get the Strand_width member data.
void SetVirtual_disulfides_on(TVirtual_disulfides_on value)
Assign a value to Virtual_disulfides_on data member.
ECn3d_backbone_type
values of enumerations must match those in cn3d/style_manager.hpp! for different types of backbones
TTube_worm_radius GetTube_worm_radius(void) const
Get the Tube_worm_radius member data.
void SetVirtual_disulfide_color(TVirtual_disulfide_color &value)
Assign a value to Virtual_disulfide_color data member.
void SetHelix_objects(THelix_objects &value)
Assign a value to Helix_objects data member.
TBlue GetBlue(void) const
Get the Blue member data.
bool IsSetNucleotide_labels(void) const
Check if a value has been assigned to Nucleotide_labels data member.
void SetTube_worm_radius(TTube_worm_radius value)
Assign a value to Tube_worm_radius data member.
TStick_radius GetStick_radius(void) const
Get the Stick_radius member data.
bool IsSetProtein_labels(void) const
backbone labels (no labels if not present) Check if a value has been assigned to Protein_labels data ...
const TStyle_table & GetStyle_table(void) const
Get the Style_table member data.
TTube_radius GetTube_radius(void) const
Get the Tube_radius member data.
void SetColor_scheme(TColor_scheme value)
Assign a value to Color_scheme data member.
void SetProtein_backbone(TProtein_backbone &value)
Assign a value to Protein_backbone data member.
void SetConnections(TConnections &value)
Assign a value to Connections data member.
void SetNucleotide_sidechains(TNucleotide_sidechains &value)
Assign a value to Nucleotide_sidechains data member.
void SetHydrogens_on(THydrogens_on value)
Assign a value to Hydrogens_on data member.
TColor_scheme GetColor_scheme(void) const
Get the Color_scheme member data.
void SetNumber(TNumber value)
Assign a value to Number data member.
void SetType(TType value)
Assign a value to Type data member.
bool IsSetStyle_table(void) const
Check if a value has been assigned to Style_table data member.
void SetProtein_labels(TProtein_labels &value)
Assign a value to Protein_labels data member.
TSpace_fill_proportion GetSpace_fill_proportion(void) const
Get the Space_fill_proportion member data.
bool IsSetIon_labels(void) const
ion labels Check if a value has been assigned to Ion_labels data member.
const TBackground_color & GetBackground_color(void) const
Get the Background_color member data.
void SetStyle(TStyle value)
Assign a value to Style data member.
TVirtual_disulfides_on GetVirtual_disulfides_on(void) const
Get the Virtual_disulfides_on member data.
THelix_radius GetHelix_radius(void) const
Get the Helix_radius member data.
TStrand_thickness GetStrand_thickness(void) const
Get the Strand_thickness member data.
const TStrand_objects & GetStrand_objects(void) const
Get the Strand_objects member data.
void SetSpacing(TSpacing value)
Assign a value to Spacing data member.
void SetTube_radius(TTube_radius value)
Assign a value to Tube_radius data member.
TSpacing GetSpacing(void) const
Get the Spacing member data.
void SetHelix_radius(THelix_radius value)
Assign a value to Helix_radius data member.
TScale_factor GetScale_factor(void) const
Get the Scale_factor member data.
void SetStrand_objects(TStrand_objects &value)
Assign a value to Strand_objects data member.
void SetIon_labels(TIon_labels value)
Assign a value to Ion_labels data member.
void SetIs_on(TIs_on value)
Assign a value to Is_on data member.
void SetStrand_thickness(TStrand_thickness value)
Assign a value to Strand_thickness data member.
TScale_factor GetScale_factor(void) const
Get the Scale_factor member data.
const TProtein_sidechains & GetProtein_sidechains(void) const
Get the Protein_sidechains member data.
const TGlobal_style & GetGlobal_style(void) const
Get the Global_style member data.
void SetUser_color(TUser_color &value)
Assign a value to User_color data member.
where boath are integers</td > n< td ></td > n</tr > n< tr > n< td > tse</td > n< td > optional</td > n< td > String</td > n< td class=\"description\"> TSE option controls what blob is orig
Messenger * GlobalMessenger(void)
Portable reference counted smart and weak pointers using CWeakRef, CRef, CObject and CObjectEx.
bool le(T x_, T y_, T round_)
double r(size_t dimension_, const Int4 *score_, const double *prob_, double theta_)
PeriodicTableClass PeriodicTable
bool IsMetal(int atomicNumber)
static SLJIT_INLINE sljit_ins l(sljit_gpr r, sljit_s32 d, sljit_gpr x, sljit_gpr b)
StyleManager::eDisplayStyle style
eAtomClassification classification
static bool SaveLabelStyleToASN(const StyleSettings::LabelStyle lSettings, CCn3d_backbone_label_style *lASN)
static bool ExtractObjectLocation(StyleManager::ResidueMap *residueMap, const CCn3d_user_annotation::TResidues &residuesASN)
double GetHydrophobicity(char code)
const double UNKNOWN_HYDROPHOBICITY
static bool LoadBackboneStyleFromASN(const CCn3d_backbone_style &bbASN, StyleSettings::BackboneStyle *bbSettings)
static bool LoadGeneralStyleFromASN(const CCn3d_general_style &gASN, StyleSettings::GeneralStyle *gSettings)
static bool SetBondStyleFromResidueStyle(StyleSettings::eDrawingStyle style, const StyleSettings &settings, BondStyle::EndStyle *end)
static bool CreateObjectLocation(CCn3d_user_annotation::TResidues *residuesASN, const StyleManager::ResidueMap &residueMap)
#define ATOM_NOT_DISPLAYED
static void Vector2ASNColor(const Vector &vec, CCn3d_color *asnColor)
#define BOND_NOT_DISPLAYED
static bool SaveGeneralStyleToASN(const StyleSettings::GeneralStyle gSettings, CCn3d_general_style *gASN)
static bool LoadLabelStyleFromASN(const CCn3d_backbone_label_style &lASN, StyleSettings::LabelStyle *lSettings)
static void ASNColor2Vector(const CCn3d_color &asnColor, Vector *vec)
static bool SaveBackboneStyleToASN(const StyleSettings::BackboneStyle bbSettings, CCn3d_backbone_style *bbASN)
static void SetDefaultLabelStyle(StyleSettings::LabelStyle *lStyle)
RetroSearch is an open source project built by @garambo | Open a GitHub Issue
Search and Browse the WWW like it's 1997 | Search results from DuckDuckGo
HTML:
3.2
| Encoding:
UTF-8
| Version:
0.7.4