|
SNAP Library, Developer Reference
2012-10-15 15:06:59
SNAP, a general purpose network analysis and graph mining library
|

Go to the source code of this file.
Classes | |
| class | TMath |
| class | TSpecFunc |
| class | TStatTest |
| class | THist |
Typedefs | |
| typedef TVVec< PMom > | TMomVV |
| typedef THash< TInt, PMom > | TIntMomH |
| typedef THash< TInt, TMomV > | TIntMomVH |
| typedef THash< TInt, TMomVV > | TIntMomVVH |
Functions | |
| TMom () | |
| TMom (const TMom &Mom) | |
| static PMom | New () |
| static void | NewV (TMomV &MomV, const int &Moms) |
| static void | NewVV (TVVec< PMom > &MomVV, const int &XMoms, const int &YMoms) |
| TMom (const TFltV &_ValV) | |
| static PMom | New (const TFltV &ValV) |
| TMom (TSIn &SIn) | |
| static PMom | Load (TSIn &SIn) |
| void | Save (TSOut &SOut) const |
| TMom & | operator= (const TMom &Mom) |
| bool | operator== (const TMom &Mom) const |
| bool | operator< (const TMom &Mom) const |
| void | Def () |
| static void | DefV (TMomV &MomV) |
| static void | DefVV (TVVec< PMom > &MomVV) |
| bool | IsDef () const |
| void | Add (const TFlt &Val, const TFlt &Wgt=1) |
| double | GetWgt () const |
| int | GetVals () const |
| TFlt | GetVal (const int &ValN) const |
| bool | IsUsable () const |
| static bool | IsUsableV (const TMomV &MomV) |
| static bool | IsUsableVV (const TVVec< PMom > &MomVV) |
| double | GetMn () const |
| double | GetMx () const |
| double | GetExtent () const |
| double | GetMean () const |
| double | GetVari () const |
| double | GetSDev () const |
| double | GetSErr () const |
| double | GetMedian () const |
| double | GetQuart1 () const |
| double | GetQuart3 () const |
| double | GetDecile (const int &DecileN) const |
| double | GetPercentile (const int &PercentileN) const |
| double | GetByNm (const TStr &MomNm) const |
| TStr | GetStrByNm (const TStr &MomNm, char *FmtStr=NULL) const |
| TStr | GetStr (const char &SepCh=' ', const char &DelimCh=':', const bool &DecileP=true, const bool &PercentileP=true, const TStr &FmtStr="%g") const |
| static TStr | GetNmVStr (const TStr &VarPfx, const char &SepCh='\t', const bool &DecileP=true, const bool &PercentileP=true) |
| TStr | GetValVStr (const char &SepCh='\t', const bool &DecileP=true, const bool &PercentileP=true) const |
| TCorr () | |
| TCorr (const TFltV &ValV1, const TFltV &ValV2) | |
| static PCorr | New (const TFltV &ValV1, const TFltV &ValV2) |
| TCorr (TSIn &) | |
| TCorr & | operator= (const TCorr &) |
| double | GetCorrCf () const |
| double | GetCorrCfPrb () const |
| TStr | GetStr () const |
| TComb () | |
| TComb (const int &_Items, const int &_Order) | |
| static PComb | New (const int &Items, const int &Order) |
| ~TComb () | |
| TComb (TSIn &) | |
| TComb & | operator= (const TComb &) |
| bool | GetNext () |
| TIntV & | GetItemV () |
| int | GetCombN () const |
| int | GetCombs () const |
| void | Wr () |
| void | GetXV (const int RecN, TFltV &VarV) const |
| double | GetY (const int RecN) const |
| double | GetSig (const int RecN) const |
| void | NR_covsrt (TFltVV &CovarVV, const int &Vars, const TIntV &ia, const int &mfit) |
| void | NR_gaussj (TFltVV &a, const int &n, TFltVV &b, const int &m) |
| void | NR_lfit () |
| TLinReg () | |
| static PLinReg | New (const TFltVV &XVV, const TFltV &YV, const TFltV &SigV=TFltV()) |
| ~TLinReg () | |
| TLinReg (TSIn &) | |
| TLinReg & | operator= (const TLinReg &) |
| int | GetRecs () const |
| int | GetVars () const |
| double | GetCf (const int &VarN) const |
| double | GetCfUncer (const int &VarN) const |
| double | GetCovar (const int &VarN1, const int &VarN2) const |
| double | GetChiSq () const |
| static double | LinInterp (const double &x1, const double &y1, const double &x2, const double &y2, const double &AtX) _CMPWARN |
| static double | NR_SIGN (double a, double b) |
| static double | NR_FMAX (double maxarg1, double maxarg2) |
| static int | NR_IMIN (int iminarg1, int iminarg2) |
| static double | NR_pythag (double a, double b) |
| static void | NR_svdcmp (TFltVV &a, int m, int n, TFltV &w, TFltVV &v) |
| void | NR_svbksb (TFltVV &u, TFltV &w, TFltVV &v, int m, int n, TFltV &b, TFltV &x) |
| void | NR_svdvar (TFltVV &v, int ma, TFltV &w, TFltVV &cvm) |
| void | NR_svdfit () |
| TSvd () | |
| ~TSvd () | |
| TSvd (TSIn &) | |
| TSvd & | operator= (const TSvd &) |
| void | GetCfV (TFltV &_CfV) |
| void | GetCfUncerV (TFltV &CfUncerV) |
| static void | Svd (const TFltVV &InMtx, TFltVV &LSingV, TFltV &SingValV, TFltVV &RSingV) |
| static void | Svd1Based (const TFltVV &InMtx1, TFltVV &LSingV, TFltV &SingValV, TFltVV &RSingV) |
Variables | |
| ClassTPV(TMom, PMom, TMomV) private TFltPrV | ValWgtV |
| TFlt | SumW |
| TFlt | ValSumW |
| TInt | Vals |
| TBool | UsableP |
| TFlt | UnusableVal |
| TFlt | Mn |
| TFlt | Mx |
| TFlt | Mean |
| TFlt | Vari |
| TFlt | SDev |
| TFlt | SErr |
| TFlt | Median |
| TFlt | Quart1 |
| TFlt | Quart3 |
| TFltV | DecileV |
| TFltV | PercentileV |
| ClassTP(TCorr, PCorr) private double | CorrCf |
| double | CorrCfPrb |
| double | FisherZ |
| ClassTP(TComb, PComb) public int | Order |
| int | CombN |
| TIntV | ItemV |
| ClassTP(TLinReg, PLinReg) public TFltV | YV |
| TFltV | SigV |
| int | Recs |
| int | Vars |
| TFltVV | CovarVV |
| TFltV | CfV |
| double | ChiSq |
| void Def | ( | ) |
| static void DefV | ( | TMomV & | MomV | ) | [static] |
Definition at line 207 of file xmath.h.
References TVVec< TVal >::At(), TVVec< TVal >::GetXDim(), and TVVec< TVal >::GetYDim().
{
for (int XMomN=0; XMomN<MomVV.GetXDim(); XMomN++){
for (int YMomN=0; YMomN<MomVV.GetYDim(); YMomN++){
MomVV.At(XMomN, YMomN)->Def();}}}

| double TMom::GetByNm | ( | const TStr & | MomNm | ) | const |
Definition at line 404 of file xmath.cpp.
References Fail, GetDecile(), GetMean(), GetMedian(), GetQuart1(), GetQuart3(), GetSDev(), GetSErr(), and GetVari().
Referenced by GetStrByNm().
{
if (MomNm=="Mean"){return GetMean();}
else if (MomNm=="Vari"){return GetVari();}
else if (MomNm=="SDev"){return GetSDev();}
else if (MomNm=="SErr"){return GetSErr();}
else if (MomNm=="Median"){return GetMedian();}
else if (MomNm=="Quart1"){return GetQuart1();}
else if (MomNm=="Quart3"){return GetQuart3();}
else if (MomNm=="Decile0"){return GetDecile(0);}
else if (MomNm=="Decile1"){return GetDecile(1);}
else if (MomNm=="Decile2"){return GetDecile(2);}
else if (MomNm=="Decile3"){return GetDecile(3);}
else if (MomNm=="Decile4"){return GetDecile(4);}
else if (MomNm=="Decile5"){return GetDecile(5);}
else if (MomNm=="Decile6"){return GetDecile(6);}
else if (MomNm=="Decile7"){return GetDecile(7);}
else if (MomNm=="Decile8"){return GetDecile(8);}
else if (MomNm=="Decile9"){return GetDecile(9);}
else if (MomNm=="Decile10"){return GetDecile(10);}
else {Fail; return 0;}
}


| double GetCf | ( | const int & | VarN | ) | const |
| double GetCfUncer | ( | const int & | VarN | ) | const |
Definition at line 374 of file xmath.h.
References TVVec< TVal >::At(), and CovarVV.
Referenced by GetCfUncerV().


| void TSvd::GetCfUncerV | ( | TFltV & | CfUncerV | ) |
Definition at line 1213 of file xmath.cpp.
References TVec< TVal >::Gen(), GetCfUncer(), and Vars.
{
CfUncerV.Gen(Vars);
for (int VarN=0; VarN<Vars; VarN++){
CfUncerV[VarN]=GetCfUncer(VarN);
}
}

| void TSvd::GetCfV | ( | TFltV & | _CfV | ) |
| int TComb::GetCombs | ( | ) | const |
| double GetCorrCf | ( | ) | const |
| double GetCorrCfPrb | ( | ) | const |
| double GetCovar | ( | const int & | VarN1, |
| const int & | VarN2 | ||
| ) | const |
| double GetDecile | ( | const int & | DecileN | ) | const |
| double GetExtent | ( | ) | const |
| double GetMean | ( | ) | const |
| double GetMedian | ( | ) | const |
| double GetMn | ( | ) | const |
Definition at line 234 of file xmath.h.
References Assert, DefP, Mn, and UsableP.
Referenced by TStr::DelSubStr(), TChA::GetSubStr(), TStr::GetSubStr(), TQQueue< TInt >::GetSubValV(), GetValVStr(), TFltRect::Intersection(), and TSparseSVD::Lanczos().

| double GetMx | ( | ) | const |
Definition at line 235 of file xmath.h.
References Assert, DefP, Mx, and UsableP.
Referenced by TChA::CountCh(), TStr::DelSubStr(), TChA::GetSubStr(), TStr::GetSubStr(), TQQueue< TInt >::GetSubValV(), GetValVStr(), TFltRect::Intersection(), TSparseSVD::Lanczos(), TSparseSVD::Lanczos2(), TChA::SearchCh(), TStr::SearchCh(), and TStr::SearchStr().

| bool TComb::GetNext | ( | ) |
Definition at line 724 of file xmath.cpp.
References CombN, TVec< TVal >::Gen(), ItemV, TVec< TVal >::Last(), TVec< TVal >::Len(), and Order.
{
if (ItemV.Len()==0){
ItemV.Gen(Order, Order);
for (int OrderN=0; OrderN<Order; OrderN++){
ItemV[OrderN]=OrderN;}
return true;
} else {
if (ItemV.Last()==Items-1){
int OrderN=Order-1;
while ((OrderN>=0)&&(ItemV[OrderN]==Items-(Order-OrderN-1)-1)){OrderN--;}
if (OrderN<0){
return false;
} else {
ItemV[OrderN]++;
for (int SubOrderN=OrderN+1; SubOrderN<Order; SubOrderN++){
ItemV[SubOrderN]=ItemV[SubOrderN-1]+1;}
CombN++; return true;
}
} else {
ItemV.Last()++; CombN++; return true;
}
}
}

| TStr TMom::GetNmVStr | ( | const TStr & | VarPfx, |
| const char & | SepCh = '\t', |
||
| const bool & | DecileP = true, |
||
| const bool & | PercentileP = true |
||
| ) | [static] |
Definition at line 475 of file xmath.cpp.
References TInt::GetStr().
{
TChA ChA;
ChA+=VarPfx; ChA+="Vals"; ChA+=SepCh;
ChA+=VarPfx; ChA+="Min"; ChA+=SepCh;
ChA+=VarPfx; ChA+="Max"; ChA+=SepCh;
ChA+=VarPfx; ChA+="Mean"; ChA+=SepCh;
//ChA+=VarPfx; ChA+="Vari"; ChA+=SepCh;
ChA+=VarPfx; ChA+="SDev"; ChA+=SepCh;
//ChA+=VarPfx; ChA+="SErr"; ChA+=SepCh;
ChA+=VarPfx; ChA+="Quart1"; ChA+=SepCh;
ChA+=VarPfx; ChA+="Median"; ChA+=SepCh;
ChA+=VarPfx; ChA+="Quart3";
if (DecileP){
ChA+=SepCh;
for (int DecileN=0; DecileN<=10; DecileN++){
ChA+=VarPfx; ChA+="Dec"; ChA+=TInt::GetStr(DecileN);
if (DecileN<10){ChA+=SepCh;}
}
}
if (PercentileP){
ChA+=SepCh;
for (int PercentileN=0; PercentileN<=100; PercentileN++){
ChA+=VarPfx; ChA+="Per"; ChA+=TInt::GetStr(PercentileN);
if (PercentileN<100){ChA+=SepCh;}
}
}
return ChA;
}

| double GetPercentile | ( | const int & | PercentileN | ) | const |
Definition at line 246 of file xmath.h.
References Assert, DefP, PercentileV, and UsableP.
Referenced by GetValVStr().
{
Assert(DefP&&UsableP); return PercentileV[PercentileN];}

| double GetQuart1 | ( | ) | const |
| double GetQuart3 | ( | ) | const |
| double GetSDev | ( | ) | const |
| double GetSErr | ( | ) | const |
| double GetSig | ( | const int | RecN | ) | const |
| TStr GetStr | ( | const char & | SepCh = ' ', |
| const char & | DelimCh = ':', |
||
| const bool & | DecileP = true, |
||
| const bool & | PercentileP = true, |
||
| const TStr & | FmtStr = "%g" |
||
| ) | const |
Definition at line 201 of file html.h.
References EAssert, TPt< TRec >::Empty(), GetLocStr(), GetMsgStr(), IsStr(), LocStr, and Str.
{return Str;}

| TStr TMom::GetStrByNm | ( | const TStr & | MomNm, |
| char * | FmtStr = NULL |
||
| ) | const |
Definition at line 426 of file xmath.cpp.
References GetByNm(), TFlt::GetStr(), and IsUsable().
{
if (IsUsable()){
if (FmtStr==NULL){
return TFlt::GetStr(GetByNm(MomNm));
} else {
return TFlt::GetStr(GetByNm(MomNm), FmtStr);
}
} else {
return "X";
}
}

| TStr TMom::GetValVStr | ( | const char & | SepCh = '\t', |
| const bool & | DecileP = true, |
||
| const bool & | PercentileP = true |
||
| ) | const |
Definition at line 505 of file xmath.cpp.
References GetDecile(), GetMean(), GetMedian(), GetMn(), GetMx(), GetPercentile(), GetQuart1(), GetQuart3(), GetSDev(), TInt::GetStr(), TFlt::GetStr(), GetVals(), IsUsable(), and Vals.
{
TChA ChA;
if (IsUsable()){
ChA+=TInt::GetStr(GetVals()); ChA+=SepCh;
ChA+=TFlt::GetStr(GetMn()); ChA+=SepCh;
ChA+=TFlt::GetStr(GetMx()); ChA+=SepCh;
ChA+=TFlt::GetStr(GetMean()); ChA+=SepCh;
//ChA+=TFlt::GetStr(GetVari()); ChA+=SepCh;
ChA+=TFlt::GetStr(GetSDev()); ChA+=SepCh;
//ChA+=TFlt::GetStr(GetSErr()); ChA+=SepCh;
ChA+=TFlt::GetStr(GetQuart1()); ChA+=SepCh;
ChA+=TFlt::GetStr(GetMedian()); ChA+=SepCh;
ChA+=TFlt::GetStr(GetQuart3()); ChA+=SepCh;
if (DecileP){
for (int DecileN=0; DecileN<=10; DecileN++){
ChA+=TFlt::GetStr(GetDecile(DecileN)); ChA+=SepCh;
}
}
if (PercentileP){
for (int PercentileN=0; PercentileN<=100; PercentileN++){
ChA+=TFlt::GetStr(GetPercentile(PercentileN)); ChA+=SepCh;
}
}
} else {
int Vals=8;
if (DecileP){Vals+=11;}
if (PercentileP){Vals+=101;}
for (int ValN=0; ValN<Vals; ValN++){
ChA="[Unusable]";
if (ValN<Vals-1){ChA+=SepCh;}
}
}
return ChA;
}

| double GetVari | ( | ) | const |
| double GetY | ( | const int | RecN | ) | const |
| bool IsDef | ( | ) | const |
| bool IsUsable | ( | ) | const |
Definition at line 222 of file xmath.h.
References Assert, DefP, and UsableP.
Referenced by GetStrByNm(), GetValVStr(), and IsUsableV().

| static bool IsUsableV | ( | const TMomV & | MomV | ) | [static] |
Definition at line 223 of file xmath.h.
References IsUsable().
{
for (int MomN=0; MomN<MomV.Len(); MomN++){
if (!MomV[MomN]->IsUsable()){return false;}}
return true;}

| static bool IsUsableVV | ( | const TVVec< PMom > & | MomVV | ) | [static] |
Definition at line 227 of file xmath.h.
References TVVec< TVal >::At(), TVVec< TVal >::GetXDim(), and TVVec< TVal >::GetYDim().
{
for (int XMomN=0; XMomN<MomVV.GetXDim(); XMomN++){
for (int YMomN=0; YMomN<MomVV.GetYDim(); YMomN++){
if (!MomVV.At(XMomN, YMomN)->IsUsable()){return false;}}}
return true;}

| static double LinInterp | ( | const double & | x1, |
| const double & | y1, | ||
| const double & | x2, | ||
| const double & | y2, | ||
| const double & | AtX | ||
| ) | [static] |
| static PMom New | ( | ) | [static] |
| static PComb New | ( | const int & | Items, |
| const int & | Order | ||
| ) | [static] |
| static void NewV | ( | TMomV & | MomV, |
| const int & | Moms | ||
| ) | [static] |
Definition at line 158 of file xmath.h.
References New().
Referenced by TLocClustStat::PlotBestClustDens(), TLocClust::PlotCutDistr(), TLocClust::PlotPhiDistr(), and TLocClust::PlotVolDistr().
{
MomV.Gen(Moms); for (int MomN=0; MomN<Moms; MomN++){MomV[MomN]=New();}}


Definition at line 160 of file xmath.h.
References TVVec< TVal >::At(), TVVec< TVal >::Gen(), and New().
{
MomVV.Gen(XMoms, YMoms);
for (int XMomN=0; XMomN<XMoms; XMomN++){
for (int YMomN=0; YMomN<YMoms; YMomN++){
MomVV.At(XMomN, YMomN)=New();}}}

| void TLinReg::NR_covsrt | ( | TFltVV & | CovarVV, |
| const int & | Vars, | ||
| const TIntV & | ia, | ||
| const int & | mfit | ||
| ) |
Definition at line 789 of file xmath.cpp.
References TVVec< TVal >::At(), Swap(), and Vars.
Referenced by NR_lfit().
{
for (int i=mfit+1; i<=Vars; i++){
for (int j=1; j<=i; j++){
CovarVV.At(i, j)=0; CovarVV.At(j, i)=0.0;}
}
int k=mfit;
for (int j=Vars; j>=1; j--){
if (ia[j]!=0){
for (int i=1; i<=Vars; i++){Swap(CovarVV.At(i, k), CovarVV.At(i, j));}
{for (int i=1; i<=Vars; i++){Swap(CovarVV.At(k, i), CovarVV.At(j, i));}}
k--;
}
}
}


| static double NR_FMAX | ( | double | maxarg1, |
| double | maxarg2 | ||
| ) | [static] |
Definition at line 409 of file xmath.h.
Referenced by NR_svdcmp().
{
return maxarg1 > maxarg2 ? maxarg1 : maxarg2;}

| void TLinReg::NR_gaussj | ( | TFltVV & | a, |
| const int & | n, | ||
| TFltVV & | b, | ||
| const int & | m | ||
| ) |
Definition at line 805 of file xmath.cpp.
References TVVec< TVal >::At(), Swap(), and Throw().
Referenced by NR_lfit().
{
int i, icol, irow=0, j, k, l, ll;
double big, dum, pivinv;
TIntV indxc(n+1);
TIntV indxr(n+1);
TIntV ipiv(n+1);
for (j=1; j<=n; j++){ipiv[j]=0;}
for (i=1; i<=n; i++){
big=0.0;
for (j=1; j<=n; j++){
if (ipiv[j]!=1){
for (k=1; k<=n; k++){
if (ipiv[k]==0){
if (fabs(double(a.At(j, k))) >= big){
big=fabs(double(a.At(j, k)));
irow=j;
icol=k;
}
} else
if (ipiv[k]>1){
TExcept::Throw("Singular Matrix(1) in Gauss");}
}
}
}
ipiv[icol]++;
if (irow != icol){
for (l=1; l<=n; l++){Swap(a.At(irow, l), a.At(icol, l));}
for (l=1; l<=m; l++){Swap(b.At(irow, l), b.At(icol, l));}
}
indxr[i]=irow;
indxc[i]=icol;
if (a.At(icol, icol)==0.0){
TExcept::Throw("Singular Matrix(1) in Gauss");}
pivinv=1.0/a.At(icol, icol);
a.At(icol, icol)=1.0;
for (l=1; l<=n; l++){a.At(icol, l)=a.At(icol, l)*pivinv;}
for (l=1; l<=m; l++){b.At(icol, l)=b.At(icol, l)*pivinv;}
for (ll=1; ll<=n; ll++){
if (ll != icol){
dum=a.At(ll, icol);
a.At(ll, icol)=0.0;
for (l=1;l<=n;l++){a.At(ll, l)-=a.At(icol, l)*dum;}
for (l=1;l<=m;l++){b.At(ll, l)-=b.At(icol, l)*dum;}
}
}
}
for (l=n; l>=1; l--){
if (indxr[l]!=indxc[l]){
for (k=1; k<=n; k++){
Swap(a.At(k, indxr[l]), a.At(k, indxc[l]));}
}
}
}


| static int NR_IMIN | ( | int | iminarg1, |
| int | iminarg2 | ||
| ) | [static] |
Definition at line 411 of file xmath.h.
Referenced by NR_svdcmp().
{
return iminarg1 < iminarg2 ? iminarg1 : iminarg2;}

| void TLinReg::NR_lfit | ( | ) |
Definition at line 860 of file xmath.cpp.
References TVVec< TVal >::At(), CfV, ChiSq, CovarVV, GetSig(), GetXV(), GetY(), NR_covsrt(), NR_gaussj(), Recs, TMath::Sqr(), Throw(), and Vars.
{
int i,j,k,l,m,mfit=0;
double ym,wt,sum,sig2i;
TIntV ia(Vars+1); for (i=1; i<=Vars; i++){ia[i]=1;}
TFltVV beta(Vars+1, 1+1);
TFltV afunc(Vars+1);
for (j=1;j<=Vars;j++){
if (ia[j]!=0){mfit++;}}
if (mfit==0){TExcept::Throw("No parameters to be fitted in LFit");}
for (j=1; j<=mfit; j++){
for (k=1; k<=mfit; k++){CovarVV.At(j, k)=0.0;}
beta.At(j, 1)=0.0;
}
for (i=1; i<=Recs; i++){
GetXV(i, afunc); // funcs(XVV[i],afunc,Vars);
ym=GetY(i);
if (mfit<Vars){
for (j=1;j<=Vars;j++){
if (ia[j]==0){ym-=CfV[j]*afunc[j];}}
}
sig2i=1.0/TMath::Sqr(GetSig(i));
for (j=0, l=1; l<=Vars; l++){
if (ia[l]!=0){
wt=afunc[l]*sig2i;
for (j++, k=0, m=1; m<=l; m++){
if (ia[m]!=0){CovarVV.At(j, ++k)+=wt*afunc[m];}
}
beta.At(j, 1)+=ym*wt;
}
}
}
for (j=2; j<=mfit; j++){
for (k=1; k<j; k++){CovarVV.At(k, j)=CovarVV.At(j, k);}
}
NR_gaussj(CovarVV, mfit, beta, 1);
for (j=0, l=1; l<=Vars; l++){
if (ia[l]!=0){CfV[l]=beta.At(++j, 1);}
}
ChiSq=0.0;
for (i=1; i<=Recs; i++){
GetXV(i, afunc); // funcs(XVV[i],afunc,Vars);
for (sum=0.0, j=1; j<=Vars; j++){sum+=CfV[j]*afunc[j];}
ChiSq+=TMath::Sqr((GetY(i)-sum)/GetSig(i));
}
NR_covsrt(CovarVV, Vars, ia, mfit);
}

| double TSvd::NR_pythag | ( | double | a, |
| double | b | ||
| ) | [static] |
Definition at line 948 of file xmath.cpp.
References TMath::Sqr().
Referenced by NR_svdcmp().
{
double absa,absb;
absa=fabs(a);
absb=fabs(b);
if (absa > absb){
return absa*sqrt(1.0+TMath::Sqr(absb/absa));
} else {
return (absb == 0.0 ? 0.0 : absb*sqrt(1.0+TMath::Sqr(absa/absb)));
}
}


| static double NR_SIGN | ( | double | a, |
| double | b | ||
| ) | [static] |
Definition at line 408 of file xmath.h.
Referenced by NR_svdcmp().
{return b >= 0.0 ? fabs(a) : -fabs(a);}

Definition at line 1136 of file xmath.cpp.
References TVVec< TVal >::At().
Referenced by NR_svdfit().
{
int jj,j,i;
double s;
TFltV tmp(n+1);
for (j=1;j<=n;j++) {
s=0.0;
if (w[j]) {
for (i=1;i<=m;i++) s += u.At(i,j)*b[i];
s /= w[j];
}
tmp[j]=s;
}
for (j=1;j<=n;j++) {
s=0.0;
for (jj=1;jj<=n;jj++) s += v.At(j,jj)*tmp[jj];
x[j]=s;
}
}


| void TSvd::NR_svdcmp | ( | TFltVV & | a, |
| int | m, | ||
| int | n, | ||
| TFltV & | w, | ||
| TFltVV & | v | ||
| ) | [static] |
Definition at line 959 of file xmath.cpp.
References TVVec< TVal >::At(), NR_FMAX(), NR_IMIN(), NR_pythag(), NR_SIGN(), and Throw().
Referenced by NR_svdfit(), Svd(), and Svd1Based().
{
int flag,i,its,j,jj,k,l=0,nm;
double anorm,c,f,g,h,s,scale,x,y,z;
TFltV rv1(n+1);
g=scale=anorm=0.0;
for (i=1;i<=n;i++) {
l=i+1;
rv1[i]=scale*g;
g=s=scale=0.0;
if (i <= m) {
for (k=i;k<=m;k++) scale += fabs(double(a.At(k,i)));
if (scale) {
for (k=i;k<=m;k++) {
a.At(k,i) /= scale;
s += a.At(k,i)*a.At(k,i);
}
f=a.At(i,i);
g = -NR_SIGN(sqrt(s),f);
h=f*g-s;
a.At(i,i)=f-g;
for (j=l;j<=n;j++) {
for (s=0.0,k=i;k<=m;k++) s += a.At(k,i)*a(k,j);
f=s/h;
for (k=i;k<=m;k++) a.At(k,j) += f*a.At(k,i);
}
for (k=i;k<=m;k++) a.At(k,i) *= scale;
}
}
w[i]=scale *g;
g=s=scale=0.0;
if (i <= m && i != n) {
for (k=l;k<=n;k++) scale += fabs(double(a.At(i,k)));
if (scale) {
for (k=l;k<=n;k++) {
a.At(i,k) /= scale;
s += a.At(i,k)*a.At(i,k);
}
f=a.At(i,l);
g = -NR_SIGN(sqrt(s),f);
h=f*g-s;
a.At(i,l)=f-g;
for (k=l;k<=n;k++) rv1[k]=a.At(i,k)/h;
for (j=l;j<=m;j++) {
for (s=0.0,k=l;k<=n;k++) s += a.At(j,k)*a.At(i,k);
for (k=l;k<=n;k++) a.At(j,k) += s*rv1[k];
}
for (k=l;k<=n;k++) a.At(i,k) *= scale;
}
}
anorm=NR_FMAX(anorm,(fabs(double(w[i]))+fabs(double(rv1[i]))));
}
for (i=n;i>=1;i--) {
if (i < n) {
if (g) {
for (j=l;j<=n;j++)
v.At(j,i)=(a.At(i,j)/a.At(i,l))/g;
for (j=l;j<=n;j++) {
for (s=0.0,k=l;k<=n;k++) s += a.At(i,k)*v.At(k,j);
for (k=l;k<=n;k++) v.At(k,j) += s*v.At(k,i);
}
}
for (j=l;j<=n;j++) v.At(i,j)=v.At(j,i)=0.0;
}
v.At(i,i)=1.0;
g=rv1[i];
l=i;
}
for (i=NR_IMIN(m,n);i>=1;i--) {
l=i+1;
g=w[i];
for (j=l;j<=n;j++) a.At(i,j)=0.0;
if (g) {
g=1.0/g;
for (j=l;j<=n;j++) {
for (s=0.0,k=l;k<=m;k++) s += a.At(k,i)*a.At(k,j);
f=(s/a.At(i,i))*g;
for (k=i;k<=m;k++) a.At(k,j) += f*a.At(k,i);
}
for (j=i;j<=m;j++) a.At(j,i) *= g;
} else for (j=i;j<=m;j++) a.At(j,i)=0.0;
a.At(i,i)++;
}
for (k=n;k>=1;k--) {
for (its=1;its<=30;its++) {
flag=1;
for (l=k;l>=1;l--) {
nm=l-1;
if ((double)(fabs(double(rv1[l])+anorm)) == anorm) {
flag=0;
break;
}
if ((double)(fabs(double(w[nm]))+anorm) == anorm) break;
}
if (flag) {
c=0.0;
s=1.0;
for (i=l;i<=k;i++) {
f=s*rv1[i];
rv1[i]=c*rv1[i];
if ((double)(fabs(f)+anorm) == anorm) break;
g=w[i];
h=NR_pythag(f,g);
w[i]=h;
h=1.0/h;
c=g*h;
s = -f*h;
for (j=1;j<=m;j++) {
y=a.At(j,nm);
z=a.At(j,i);
a.At(j,nm)=y*c+z*s;
a.At(j,i)=z*c-y*s;
}
}
}
z=w[k];
if (l == k) {
if (z < 0.0) {
w[k] = -z;
for (j=1;j<=n;j++) v.At(j,k) = -v.At(j,k);
}
break;
}
if (its==30){
TExcept::Throw("no convergence in 30 svdcmp iterations");}
x=w[l];
nm=k-1;
y=w[nm];
g=rv1[nm];
h=rv1[k];
f=((y-z)*(y+z)+(g-h)*(g+h))/(2.0*h*y);
g=NR_pythag(f,1.0);
f=((x-z)*(x+z)+h*((y/(f+NR_SIGN(g,f)))-h))/x;
c=s=1.0;
for (j=l;j<=nm;j++) {
i=j+1;
g=rv1[i];
y=w[i];
h=s*g;
g=c*g;
z=NR_pythag(f,h);
rv1[j]=z;
c=f/z;
s=h/z;
f=x*c+g*s;
g = g*c-x*s;
h=y*s;
y *= c;
for (jj=1;jj<=n;jj++) {
x=v.At(jj,j);
z=v.At(jj,i);
v.At(jj,j)=x*c+z*s;
v.At(jj,i)=z*c-x*s;
}
z=NR_pythag(f,h);
w[j]=z;
if (z) {
z=1.0/z;
c=f*z;
s=h*z;
}
f=c*g+s*y;
x=c*y-s*g;
for (jj=1;jj<=m;jj++) {
y=a.At(jj,j);
z=a.At(jj,i);
a.At(jj,j)=y*c+z*s;
a.At(jj,i)=z*c-y*s;
}
}
rv1[l]=0.0;
rv1[k]=f;
w[k]=x;
}
}
}


| void TSvd::NR_svdfit | ( | ) |
Definition at line 1174 of file xmath.cpp.
References TVVec< TVal >::At(), CfV, ChiSq, CovarVV, TVVec< TVal >::Gen(), GetSig(), GetXV(), GetY(), NR_svbksb(), NR_svdcmp(), NR_svdvar(), Recs, and Vars.
{
int j,i;
double wmax,tmp,thresh,sum;
double TOL=1.0e-5;
TFltVV u(Recs+1, Vars+1);
TFltVV v(Vars+1, Vars+1);
TFltV w(Vars+1);
TFltV b(Recs+1);
TFltV afunc(Vars+1);
for (i=1;i<=Recs;i++) {
GetXV(i, afunc); // (*funcs)(x[i],afunc,Vars);
tmp=1.0/GetSig(i);
for (j=1;j<=Vars;j++){u.At(i,j)=afunc[j]*tmp;}
b[i]=GetY(i)*tmp;
}
NR_svdcmp(u,Recs,Vars,w,v);
wmax=0.0;
for (j=1;j<=Vars;j++){
if (w[j] > wmax){wmax=w[j];}}
thresh=TOL*wmax;
for (j=1;j<=Vars;j++){
if (double(w[j])<thresh){w[j]=0.0;}}
NR_svbksb(u,w,v,Recs,Vars,b,CfV);
ChiSq=0.0;
for (i=1;i<=Recs;i++) {
GetXV(i, afunc); // (*funcs)(x[i],afunc,Vars);
for (sum=0.0,j=1;j<=Vars;j++){sum += CfV[j]*afunc[j];}
ChiSq += (tmp=(GetY(i)-sum)/GetSig(i),tmp*tmp);
}
// covariance matrix calculation
CovarVV.Gen(Vars+1, Vars+1);
NR_svdvar(v, Vars, w, CovarVV);
}

| void TSvd::NR_svdvar | ( | TFltVV & | v, |
| int | ma, | ||
| TFltV & | w, | ||
| TFltVV & | cvm | ||
| ) |
Definition at line 1157 of file xmath.cpp.
References TVVec< TVal >::At().
Referenced by NR_svdfit().
{
int k,j,i;
double sum;
TFltV wti(ma+1);
for (i=1;i<=ma;i++) {
wti[i]=0.0;
if (w[i]) wti[i]=1.0/(w[i]*w[i]);
}
for (i=1;i<=ma;i++) {
for (j=1;j<=i;j++) {
for (sum=0.0,k=1;k<=ma;k++) sum += v.At(i,k)*v.At(j,k)*wti[k];
cvm.At(j,i)=cvm.At(i,j)=sum;
}
}
}


| bool operator< | ( | const TMom & | Mom | ) | const |
Definition at line 188 of file xmath.h.
References Assert, DecileV, DefP, Mean, Median, Mn, TFlt::Mn, Mx, TFlt::Mx, PercentileV, Quart1, Quart3, SDev, SErr, SumW, UnusableVal, UsableP, Vals, ValSumW, ValWgtV, and Vari.
{
Assert(!DefP); DefP=Mom.DefP;
ValWgtV=Mom.ValWgtV;
SumW=Mom.SumW; ValSumW=Mom.ValSumW; Vals=Mom.Vals;
UsableP=Mom.UsableP; UnusableVal=Mom.UnusableVal;
Mn=Mom.Mn; Mx=Mom.Mx;
Mean=Mom.Mean; Vari=Mom.Vari; SDev=Mom.SDev; SErr=Mom.SErr;
Median=Mom.Median; Quart1=Mom.Quart1; Quart3=Mom.Quart3;
DecileV=Mom.DecileV; PercentileV=Mom.PercentileV;
return *this;}
| bool operator== | ( | const TMom & | Mom | ) | const |
Definition at line 178 of file xmath.h.
References B4T, DecileV, DefP, LastB4Mask, Mean, Median, Mn, Mx, PercentileV, Quart1, Quart3, TSOut::Save(), TVec< TVal >::Save(), TBool::Save(), TInt::Save(), TFlt::Save(), TSOut::SaveBf(), SDev, SErr, SumW, UnusableVal, UsableP, Vals, ValSumW, ValWgtV, and Vari.
{
DefP.Save(SOut);
ValWgtV.Save(SOut);
SumW.Save(SOut); ValSumW.Save(SOut); Vals.Save(SOut);
UsableP.Save(SOut); UnusableVal.Save(SOut);
Mn.Save(SOut); Mx.Save(SOut);
Mean.Save(SOut); Vari.Save(SOut); SDev.Save(SOut); SErr.Save(SOut);
Median.Save(SOut); Quart1.Save(SOut); Quart3.Save(SOut);
DecileV.Save(SOut); PercentileV.Save(SOut);}

| void TSvd::Svd | ( | const TFltVV & | InMtx, |
| TFltVV & | LSingV, | ||
| TFltV & | SingValV, | ||
| TFltVV & | RSingV | ||
| ) | [static] |
Definition at line 1221 of file xmath.cpp.
References TVVec< TVal >::At(), TVec< TVal >::Del(), TVVec< TVal >::DelX(), TVVec< TVal >::DelY(), TVec< TVal >::Gen(), TVVec< TVal >::Gen(), TVVec< TVal >::GetXDim(), TVVec< TVal >::GetYDim(), and NR_svdcmp().
Referenced by TGraphKey::TakeSig().
{
//LSingV = InMtx;
LSingV.Gen(InMtx.GetYDim()+1, InMtx.GetYDim()+1);
// create 1 based adjacency matrix
for (int x = 0; x < InMtx.GetXDim(); x++) {
for (int y = 0; y < InMtx.GetYDim(); y++) {
LSingV.At(x+1, y+1) = InMtx.At(x, y);
}
}
RSingV.Gen(InMtx.GetYDim()+1, InMtx.GetYDim()+1);
SingValV.Gen(InMtx.GetYDim()+1);
TSvd::NR_svdcmp(LSingV, InMtx.GetXDim(), InMtx.GetYDim(), SingValV, RSingV);
// 0-th singular value/vector is full of zeros, delete it
SingValV.Del(0);
LSingV.DelX(0); LSingV.DelY(0);
RSingV.DelX(0); RSingV.DelY(0);
}


| void TSvd::Svd1Based | ( | const TFltVV & | InMtx1, |
| TFltVV & | LSingV, | ||
| TFltV & | SingValV, | ||
| TFltVV & | RSingV | ||
| ) | [static] |
Definition at line 1241 of file xmath.cpp.
References TVec< TVal >::Del(), TVVec< TVal >::DelX(), TVVec< TVal >::DelY(), TVec< TVal >::Gen(), TVVec< TVal >::Gen(), TVVec< TVal >::GetXDim(), TVVec< TVal >::GetYDim(), and NR_svdcmp().
Referenced by TSnap::GetSngVals(), and TSnap::GetSngVec().
{
LSingV = InMtx1;
SingValV.Gen(InMtx1.GetYDim());
RSingV.Gen(InMtx1.GetYDim(), InMtx1.GetYDim());
TSvd::NR_svdcmp(LSingV, InMtx1.GetXDim()-1, InMtx1.GetYDim()-1, SingValV, RSingV);
// 0-th singular value/vector is full of zeros, delete it
SingValV.Del(0);
LSingV.DelX(0); LSingV.DelY(0);
RSingV.DelX(0); RSingV.DelY(0);
}


| TComb | ( | ) |
| TComb | ( | const int & | _Items, |
| const int & | _Order | ||
| ) |
| TCorr | ( | ) |
| TCorr::TCorr | ( | const TFltV & | ValV1, |
| const TFltV & | ValV2 | ||
| ) |
Definition at line 543 of file xmath.cpp.
References TSpecFunc::BetaI(), CorrCf, CorrCfPrb, FisherZ, IAssert, and TVec< TVal >::Len().
: ValVLen(ValV1.Len()), CorrCf(), CorrCfPrb(), FisherZ(){ static const double TINY=1.0e-20; IAssert(ValV1.Len()==ValV2.Len()); // calculate the means double MeanVal1=0; double MeanVal2=0; {for (int ValN=0; ValN<ValVLen; ValN++){ MeanVal1+=ValV1[ValN]; MeanVal2+=ValV2[ValN];}} MeanVal1/=ValVLen; MeanVal2/=ValVLen; // calculate correlation coefficient double yt, xt; double syy=0.0; double sxy=0.0; double sxx=0.0; {for (int ValN=0; ValN<ValVLen; ValN++){ xt=ValV1[ValN]-MeanVal1; yt=ValV2[ValN]-MeanVal2; sxx+=xt*xt; syy+=yt*yt; sxy+=xt*yt; }} if (sxx*syy==0){ CorrCf=0; //** not in numerical recipes - check why (pojavi se, ko so same nicle) } else { CorrCf=sxy/sqrt(sxx*syy); } // calculate correlation coefficient significance level double df=ValVLen-2; double t=CorrCf*sqrt(df/((1.0-CorrCf+TINY)*(1.0+CorrCf+TINY))); CorrCfPrb=TSpecFunc::BetaI(0.5*df,0.5,df/(df+t*t)); // calculate Fisher's Z transformation FisherZ=0.5*log((1.0+(CorrCf)+TINY)/(1.0-(CorrCf)+TINY)); }

| TMom | ( | ) |
Definition at line 141 of file xmath.h.
Referenced by TGnuPlot::AddPlot(), TGStat::AvgGStat(), TSnap::GetAnfEffDiam(), TLocClustStat::GetCurveStat(), TLocClustStat::TCutInfo::GetFracDegOut(), Load(), New(), TTimeNet::PlotEffDiam(), TTimeNENet::PlotEffDiam(), TTimeNet::PlotMedianDegOverTm(), TTimeNet::PlotMissingPast(), TGnuPlot::PlotValMomH(), TGStat::TakeDiam(), and TSnap::TestAnf().
:
DefP(false), ValWgtV(),
SumW(), ValSumW(), Vals(),
UsableP(false), UnusableVal(-1),
Mn(), Mx(),
Mean(), Vari(), SDev(), SErr(),
Median(), Quart1(), Quart3(),
DecileV(), PercentileV(){}

Definition at line 149 of file xmath.h.
:
DefP(Mom.DefP), ValWgtV(Mom.ValWgtV),
SumW(Mom.SumW), ValSumW(Mom.ValSumW), Vals(Mom.Vals),
UsableP(Mom.UsableP), UnusableVal(Mom.UnusableVal),
Mn(Mom.Mn), Mx(Mom.Mx),
Mean(Mom.Mean), Vari(Mom.Vari), SDev(Mom.SDev), SErr(Mom.SErr),
Median(Mom.Median), Quart1(Mom.Quart1), Quart3(Mom.Quart3),
DecileV(Mom.DecileV), PercentileV(Mom.PercentileV){}
| TMom::TMom | ( | const TFltV & | _ValV | ) |
Definition at line 326 of file xmath.cpp.
References Add(), Def(), and TVec< TVal >::Len().
: //WgtV(_ValV.Len(), 0), ValV(_ValV.Len(), 0), ValWgtV(_ValV.Len(), 0), SumW(), ValSumW(), UsableP(false), UnusableVal(-1), Mn(), Mx(), Mean(), Vari(), SDev(), SErr(), Median(), Quart1(), Quart3(), DecileV(), PercentileV(){ for (int ValN=0; ValN<_ValV.Len(); ValN++){Add(_ValV[ValN], 1);} Def(); }

| TSvd | ( | ) |
Definition at line 420 of file xmath.h.
Referenced by TLinAlg::InverseSVD().
{}

| void Wr | ( | ) |
| double ChiSq |
Definition at line 349 of file xmath.h.
Referenced by GetChiSq(), NR_lfit(), and NR_svdfit().
| int CombN |
Definition at line 316 of file xmath.h.
Referenced by GetCombN(), and GetNext().
Definition at line 265 of file xmath.h.
Referenced by GetCorrCf(), and TCorr().
| double CorrCfPrb |
Definition at line 269 of file xmath.h.
Referenced by GetCorrCfPrb(), and TCorr().
Definition at line 347 of file xmath.h.
Referenced by GetCfUncer(), GetCovar(), NR_lfit(), and NR_svdfit().
Definition at line 138 of file xmath.h.
Referenced by GetDecile(), operator=(), and Save().
Definition at line 136 of file xmath.h.
Referenced by GetMean(), TRnd::GetPoissonDev(), operator=(), and Save().
Definition at line 137 of file xmath.h.
Referenced by GetMedian(), operator=(), and Save().
Definition at line 135 of file xmath.h.
Referenced by TGnuPlot::AddPwrFit1(), TGnuPlot::AddPwrFit2(), TGnuPlot::AddPwrFit3(), TArtPointVisitor::BackEdge(), TBiConVisitor::BackEdge(), TLocClustStat::BagOfWhiskers(), TForestFire::BurnGeoFire(), TUndirFFire::BurnGeoFire(), TKroneckerLL::ChainGelmapRubinPlot(), TLocClust::DrawWhiskers(), TArtPointVisitor::FinishNode(), TBiConVisitor::FinishNode(), TArtPointVisitor::FwdEdge(), TSubGraphsEnum::Gen2Graphs(), TSnap::GenConfModel(), TSnap::GetBfsEffDiam(), THttpChDef::GetChTy(), TUNGraph::GetEI(), GetExtent(), TSnap::GetInvParticipRat(), THttpChDef::GetLcCh(), GetMn(), TRnd::GetNrmDev(), TSnap::GetSngVec(), TNcpGraphsBase::Impose(), THttpChDef::IsAlpha(), THttpChDef::IsCtl(), THttpChDef::IsDigit(), TTimeNet::LoadBipartite(), TTimeNENet::LoadEdgeTm(), operator=(), TSnap::PlotShortPathDistr(), Save(), THttpChDef::SetChTy(), THttpChDef::SetLcCh(), TGStat::TakeSpectral(), and THttpChDef::THttpChDef().
Definition at line 135 of file xmath.h.
Referenced by TNEGraph::AddEdge(), TNodeEdgeNet< TNodeData, TEdgeData >::AddEdge(), TUNGraph::AddNode(), TNGraph::AddNode(), TNEGraph::AddNode(), TBPGraph::AddNode(), TNodeEdgeNet< TNodeData, TEdgeData >::AddNode(), TGnuPlot::AddPwrFit1(), TGnuPlot::AddPwrFit2(), TGnuPlot::AddPwrFit3(), TKronMomentsFit::EstABC(), TLocClust::FindBestCut(), TSubGraphsEnum::Gen2Graphs(), TSnap::GetClustCf(), TSecTm::GetCurTm(), TUNGraph::GetEI(), TSnap::GetEigenVectorCentr(), GetExtent(), TSnap::GetFarnessCentr(), TSecTm::GetInUnits(), GetMx(), TRnd::GetNrmDev(), TSnap::GetSubTreeSz(), TSecTm::IsDef(), TStatTest::KsTest(), TTimeNENet::LoadEdgeTm(), TLocClustStat::MakeExpBins(), operator=(), TLocClustStat::Run(), Save(), TLocClustStat::SaveTxtInfo(), THttpChDef::THttpChDef(), TSparseRowMatrix::TSparseRowMatrix(), and TSecTm::Undef().
Definition at line 312 of file xmath.h.
Referenced by GetCombs(), TRnd::GetGammaDev(), GetNext(), and TComb().
Definition at line 139 of file xmath.h.
Referenced by GetPercentile(), operator=(), and Save().
Definition at line 137 of file xmath.h.
Referenced by GetQuart1(), operator=(), and Save().
Definition at line 137 of file xmath.h.
Referenced by GetQuart3(), operator=(), and Save().
| int Recs |
Definition at line 346 of file xmath.h.
Referenced by GetRecs(), NR_lfit(), and NR_svdfit().
Definition at line 136 of file xmath.h.
Referenced by TRnd::GetNrmDev(), GetSDev(), operator=(), and Save().
Definition at line 131 of file xmath.h.
Referenced by Add(), TLocClustStat::GetBoltzmanCurveStat(), GetWgt(), operator=(), and Save().
Definition at line 134 of file xmath.h.
Referenced by operator=(), and Save().
Definition at line 133 of file xmath.h.
Referenced by GetDecile(), GetExtent(), GetMean(), GetMedian(), GetMn(), GetMx(), GetPercentile(), GetQuart1(), GetQuart3(), GetSDev(), GetSErr(), GetVari(), IsUsable(), operator=(), and Save().
Definition at line 132 of file xmath.h.
Referenced by Add(), TVec< TVal >::AddBackSorted(), TVecPool< TVal >::AddEmptyV(), TVecPool< TVal >::AddV(), TSparseTable< TVal, GroupSize >::Clr(), TVec< TVal >::Clr(), TVecPool< TVal >::CompactPool(), TSparseTable< TVal, GroupSize >::Del(), TVec< TVal >::Del(), TStr::GetDChStr(), TVec< TVal >::GetMxValN(), TVec< TVal >::GetPrimHashCd(), TVec< TVal >::GetSecHashCd(), GetVals(), GetValVStr(), TVec< TVal >::GetXOutOfBoundsErrMsg(), TVec< TVal >::Ins(), TVec< TVal >::IsSorted(), TVec< TVal >::Load(), TPackVec< TVal >::Load(), TBigNet< TNodeData, IsDir >::LoadNodeDatH(), TVec< TVal >::MoveFrom(), PHash< TKey, TDat >::New(), PVec< TVal >::New(), operator<(), TSparseTable< TVal, GroupSize >::operator<(), TVec< TVal >::operator<(), operator=(), TSparseTable< TVal, GroupSize >::operator=(), TVec< TVal >::operator=(), TVecPool< TVal >::operator=(), operator==(), TSparseTable< TVal, GroupSize >::operator==(), TVec< TVal >::operator==(), TVec< TVal >::Pack(), TVec< TVal >::PutAll(), TVec< TVal >::Resize(), TVecPool< TVal >::Resize(), TPackVec< TVal >::ResizeDelta(), TVec< TVal >::Reverse(), Save(), TVec< TVal >::Save(), TPackVec< TVal >::Save(), TVecPool< TVal >::Save(), TGnuPlot::SaveTs(), TVec< TVal >::SaveXml(), TVec< TVal >::SearchBack(), TVec< TVal >::SearchForw(), TVec< TVal >::SearchVForw(), TSparseTable< TVal, GroupSize >::Set(), TVec< TVal >::Shuffle(), TVecPool< TVal >::ShuffleAll(), TSparseTable< TVal, GroupSize >::Swap(), TVec< TVal >::Swap(), TVec< TVal >::Trunc(), and TVec< TVal >::TVec().
| int Vars |
Definition at line 346 of file xmath.h.
Referenced by GetCfUncerV(), GetVars(), GetXV(), NR_covsrt(), NR_lfit(), and NR_svdfit().