亚洲欧美第一页_禁久久精品乱码_粉嫩av一区二区三区免费野_久草精品视频

? 歡迎來到蟲蟲下載站! | ?? 資源下載 ?? 資源專輯 ?? 關于我們
? 蟲蟲下載站

?? jama_eig.h

?? 在MATLAB環境下的level set方法的實現
?? H
?? 第 1 頁 / 共 2 頁
字號:
#ifndef JAMA_EIG_H
#define JAMA_EIG_H


#include "tnt_array1d.h"
#include "tnt_array2d.h"
#include "tnt_math_utils.h"


// using namespace TNT;


namespace JAMA
{

/** 

    Computes eigenvalues and eigenvectors of a real (non-complex)
    matrix. 
<P>
    If A is symmetric, then A = V*D*V' where the eigenvalue matrix D is
    diagonal and the eigenvector matrix V is orthogonal. That is,
	the diagonal values of D are the eigenvalues, and
    V*V' = I, where I is the identity matrix.  The columns of V 
    represent the eigenvectors in the sense that A*V = V*D.
    
<P>
    If A is not symmetric, then the eigenvalue matrix D is block diagonal
    with the real eigenvalues in 1-by-1 blocks and any complex eigenvalues,
    a + i*b, in 2-by-2 blocks, [a, b; -b, a].  That is, if the complex
    eigenvalues look like
<pre>

          u + iv     .        .          .      .    .
            .      u - iv     .          .      .    .
            .        .      a + ib       .      .    .
            .        .        .        a - ib   .    .
            .        .        .          .      x    .
            .        .        .          .      .    y
</pre>
        then D looks like
<pre>

            u        v        .          .      .    .
           -v        u        .          .      .    . 
            .        .        a          b      .    .
            .        .       -b          a      .    .
            .        .        .          .      x    .
            .        .        .          .      .    y
</pre>
    This keeps V a real matrix in both symmetric and non-symmetric
    cases, and A*V = V*D.
    
    
    
    <p>
    The matrix V may be badly
    conditioned, or even singular, so the validity of the equation
    A = V*D*inverse(V) depends upon the condition number of V.

   <p>
	(Adapted from JAMA, a Java Matrix Library, developed by jointly 
	by the Mathworks and NIST; see  http://math.nist.gov/javanumerics/jama).
**/

using TNT::abs;

template <class Real>
class Eigenvalue
{

   /** Row and column dimension (square matrix).  */
    int n;

   int issymmetric; /* boolean*/

   /** Arrays for internal storage of eigenvalues. */

   TNT::Array1D<Real> d;         /* real part */
   TNT::Array1D<Real> e;         /* img part */

   /** Array for internal storage of eigenvectors. */
    TNT::Array2D<Real> V;

   /** Array for internal storage of nonsymmetric Hessenberg form.
   @serial internal storage of nonsymmetric Hessenberg form.
   */
   TNT::Array2D<Real> H;
   

   /** Working storage for nonsymmetric algorithm.
   @serial working storage for nonsymmetric algorithm.
   */
   TNT::Array1D<Real> ort;


   // Symmetric Householder reduction to tridiagonal form.

   void tred2() {

   //  This is derived from the Algol procedures tred2 by
   //  Bowdler, Martin, Reinsch, and Wilkinson, Handbook for
   //  Auto. Comp., Vol.ii-Linear Algebra, and the corresponding
   //  Fortran subroutine in EISPACK.

      for (int j = 0; j < n; j++) {
         d[j] = V[n-1][j];
      }

      // Householder reduction to tridiagonal form.
   
      for (int i = n-1; i > 0; i--) {
   
         // Scale to avoid under/overflow.
   
         Real scale = 0.0;
         Real h = 0.0;
         for (int k = 0; k < i; k++) {
            scale = scale + abs(d[k]);
         }
         if (scale == 0.0) {
            e[i] = d[i-1];
            for (int j = 0; j < i; j++) {
               d[j] = V[i-1][j];
               V[i][j] = 0.0;
               V[j][i] = 0.0;
            }
         } else {
   
            // Generate Householder vector.
   
            for (int k = 0; k < i; k++) {
               d[k] /= scale;
               h += d[k] * d[k];
            }
            Real f = d[i-1];
            Real g = sqrt(h);
            if (f > 0) {
               g = -g;
            }
            e[i] = scale * g;
            h = h - f * g;
            d[i-1] = f - g;
            for (int j = 0; j < i; j++) {
               e[j] = 0.0;
            }
   
            // Apply similarity transformation to remaining columns.
   
            for (int j = 0; j < i; j++) {
               f = d[j];
               V[j][i] = f;
               g = e[j] + V[j][j] * f;
               for (int k = j+1; k <= i-1; k++) {
                  g += V[k][j] * d[k];
                  e[k] += V[k][j] * f;
               }
               e[j] = g;
            }
            f = 0.0;
            for (int j = 0; j < i; j++) {
               e[j] /= h;
               f += e[j] * d[j];
            }
            Real hh = f / (h + h);
            for (int j = 0; j < i; j++) {
               e[j] -= hh * d[j];
            }
            for (int j = 0; j < i; j++) {
               f = d[j];
               g = e[j];
               for (int k = j; k <= i-1; k++) {
                  V[k][j] -= (f * e[k] + g * d[k]);
               }
               d[j] = V[i-1][j];
               V[i][j] = 0.0;
            }
         }
         d[i] = h;
      }
   
      // Accumulate transformations.
   
      for (int i = 0; i < n-1; i++) {
         V[n-1][i] = V[i][i];
         V[i][i] = 1.0;
         Real h = d[i+1];
         if (h != 0.0) {
            for (int k = 0; k <= i; k++) {
               d[k] = V[k][i+1] / h;
            }
            for (int j = 0; j <= i; j++) {
               Real g = 0.0;
               for (int k = 0; k <= i; k++) {
                  g += V[k][i+1] * V[k][j];
               }
               for (int k = 0; k <= i; k++) {
                  V[k][j] -= g * d[k];
               }
            }
         }
         for (int k = 0; k <= i; k++) {
            V[k][i+1] = 0.0;
         }
      }
      for (int j = 0; j < n; j++) {
         d[j] = V[n-1][j];
         V[n-1][j] = 0.0;
      }
      V[n-1][n-1] = 1.0;
      e[0] = 0.0;
   } 

   // Symmetric tridiagonal QL algorithm.
   
   void tql2 () {

   //  This is derived from the Algol procedures tql2, by
   //  Bowdler, Martin, Reinsch, and Wilkinson, Handbook for
   //  Auto. Comp., Vol.ii-Linear Algebra, and the corresponding
   //  Fortran subroutine in EISPACK.
   
      for (int i = 1; i < n; i++) {
         e[i-1] = e[i];
      }
      e[n-1] = 0.0;
   
      Real f = 0.0;
      Real tst1 = 0.0;
      Real eps = pow(2.0,-52.0);
      for (int l = 0; l < n; l++) {

         // Find small subdiagonal element
   
         tst1 = TNT::max(tst1,abs(d[l]) + abs(e[l]));
         int m = l;

        // Original while-loop from Java code
         while (m < n) {
            if (abs(e[m]) <= eps*tst1) {
               break;
            }
            m++;
         }

   
         // If m == l, d[l] is an eigenvalue,
         // otherwise, iterate.
   
         if (m > l) {
            int iter = 0;
            do {
               iter = iter + 1;  // (Could check iteration count here.)
   
               // Compute implicit shift
   
               Real g = d[l];
               Real p = (d[l+1] - g) / (2.0 * e[l]);
               Real r = hypot(p,1.0);
               if (p < 0) {
                  r = -r;
               }
               d[l] = e[l] / (p + r);
               d[l+1] = e[l] * (p + r);
               Real dl1 = d[l+1];
               Real h = g - d[l];
               for (int i = l+2; i < n; i++) {
                  d[i] -= h;
               }
               f = f + h;
   
               // Implicit QL transformation.
   
               p = d[m];
               Real c = 1.0;
               Real c2 = c;
               Real c3 = c;
               Real el1 = e[l+1];
               Real s = 0.0;
               Real s2 = 0.0;
               for (int i = m-1; i >= l; i--) {
                  c3 = c2;
                  c2 = c;
                  s2 = s;
                  g = c * e[i];
                  h = c * p;
                  r = hypot(p,e[i]);
                  e[i+1] = s * r;
                  s = e[i] / r;
                  c = p / r;
                  p = c * d[i] - s * g;
                  d[i+1] = h + s * (c * g + s * d[i]);
   
                  // Accumulate transformation.
   
                  for (int k = 0; k < n; k++) {
                     h = V[k][i+1];
                     V[k][i+1] = s * V[k][i] + c * h;
                     V[k][i] = c * V[k][i] - s * h;
                  }
               }
               p = -s * s2 * c3 * el1 * e[l] / dl1;
               e[l] = s * p;
               d[l] = c * p;
   
               // Check for convergence.
   
            } while (abs(e[l]) > eps*tst1);
         }
         d[l] = d[l] + f;
         e[l] = 0.0;
      }
     
      // Sort eigenvalues and corresponding vectors.
   
      for (int i = 0; i < n-1; i++) {
         int k = i;
         Real p = d[i];
         for (int j = i+1; j < n; j++) {
            if (d[j] < p) {
               k = j;
               p = d[j];
            }
         }
         if (k != i) {
            d[k] = d[i];
            d[i] = p;
            for (int j = 0; j < n; j++) {
               p = V[j][i];
               V[j][i] = V[j][k];
               V[j][k] = p;
            }
         }
      }
   }

   // Nonsymmetric reduction to Hessenberg form.

   void orthes () {
   
      //  This is derived from the Algol procedures orthes and ortran,
      //  by Martin and Wilkinson, Handbook for Auto. Comp.,
      //  Vol.ii-Linear Algebra, and the corresponding
      //  Fortran subroutines in EISPACK.
   
      int low = 0;
      int high = n-1;
   
      for (int m = low+1; m <= high-1; m++) {
   
         // Scale column.
   
         Real scale = 0.0;
         for (int i = m; i <= high; i++) {
            scale = scale + abs(H[i][m-1]);
         }
         if (scale != 0.0) {
   
            // Compute Householder transformation.
   
            Real h = 0.0;
            for (int i = high; i >= m; i--) {
               ort[i] = H[i][m-1]/scale;
               h += ort[i] * ort[i];
            }
            Real g = sqrt(h);
            if (ort[m] > 0) {
               g = -g;
            }
            h = h - ort[m] * g;
            ort[m] = ort[m] - g;
   
            // Apply Householder similarity transformation
            // H = (I-u*u'/h)*H*(I-u*u')/h)
   
            for (int j = m; j < n; j++) {
               Real f = 0.0;
               for (int i = high; i >= m; i--) {
                  f += ort[i]*H[i][j];
               }
               f = f/h;
               for (int i = m; i <= high; i++) {
                  H[i][j] -= f*ort[i];
               }
           }
   
           for (int i = 0; i <= high; i++) {
               Real f = 0.0;
               for (int j = high; j >= m; j--) {
                  f += ort[j]*H[i][j];
               }
               f = f/h;
               for (int j = m; j <= high; j++) {
                  H[i][j] -= f*ort[j];
               }
            }
            ort[m] = scale*ort[m];
            H[m][m-1] = scale*g;
         }
      }
   
      // Accumulate transformations (Algol's ortran).

      for (int i = 0; i < n; i++) {
         for (int j = 0; j < n; j++) {
            V[i][j] = (i == j ? 1.0 : 0.0);
         }
      }

      for (int m = high-1; m >= low+1; m--) {
         if (H[m][m-1] != 0.0) {
            for (int i = m+1; i <= high; i++) {
               ort[i] = H[i][m-1];
            }
            for (int j = m; j <= high; j++) {
               Real g = 0.0;
               for (int i = m; i <= high; i++) {
                  g += ort[i] * V[i][j];
               }
               // Double division avoids possible underflow
               g = (g / ort[m]) / H[m][m-1];
               for (int i = m; i <= high; i++) {
                  V[i][j] += g * ort[i];
               }
            }
         }
      }
   }


   // Complex scalar division.

   Real cdivr, cdivi;
   void cdiv(Real xr, Real xi, Real yr, Real yi) {
      Real r,d;
      if (abs(yr) > abs(yi)) {
         r = yi/yr;
         d = yr + r*yi;
         cdivr = (xr + r*xi)/d;
         cdivi = (xi - r*xr)/d;
      } else {
         r = yr/yi;
         d = yi + r*yr;
         cdivr = (r*xr + xi)/d;
         cdivi = (r*xi - xr)/d;
      }
   }


   // Nonsymmetric reduction from Hessenberg to real Schur form.

   void hqr2 () {
   
      //  This is derived from the Algol procedure hqr2,
      //  by Martin and Wilkinson, Handbook for Auto. Comp.,
      //  Vol.ii-Linear Algebra, and the corresponding
      //  Fortran subroutine in EISPACK.
   
      // Initialize
   
      int nn = this->n;
      int n = nn-1;
      int low = 0;
      int high = nn-1;
      Real eps = pow(2.0,-52.0);
      Real exshift = 0.0;
      Real p=0,q=0,r=0,s=0,z=0,t,w,x,y;
   
      // Store roots isolated by balanc and compute matrix norm
   
      Real norm = 0.0;
      for (int i = 0; i < nn; i++) {
         if ((i < low) || (i > high)) {
            d[i] = H[i][i];
            e[i] = 0.0;
         }
         for (int j = TNT::max(i-1,0); j < nn; j++) {
            norm = norm + abs(H[i][j]);
         }
      }
   
      // Outer loop over eigenvalue index
   
      int iter = 0;
      while (n >= low) {
   
         // Look for single small sub-diagonal element
   
         int l = n;
         while (l > low) {
            s = abs(H[l-1][l-1]) + abs(H[l][l]);
            if (s == 0.0) {
               s = norm;
            }
            if (abs(H[l][l-1]) < eps * s) {
               break;
            }
            l--;
         }
       
         // Check for convergence
         // One root found
   
         if (l == n) {
            H[n][n] = H[n][n] + exshift;
            d[n] = H[n][n];
            e[n] = 0.0;
            n--;
            iter = 0;
   
         // Two roots found
   
         } else if (l == n-1) {
            w = H[n][n-1] * H[n-1][n];

?? 快捷鍵說明

復制代碼 Ctrl + C
搜索代碼 Ctrl + F
全屏模式 F11
切換主題 Ctrl + Shift + D
顯示快捷鍵 ?
增大字號 Ctrl + =
減小字號 Ctrl + -
亚洲欧美第一页_禁久久精品乱码_粉嫩av一区二区三区免费野_久草精品视频
日韩欧美的一区二区| 成人免费毛片aaaaa**| 欧美精品乱码久久久久久| 亚洲午夜av在线| 9191精品国产综合久久久久久| 夜夜精品浪潮av一区二区三区| 欧美性受极品xxxx喷水| 午夜不卡在线视频| 精品国产91乱码一区二区三区| 国产精品66部| 国产精品成人一区二区三区夜夜夜| 成人av资源站| 亚洲国产成人av好男人在线观看| 欧美高清精品3d| 国产一区二区三区综合| 国产欧美一二三区| 欧美吻胸吃奶大尺度电影| 日韩精品一二三区| 国产欧美日韩不卡免费| 99久久精品国产观看| 五月天中文字幕一区二区| 日韩免费一区二区三区在线播放| 国产精品99久久久久久有的能看 | 91麻豆精品国产自产在线| 狠狠色狠狠色综合| 国产精品国产精品国产专区不片| 欧美日韩激情一区| 大白屁股一区二区视频| 五月婷婷综合激情| 国产日韩欧美一区二区三区乱码 | 欧美精品久久久久久久久老牛影院| 精品无人码麻豆乱码1区2区 | 久久久99精品免费观看不卡| 色婷婷久久久亚洲一区二区三区 | 欧美日韩国产片| 成人午夜视频在线观看| 日韩激情在线观看| 国产精品无遮挡| 欧美一级生活片| 91玉足脚交白嫩脚丫在线播放| 男男视频亚洲欧美| 亚洲少妇屁股交4| 久久综合久久综合久久| 欧美麻豆精品久久久久久| av在线播放成人| 久草热8精品视频在线观看| 亚洲一区二区三区国产| 在线视频一区二区三| 亚洲国产视频在线| 亚洲国产另类av| 91精品午夜视频| 99re亚洲国产精品| 九九**精品视频免费播放| 亚洲自拍偷拍图区| 中文字幕在线一区二区三区| 欧美一级一区二区| 欧美色综合久久| 色噜噜狠狠成人中文综合 | 国产精品乱码人人做人人爱| 91精品国产91久久久久久一区二区| 91在线一区二区| 国产中文一区二区三区| 久久精品999| 日韩电影在线看| 亚洲福利国产精品| 亚洲在线视频网站| 亚洲色大成网站www久久九九| 国产日韩精品一区二区三区 | 国产欧美一二三区| 久久综合九色综合97婷婷女人| 91精品欧美久久久久久动漫| 欧美日韩免费观看一区二区三区| 欧美日韩国产综合视频在线观看| 色综合久久中文字幕综合网| av亚洲精华国产精华| av电影在线观看完整版一区二区| 日韩电影在线一区二区三区| 久久女同精品一区二区| 日本网站在线观看一区二区三区| 亚洲日穴在线视频| 日韩理论片在线| 亚洲女厕所小便bbb| 亚洲欧洲日产国产综合网| 亚洲国产精品激情在线观看| 国产精品麻豆一区二区| 国产精品久久久久精k8| 中文字幕日韩精品一区| 亚洲日本电影在线| 一区二区三区精品在线| 午夜激情综合网| 久久精品99久久久| 国产v综合v亚洲欧| 91在线观看成人| 欧美日韩电影一区| 久久久影院官网| 亚洲人被黑人高潮完整版| 亚洲福利电影网| 裸体在线国模精品偷拍| 国产精品一区二区三区四区| a美女胸又www黄视频久久| 91久久精品一区二区二区| 91麻豆精品国产91久久久更新时间| 日韩写真欧美这视频| 久久精品一区蜜桃臀影院| 亚洲激情在线播放| 久久精品久久久精品美女| 成人精品亚洲人成在线| 日本高清成人免费播放| 日韩一区二区三区免费观看| 中文字幕第一页久久| 午夜视频一区二区三区| 福利91精品一区二区三区| 欧美在线播放高清精品| 精品久久久三级丝袜| 亚洲精品高清在线| 久久国产免费看| 色综合欧美在线视频区| 欧美不卡123| 亚洲丝袜美腿综合| 免费视频最近日韩| 色综合久久精品| 337p日本欧洲亚洲大胆精品| 亚洲少妇最新在线视频| 国内精品视频666| 欧美日韩国产成人在线91| 中文在线一区二区| 日韩精品1区2区3区| 94-欧美-setu| 国产日韩欧美一区二区三区乱码 | 日韩三级视频中文字幕| 欧美一区二区美女| 亚洲精品自拍动漫在线| 国产麻豆精品久久一二三| www.亚洲激情.com| 久久这里只有精品首页| 国产精品一品二品| 91蝌蚪porny| 久久女同性恋中文字幕| 偷窥少妇高潮呻吟av久久免费| 久久久91精品国产一区二区精品 | 亚洲一区二三区| 国产精品一区一区| 欧美精品一级二级| 中文字幕一区二区5566日韩| 久久激情五月婷婷| 欧美日韩在线亚洲一区蜜芽| 久久久国产精品麻豆| 国产自产视频一区二区三区| 欧美日韩成人一区二区| 国产精品电影一区二区三区| 成人激情小说乱人伦| 久久蜜桃av一区精品变态类天堂 | 国产一区 二区| 亚洲欧洲av色图| 91视频免费观看| 欧美激情一区不卡| 欧美性受xxxx黑人xyx| 亚洲人成影院在线观看| 久久亚洲综合色| 亚洲日本一区二区| 国产精品国产成人国产三级 | 91福利视频在线| 久久久久9999亚洲精品| 国产99精品国产| 中文字幕亚洲精品在线观看| 奇米综合一区二区三区精品视频| 欧美亚洲免费在线一区| 国产成人精品免费网站| 日本va欧美va瓶| ●精品国产综合乱码久久久久| 色综合久久久久网| 激情综合色综合久久| 国产欧美日韩另类一区| 亚洲欧美另类综合偷拍| 久久久99精品免费观看不卡| 欧美四级电影在线观看| 在线观看不卡视频| 欧洲精品在线观看| 欧美日韩激情一区| 色欧美88888久久久久久影院| 亚洲大片免费看| 亚洲视频在线一区二区| 国产精品久久久久永久免费观看| 欧美大片国产精品| 一本色道久久综合亚洲91 | 亚洲福中文字幕伊人影院| 欧美tickling网站挠脚心| 色视频一区二区| 成人教育av在线| 国产一区二区毛片| 免费成人你懂的| 日韩不卡免费视频| 中文字幕不卡在线| 欧美精品一区二区三| 欧美日韩激情一区二区三区| av一区二区三区| 波多野结衣的一区二区三区| 99国产欧美另类久久久精品| 麻豆91在线播放免费| 日韩1区2区3区|