btImplicitQRSVD.h 24 KB

123456789101112131415161718192021222324252627282930313233343536373839404142434445464748495051525354555657585960616263646566676869707172737475767778798081828384858687888990919293949596979899100101102103104105106107108109110111112113114115116117118119120121122123124125126127128129130131132133134135136137138139140141142143144145146147148149150151152153154155156157158159160161162163164165166167168169170171172173174175176177178179180181182183184185186187188189190191192193194195196197198199200201202203204205206207208209210211212213214215216217218219220221222223224225226227228229230231232233234235236237238239240241242243244245246247248249250251252253254255256257258259260261262263264265266267268269270271272273274275276277278279280281282283284285286287288289290291292293294295296297298299300301302303304305306307308309310311312313314315316317318319320321322323324325326327328329330331332333334335336337338339340341342343344345346347348349350351352353354355356357358359360361362363364365366367368369370371372373374375376377378379380381382383384385386387388389390391392393394395396397398399400401402403404405406407408409410411412413414415416417418419420421422423424425426427428429430431432433434435436437438439440441442443444445446447448449450451452453454455456457458459460461462463464465466467468469470471472473474475476477478479480481482483484485486487488489490491492493494495496497498499500501502503504505506507508509510511512513514515516517518519520521522523524525526527528529530531532533534535536537538539540541542543544545546547548549550551552553554555556557558559560561562563564565566567568569570571572573574575576577578579580581582583584585586587588589590591592593594595596597598599600601602603604605606607608609610611612613614615616617618619620621622623624625626627628629630631632633634635636637638639640641642643644645646647648649650651652653654655656657658659660661662663664665666667668669670671672673674675676677678679680681682683684685686687688689690691692693694695696697698699700701702703704705706707708709710711712713714715716717718719720721722723724725726727728729730731732733734735736737738739740741742743744745746747748749750751752753754755756757758759760761762763764765766767768769770771772773774775776777778779780781782783784785786787788789790791792793794795796797798799800801802803804805806807808809810811812813814815816817818819820821822823824825826827828829830831832833834835836837838839840841842843844845846847848849850851852853854855856857858859860861862863864865866867868869870871872873874875876877878879880881882883884885886887888889890891892893894895896897898899900901902903904905906907908909910911912913914915916
  1. /**
  2. Bullet Continuous Collision Detection and Physics Library
  3. Copyright (c) 2019 Google Inc. http://bulletphysics.org
  4. This software is provided 'as-is', without any express or implied warranty.
  5. In no event will the authors be held liable for any damages arising from the use of this software.
  6. Permission is granted to anyone to use this software for any purpose,
  7. including commercial applications, and to alter it and redistribute it freely,
  8. subject to the following restrictions:
  9. 1. The origin of this software must not be misrepresented; you must not claim that you wrote the original software. If you use this software in a product, an acknowledgment in the product documentation would be appreciated but is not required.
  10. 2. Altered source versions must be plainly marked as such, and must not be misrepresented as being the original software.
  11. 3. This notice may not be removed or altered from any source distribution.
  12. Copyright (c) 2016 Theodore Gast, Chuyuan Fu, Chenfanfu Jiang, Joseph Teran
  13. Permission is hereby granted, free of charge, to any person obtaining a copy of
  14. this software and associated documentation files (the "Software"), to deal in
  15. the Software without restriction, including without limitation the rights to
  16. use, copy, modify, merge, publish, distribute, sublicense, and/or sell copies
  17. of the Software, and to permit persons to whom the Software is furnished to do
  18. so, subject to the following conditions:
  19. The above copyright notice and this permission notice shall be included in all
  20. copies or substantial portions of the Software.
  21. If the code is used in an article, the following paper shall be cited:
  22. @techreport{qrsvd:2016,
  23. title={Implicit-shifted Symmetric QR Singular Value Decomposition of 3x3 Matrices},
  24. author={Gast, Theodore and Fu, Chuyuan and Jiang, Chenfanfu and Teran, Joseph},
  25. year={2016},
  26. institution={University of California Los Angeles}
  27. }
  28. THE SOFTWARE IS PROVIDED "AS IS", WITHOUT WARRANTY OF ANY KIND, EXPRESS OR
  29. IMPLIED, INCLUDING BUT NOT LIMITED TO THE WARRANTIES OF MERCHANTABILITY,
  30. FITNESS FOR A PARTICULAR PURPOSE AND NONINFRINGEMENT. IN NO EVENT SHALL THE
  31. AUTHORS OR COPYRIGHT HOLDERS BE LIABLE FOR ANY CLAIM, DAMAGES OR OTHER
  32. LIABILITY, WHETHER IN AN ACTION OF CONTRACT, TORT OR OTHERWISE, ARISING FROM,
  33. OUT OF OR IN CONNECTION WITH THE SOFTWARE OR THE USE OR OTHER DEALINGS IN THE
  34. SOFTWARE.
  35. **/
  36. #ifndef btImplicitQRSVD_h
  37. #define btImplicitQRSVD_h
  38. #include "btMatrix3x3.h"
  39. class btMatrix2x2
  40. {
  41. public:
  42. btScalar m_00, m_01, m_10, m_11;
  43. btMatrix2x2(): m_00(0), m_10(0), m_01(0), m_11(0)
  44. {
  45. }
  46. btMatrix2x2(const btMatrix2x2& other): m_00(other.m_00),m_01(other.m_01),m_10(other.m_10),m_11(other.m_11)
  47. {}
  48. btScalar& operator()(int i, int j)
  49. {
  50. if (i == 0 && j == 0)
  51. return m_00;
  52. if (i == 1 && j == 0)
  53. return m_10;
  54. if (i == 0 && j == 1)
  55. return m_01;
  56. if (i == 1 && j == 1)
  57. return m_11;
  58. btAssert(false);
  59. return m_00;
  60. }
  61. const btScalar& operator()(int i, int j) const
  62. {
  63. if (i == 0 && j == 0)
  64. return m_00;
  65. if (i == 1 && j == 0)
  66. return m_10;
  67. if (i == 0 && j == 1)
  68. return m_01;
  69. if (i == 1 && j == 1)
  70. return m_11;
  71. btAssert(false);
  72. return m_00;
  73. }
  74. void setIdentity()
  75. {
  76. m_00 = 1;
  77. m_11 = 1;
  78. m_01 = 0;
  79. m_10 = 0;
  80. }
  81. };
  82. static inline btScalar copySign(btScalar x, btScalar y) {
  83. if ((x < 0 && y > 0) || (x > 0 && y < 0))
  84. return -x;
  85. return x;
  86. }
  87. /**
  88. Class for givens rotation.
  89. Row rotation G*A corresponds to something like
  90. c -s 0
  91. ( s c 0 ) A
  92. 0 0 1
  93. Column rotation A G' corresponds to something like
  94. c -s 0
  95. A ( s c 0 )
  96. 0 0 1
  97. c and s are always computed so that
  98. ( c -s ) ( a ) = ( * )
  99. s c b ( 0 )
  100. Assume rowi<rowk.
  101. */
  102. class GivensRotation {
  103. public:
  104. int rowi;
  105. int rowk;
  106. btScalar c;
  107. btScalar s;
  108. inline GivensRotation(int rowi_in, int rowk_in)
  109. : rowi(rowi_in)
  110. , rowk(rowk_in)
  111. , c(1)
  112. , s(0)
  113. {
  114. }
  115. inline GivensRotation(btScalar a, btScalar b, int rowi_in, int rowk_in)
  116. : rowi(rowi_in)
  117. , rowk(rowk_in)
  118. {
  119. compute(a, b);
  120. }
  121. ~GivensRotation() {}
  122. inline void transposeInPlace()
  123. {
  124. s = -s;
  125. }
  126. /**
  127. Compute c and s from a and b so that
  128. ( c -s ) ( a ) = ( * )
  129. s c b ( 0 )
  130. */
  131. inline void compute(const btScalar a, const btScalar b)
  132. {
  133. btScalar d = a * a + b * b;
  134. c = 1;
  135. s = 0;
  136. if (d > SIMD_EPSILON) {
  137. btScalar sqrtd = btSqrt(d);
  138. if (sqrtd>SIMD_EPSILON)
  139. {
  140. btScalar t = btScalar(1.0)/sqrtd;
  141. c = a * t;
  142. s = -b * t;
  143. }
  144. }
  145. }
  146. /**
  147. This function computes c and s so that
  148. ( c -s ) ( a ) = ( 0 )
  149. s c b ( * )
  150. */
  151. inline void computeUnconventional(const btScalar a, const btScalar b)
  152. {
  153. btScalar d = a * a + b * b;
  154. c = 0;
  155. s = 1;
  156. if (d > SIMD_EPSILON) {
  157. btScalar t = btScalar(1.0)/btSqrt(d);
  158. s = a * t;
  159. c = b * t;
  160. }
  161. }
  162. /**
  163. Fill the R with the entries of this rotation
  164. */
  165. inline void fill(const btMatrix3x3& R) const
  166. {
  167. btMatrix3x3& A = const_cast<btMatrix3x3&>(R);
  168. A.setIdentity();
  169. A[rowi][rowi] = c;
  170. A[rowk][rowi] = -s;
  171. A[rowi][rowk] = s;
  172. A[rowk][rowk] = c;
  173. }
  174. inline void fill(const btMatrix2x2& R) const
  175. {
  176. btMatrix2x2& A = const_cast<btMatrix2x2&>(R);
  177. A(rowi,rowi) = c;
  178. A(rowk,rowi) = -s;
  179. A(rowi,rowk) = s;
  180. A(rowk,rowk) = c;
  181. }
  182. /**
  183. This function does something like
  184. c -s 0
  185. ( s c 0 ) A -> A
  186. 0 0 1
  187. It only affects row i and row k of A.
  188. */
  189. inline void rowRotation(btMatrix3x3& A) const
  190. {
  191. for (int j = 0; j < 3; j++) {
  192. btScalar tau1 = A[rowi][j];
  193. btScalar tau2 = A[rowk][j];
  194. A[rowi][j] = c * tau1 - s * tau2;
  195. A[rowk][j] = s * tau1 + c * tau2;
  196. }
  197. }
  198. inline void rowRotation(btMatrix2x2& A) const
  199. {
  200. for (int j = 0; j < 2; j++) {
  201. btScalar tau1 = A(rowi,j);
  202. btScalar tau2 = A(rowk,j);
  203. A(rowi,j) = c * tau1 - s * tau2;
  204. A(rowk,j) = s * tau1 + c * tau2;
  205. }
  206. }
  207. /**
  208. This function does something like
  209. c s 0
  210. A ( -s c 0 ) -> A
  211. 0 0 1
  212. It only affects column i and column k of A.
  213. */
  214. inline void columnRotation(btMatrix3x3& A) const
  215. {
  216. for (int j = 0; j < 3; j++) {
  217. btScalar tau1 = A[j][rowi];
  218. btScalar tau2 = A[j][rowk];
  219. A[j][rowi] = c * tau1 - s * tau2;
  220. A[j][rowk] = s * tau1 + c * tau2;
  221. }
  222. }
  223. inline void columnRotation(btMatrix2x2& A) const
  224. {
  225. for (int j = 0; j < 2; j++) {
  226. btScalar tau1 = A(j,rowi);
  227. btScalar tau2 = A(j,rowk);
  228. A(j,rowi) = c * tau1 - s * tau2;
  229. A(j,rowk) = s * tau1 + c * tau2;
  230. }
  231. }
  232. /**
  233. Multiply givens must be for same row and column
  234. **/
  235. inline void operator*=(const GivensRotation& A)
  236. {
  237. btScalar new_c = c * A.c - s * A.s;
  238. btScalar new_s = s * A.c + c * A.s;
  239. c = new_c;
  240. s = new_s;
  241. }
  242. /**
  243. Multiply givens must be for same row and column
  244. **/
  245. inline GivensRotation operator*(const GivensRotation& A) const
  246. {
  247. GivensRotation r(*this);
  248. r *= A;
  249. return r;
  250. }
  251. };
  252. /**
  253. \brief zero chasing the 3X3 matrix to bidiagonal form
  254. original form of H: x x 0
  255. x x x
  256. 0 0 x
  257. after zero chase:
  258. x x 0
  259. 0 x x
  260. 0 0 x
  261. */
  262. inline void zeroChase(btMatrix3x3& H, btMatrix3x3& U, btMatrix3x3& V)
  263. {
  264. /**
  265. Reduce H to of form
  266. x x +
  267. 0 x x
  268. 0 0 x
  269. */
  270. GivensRotation r1(H[0][0], H[1][0], 0, 1);
  271. /**
  272. Reduce H to of form
  273. x x 0
  274. 0 x x
  275. 0 + x
  276. Can calculate r2 without multiplying by r1 since both entries are in first two
  277. rows thus no need to divide by sqrt(a^2+b^2)
  278. */
  279. GivensRotation r2(1, 2);
  280. if (H[1][0] != 0)
  281. r2.compute(H[0][0] * H[0][1] + H[1][0] * H[1][1], H[0][0] * H[0][2] + H[1][0] * H[1][2]);
  282. else
  283. r2.compute(H[0][1], H[0][2]);
  284. r1.rowRotation(H);
  285. /* GivensRotation<T> r2(H(0, 1), H(0, 2), 1, 2); */
  286. r2.columnRotation(H);
  287. r2.columnRotation(V);
  288. /**
  289. Reduce H to of form
  290. x x 0
  291. 0 x x
  292. 0 0 x
  293. */
  294. GivensRotation r3(H[1][1], H[2][1], 1, 2);
  295. r3.rowRotation(H);
  296. // Save this till end for better cache coherency
  297. // r1.rowRotation(u_transpose);
  298. // r3.rowRotation(u_transpose);
  299. r1.columnRotation(U);
  300. r3.columnRotation(U);
  301. }
  302. /**
  303. \brief make a 3X3 matrix to upper bidiagonal form
  304. original form of H: x x x
  305. x x x
  306. x x x
  307. after zero chase:
  308. x x 0
  309. 0 x x
  310. 0 0 x
  311. */
  312. inline void makeUpperBidiag(btMatrix3x3& H, btMatrix3x3& U, btMatrix3x3& V)
  313. {
  314. U.setIdentity();
  315. V.setIdentity();
  316. /**
  317. Reduce H to of form
  318. x x x
  319. x x x
  320. 0 x x
  321. */
  322. GivensRotation r(H[1][0], H[2][0], 1, 2);
  323. r.rowRotation(H);
  324. // r.rowRotation(u_transpose);
  325. r.columnRotation(U);
  326. // zeroChase(H, u_transpose, V);
  327. zeroChase(H, U, V);
  328. }
  329. /**
  330. \brief make a 3X3 matrix to lambda shape
  331. original form of H: x x x
  332. * x x x
  333. * x x x
  334. after :
  335. * x 0 0
  336. * x x 0
  337. * x 0 x
  338. */
  339. inline void makeLambdaShape(btMatrix3x3& H, btMatrix3x3& U, btMatrix3x3& V)
  340. {
  341. U.setIdentity();
  342. V.setIdentity();
  343. /**
  344. Reduce H to of form
  345. * x x 0
  346. * x x x
  347. * x x x
  348. */
  349. GivensRotation r1(H[0][1], H[0][2], 1, 2);
  350. r1.columnRotation(H);
  351. r1.columnRotation(V);
  352. /**
  353. Reduce H to of form
  354. * x x 0
  355. * x x 0
  356. * x x x
  357. */
  358. r1.computeUnconventional(H[1][2], H[2][2]);
  359. r1.rowRotation(H);
  360. r1.columnRotation(U);
  361. /**
  362. Reduce H to of form
  363. * x x 0
  364. * x x 0
  365. * x 0 x
  366. */
  367. GivensRotation r2(H[2][0], H[2][1], 0, 1);
  368. r2.columnRotation(H);
  369. r2.columnRotation(V);
  370. /**
  371. Reduce H to of form
  372. * x 0 0
  373. * x x 0
  374. * x 0 x
  375. */
  376. r2.computeUnconventional(H[0][1], H[1][1]);
  377. r2.rowRotation(H);
  378. r2.columnRotation(U);
  379. }
  380. /**
  381. \brief 2x2 polar decomposition.
  382. \param[in] A matrix.
  383. \param[out] R Robustly a rotation matrix.
  384. \param[out] S_Sym Symmetric. Whole matrix is stored
  385. Polar guarantees negative sign is on the small magnitude singular value.
  386. S is guaranteed to be the closest one to identity.
  387. R is guaranteed to be the closest rotation to A.
  388. */
  389. inline void polarDecomposition(const btMatrix2x2& A,
  390. GivensRotation& R,
  391. const btMatrix2x2& S_Sym)
  392. {
  393. btScalar a = (A(0, 0) + A(1, 1)), b = (A(1, 0) - A(0, 1));
  394. btScalar denominator = btSqrt(a*a+b*b);
  395. R.c = (btScalar)1;
  396. R.s = (btScalar)0;
  397. if (denominator > SIMD_EPSILON) {
  398. /*
  399. No need to use a tolerance here because x(0) and x(1) always have
  400. smaller magnitude then denominator, therefore overflow never happens.
  401. In Bullet, we use a tolerance anyway.
  402. */
  403. R.c = a / denominator;
  404. R.s = -b / denominator;
  405. }
  406. btMatrix2x2& S = const_cast<btMatrix2x2&>(S_Sym);
  407. S = A;
  408. R.rowRotation(S);
  409. }
  410. inline void polarDecomposition(const btMatrix2x2& A,
  411. const btMatrix2x2& R,
  412. const btMatrix2x2& S_Sym)
  413. {
  414. GivensRotation r(0, 1);
  415. polarDecomposition(A, r, S_Sym);
  416. r.fill(R);
  417. }
  418. /**
  419. \brief 2x2 SVD (singular value decomposition) A=USV'
  420. \param[in] A Input matrix.
  421. \param[out] U Robustly a rotation matrix in Givens form
  422. \param[out] Sigma matrix of singular values sorted with decreasing magnitude. The second one can be negative.
  423. \param[out] V Robustly a rotation matrix in Givens form
  424. */
  425. inline void singularValueDecomposition(
  426. const btMatrix2x2& A,
  427. GivensRotation& U,
  428. const btMatrix2x2& Sigma,
  429. GivensRotation& V,
  430. const btScalar tol = 64 * std::numeric_limits<btScalar>::epsilon())
  431. {
  432. btMatrix2x2& sigma = const_cast<btMatrix2x2&>(Sigma);
  433. sigma.setIdentity();
  434. btMatrix2x2 S_Sym;
  435. polarDecomposition(A, U, S_Sym);
  436. btScalar cosine, sine;
  437. btScalar x = S_Sym(0, 0);
  438. btScalar y = S_Sym(0, 1);
  439. btScalar z = S_Sym(1, 1);
  440. if (y == 0) {
  441. // S is already diagonal
  442. cosine = 1;
  443. sine = 0;
  444. sigma(0,0) = x;
  445. sigma(1,1) = z;
  446. }
  447. else {
  448. btScalar tau = 0.5 * (x - z);
  449. btScalar val = tau * tau + y * y;
  450. if (val > SIMD_EPSILON)
  451. {
  452. btScalar w = btSqrt(val);
  453. // w > y > 0
  454. btScalar t;
  455. if (tau > 0) {
  456. // tau + w > w > y > 0 ==> division is safe
  457. t = y / (tau + w);
  458. }
  459. else {
  460. // tau - w < -w < -y < 0 ==> division is safe
  461. t = y / (tau - w);
  462. }
  463. cosine = btScalar(1) / btSqrt(t * t + btScalar(1));
  464. sine = -t * cosine;
  465. /*
  466. V = [cosine -sine; sine cosine]
  467. Sigma = V'SV. Only compute the diagonals for efficiency.
  468. Also utilize symmetry of S and don't form V yet.
  469. */
  470. btScalar c2 = cosine * cosine;
  471. btScalar csy = 2 * cosine * sine * y;
  472. btScalar s2 = sine * sine;
  473. sigma(0,0) = c2 * x - csy + s2 * z;
  474. sigma(1,1) = s2 * x + csy + c2 * z;
  475. } else
  476. {
  477. cosine = 1;
  478. sine = 0;
  479. sigma(0,0) = x;
  480. sigma(1,1) = z;
  481. }
  482. }
  483. // Sorting
  484. // Polar already guarantees negative sign is on the small magnitude singular value.
  485. if (sigma(0,0) < sigma(1,1)) {
  486. std::swap(sigma(0,0), sigma(1,1));
  487. V.c = -sine;
  488. V.s = cosine;
  489. }
  490. else {
  491. V.c = cosine;
  492. V.s = sine;
  493. }
  494. U *= V;
  495. }
  496. /**
  497. \brief 2x2 SVD (singular value decomposition) A=USV'
  498. \param[in] A Input matrix.
  499. \param[out] U Robustly a rotation matrix.
  500. \param[out] Sigma Vector of singular values sorted with decreasing magnitude. The second one can be negative.
  501. \param[out] V Robustly a rotation matrix.
  502. */
  503. inline void singularValueDecomposition(
  504. const btMatrix2x2& A,
  505. const btMatrix2x2& U,
  506. const btMatrix2x2& Sigma,
  507. const btMatrix2x2& V,
  508. const btScalar tol = 64 * std::numeric_limits<btScalar>::epsilon())
  509. {
  510. GivensRotation gv(0, 1);
  511. GivensRotation gu(0, 1);
  512. singularValueDecomposition(A, gu, Sigma, gv);
  513. gu.fill(U);
  514. gv.fill(V);
  515. }
  516. /**
  517. \brief compute wilkinsonShift of the block
  518. a1 b1
  519. b1 a2
  520. based on the wilkinsonShift formula
  521. mu = c + d - sign (d) \ sqrt (d*d + b*b), where d = (a-c)/2
  522. */
  523. inline btScalar wilkinsonShift(const btScalar a1, const btScalar b1, const btScalar a2)
  524. {
  525. btScalar d = (btScalar)0.5 * (a1 - a2);
  526. btScalar bs = b1 * b1;
  527. btScalar val = d * d + bs;
  528. if (val>SIMD_EPSILON)
  529. {
  530. btScalar denom = btFabs(d) + btSqrt(val);
  531. btScalar mu = a2 - copySign(bs / (denom), d);
  532. // T mu = a2 - bs / ( d + sign_d*sqrt (d*d + bs));
  533. return mu;
  534. }
  535. return a2;
  536. }
  537. /**
  538. \brief Helper function of 3X3 SVD for processing 2X2 SVD
  539. */
  540. template <int t>
  541. inline void process(btMatrix3x3& B, btMatrix3x3& U, btVector3& sigma, btMatrix3x3& V)
  542. {
  543. int other = (t == 1) ? 0 : 2;
  544. GivensRotation u(0, 1);
  545. GivensRotation v(0, 1);
  546. sigma[other] = B[other][other];
  547. btMatrix2x2 B_sub, sigma_sub;
  548. if (t == 0)
  549. {
  550. B_sub.m_00 = B[0][0];
  551. B_sub.m_10 = B[1][0];
  552. B_sub.m_01 = B[0][1];
  553. B_sub.m_11 = B[1][1];
  554. sigma_sub.m_00 = sigma[0];
  555. sigma_sub.m_11 = sigma[1];
  556. // singularValueDecomposition(B.template block<2, 2>(t, t), u, sigma.template block<2, 1>(t, 0), v);
  557. singularValueDecomposition(B_sub, u, sigma_sub, v);
  558. B[0][0] = B_sub.m_00;
  559. B[1][0] = B_sub.m_10;
  560. B[0][1] = B_sub.m_01;
  561. B[1][1] = B_sub.m_11;
  562. sigma[0] = sigma_sub.m_00;
  563. sigma[1] = sigma_sub.m_11;
  564. }
  565. else
  566. {
  567. B_sub.m_00 = B[1][1];
  568. B_sub.m_10 = B[2][1];
  569. B_sub.m_01 = B[1][2];
  570. B_sub.m_11 = B[2][2];
  571. sigma_sub.m_00 = sigma[1];
  572. sigma_sub.m_11 = sigma[2];
  573. // singularValueDecomposition(B.template block<2, 2>(t, t), u, sigma.template block<2, 1>(t, 0), v);
  574. singularValueDecomposition(B_sub, u, sigma_sub, v);
  575. B[1][1] = B_sub.m_00;
  576. B[2][1] = B_sub.m_10;
  577. B[1][2] = B_sub.m_01;
  578. B[2][2] = B_sub.m_11;
  579. sigma[1] = sigma_sub.m_00;
  580. sigma[2] = sigma_sub.m_11;
  581. }
  582. u.rowi += t;
  583. u.rowk += t;
  584. v.rowi += t;
  585. v.rowk += t;
  586. u.columnRotation(U);
  587. v.columnRotation(V);
  588. }
  589. /**
  590. \brief Helper function of 3X3 SVD for flipping signs due to flipping signs of sigma
  591. */
  592. inline void flipSign(int i, btMatrix3x3& U, btVector3& sigma)
  593. {
  594. sigma[i] = -sigma[i];
  595. U[0][i] = -U[0][i];
  596. U[1][i] = -U[1][i];
  597. U[2][i] = -U[2][i];
  598. }
  599. inline void flipSign(int i, btMatrix3x3& U)
  600. {
  601. U[0][i] = -U[0][i];
  602. U[1][i] = -U[1][i];
  603. U[2][i] = -U[2][i];
  604. }
  605. inline void swapCol(btMatrix3x3& A, int i, int j)
  606. {
  607. for (int d = 0; d < 3; ++d)
  608. std::swap(A[d][i], A[d][j]);
  609. }
  610. /**
  611. \brief Helper function of 3X3 SVD for sorting singular values
  612. */
  613. inline void sort(btMatrix3x3& U, btVector3& sigma, btMatrix3x3& V, int t)
  614. {
  615. if (t == 0)
  616. {
  617. // Case: sigma(0) > |sigma(1)| >= |sigma(2)|
  618. if (btFabs(sigma[1]) >= btFabs(sigma[2])) {
  619. if (sigma[1] < 0) {
  620. flipSign(1, U, sigma);
  621. flipSign(2, U, sigma);
  622. }
  623. return;
  624. }
  625. //fix sign of sigma for both cases
  626. if (sigma[2] < 0) {
  627. flipSign(1, U, sigma);
  628. flipSign(2, U, sigma);
  629. }
  630. //swap sigma(1) and sigma(2) for both cases
  631. std::swap(sigma[1], sigma[2]);
  632. // swap the col 1 and col 2 for U,V
  633. swapCol(U,1,2);
  634. swapCol(V,1,2);
  635. // Case: |sigma(2)| >= sigma(0) > |simga(1)|
  636. if (sigma[1] > sigma[0]) {
  637. std::swap(sigma[0], sigma[1]);
  638. swapCol(U,0,1);
  639. swapCol(V,0,1);
  640. }
  641. // Case: sigma(0) >= |sigma(2)| > |simga(1)|
  642. else {
  643. flipSign(2, U);
  644. flipSign(2, V);
  645. }
  646. }
  647. else if (t == 1)
  648. {
  649. // Case: |sigma(0)| >= sigma(1) > |sigma(2)|
  650. if (btFabs(sigma[0]) >= sigma[1]) {
  651. if (sigma[0] < 0) {
  652. flipSign(0, U, sigma);
  653. flipSign(2, U, sigma);
  654. }
  655. return;
  656. }
  657. //swap sigma(0) and sigma(1) for both cases
  658. std::swap(sigma[0], sigma[1]);
  659. swapCol(U, 0, 1);
  660. swapCol(V, 0, 1);
  661. // Case: sigma(1) > |sigma(2)| >= |sigma(0)|
  662. if (btFabs(sigma[1]) < btFabs(sigma[2])) {
  663. std::swap(sigma[1], sigma[2]);
  664. swapCol(U, 1, 2);
  665. swapCol(V, 1, 2);
  666. }
  667. // Case: sigma(1) >= |sigma(0)| > |sigma(2)|
  668. else {
  669. flipSign(1, U);
  670. flipSign(1, V);
  671. }
  672. // fix sign for both cases
  673. if (sigma[1] < 0) {
  674. flipSign(1, U, sigma);
  675. flipSign(2, U, sigma);
  676. }
  677. }
  678. }
  679. /**
  680. \brief 3X3 SVD (singular value decomposition) A=USV'
  681. \param[in] A Input matrix.
  682. \param[out] U is a rotation matrix.
  683. \param[out] sigma Diagonal matrix, sorted with decreasing magnitude. The third one can be negative.
  684. \param[out] V is a rotation matrix.
  685. */
  686. inline int singularValueDecomposition(const btMatrix3x3& A,
  687. btMatrix3x3& U,
  688. btVector3& sigma,
  689. btMatrix3x3& V,
  690. btScalar tol = 128*std::numeric_limits<btScalar>::epsilon())
  691. {
  692. using std::fabs;
  693. btMatrix3x3 B = A;
  694. U.setIdentity();
  695. V.setIdentity();
  696. makeUpperBidiag(B, U, V);
  697. int count = 0;
  698. btScalar mu = (btScalar)0;
  699. GivensRotation r(0, 1);
  700. btScalar alpha_1 = B[0][0];
  701. btScalar beta_1 = B[0][1];
  702. btScalar alpha_2 = B[1][1];
  703. btScalar alpha_3 = B[2][2];
  704. btScalar beta_2 = B[1][2];
  705. btScalar gamma_1 = alpha_1 * beta_1;
  706. btScalar gamma_2 = alpha_2 * beta_2;
  707. btScalar val = alpha_1 * alpha_1 + alpha_2 * alpha_2 + alpha_3 * alpha_3 + beta_1 * beta_1 + beta_2 * beta_2;
  708. if (val > SIMD_EPSILON)
  709. {
  710. tol *= btMax((btScalar)0.5 * btSqrt(val), (btScalar)1);
  711. }
  712. /**
  713. Do implicit shift QR until A^T A is block diagonal
  714. */
  715. int max_count = 100;
  716. while (btFabs(beta_2) > tol && btFabs(beta_1) > tol
  717. && btFabs(alpha_1) > tol && btFabs(alpha_2) > tol
  718. && btFabs(alpha_3) > tol
  719. && count < max_count) {
  720. mu = wilkinsonShift(alpha_2 * alpha_2 + beta_1 * beta_1, gamma_2, alpha_3 * alpha_3 + beta_2 * beta_2);
  721. r.compute(alpha_1 * alpha_1 - mu, gamma_1);
  722. r.columnRotation(B);
  723. r.columnRotation(V);
  724. zeroChase(B, U, V);
  725. alpha_1 = B[0][0];
  726. beta_1 = B[0][1];
  727. alpha_2 = B[1][1];
  728. alpha_3 = B[2][2];
  729. beta_2 = B[1][2];
  730. gamma_1 = alpha_1 * beta_1;
  731. gamma_2 = alpha_2 * beta_2;
  732. count++;
  733. }
  734. /**
  735. Handle the cases of one of the alphas and betas being 0
  736. Sorted by ease of handling and then frequency
  737. of occurrence
  738. If B is of form
  739. x x 0
  740. 0 x 0
  741. 0 0 x
  742. */
  743. if (btFabs(beta_2) <= tol) {
  744. process<0>(B, U, sigma, V);
  745. sort(U, sigma, V,0);
  746. }
  747. /**
  748. If B is of form
  749. x 0 0
  750. 0 x x
  751. 0 0 x
  752. */
  753. else if (btFabs(beta_1) <= tol) {
  754. process<1>(B, U, sigma, V);
  755. sort(U, sigma, V,1);
  756. }
  757. /**
  758. If B is of form
  759. x x 0
  760. 0 0 x
  761. 0 0 x
  762. */
  763. else if (btFabs(alpha_2) <= tol) {
  764. /**
  765. Reduce B to
  766. x x 0
  767. 0 0 0
  768. 0 0 x
  769. */
  770. GivensRotation r1(1, 2);
  771. r1.computeUnconventional(B[1][2], B[2][2]);
  772. r1.rowRotation(B);
  773. r1.columnRotation(U);
  774. process<0>(B, U, sigma, V);
  775. sort(U, sigma, V, 0);
  776. }
  777. /**
  778. If B is of form
  779. x x 0
  780. 0 x x
  781. 0 0 0
  782. */
  783. else if (btFabs(alpha_3) <= tol) {
  784. /**
  785. Reduce B to
  786. x x +
  787. 0 x 0
  788. 0 0 0
  789. */
  790. GivensRotation r1(1, 2);
  791. r1.compute(B[1][1], B[1][2]);
  792. r1.columnRotation(B);
  793. r1.columnRotation(V);
  794. /**
  795. Reduce B to
  796. x x 0
  797. + x 0
  798. 0 0 0
  799. */
  800. GivensRotation r2(0, 2);
  801. r2.compute(B[0][0], B[0][2]);
  802. r2.columnRotation(B);
  803. r2.columnRotation(V);
  804. process<0>(B, U, sigma, V);
  805. sort(U, sigma, V, 0);
  806. }
  807. /**
  808. If B is of form
  809. 0 x 0
  810. 0 x x
  811. 0 0 x
  812. */
  813. else if (btFabs(alpha_1) <= tol) {
  814. /**
  815. Reduce B to
  816. 0 0 +
  817. 0 x x
  818. 0 0 x
  819. */
  820. GivensRotation r1(0, 1);
  821. r1.computeUnconventional(B[0][1], B[1][1]);
  822. r1.rowRotation(B);
  823. r1.columnRotation(U);
  824. /**
  825. Reduce B to
  826. 0 0 0
  827. 0 x x
  828. 0 + x
  829. */
  830. GivensRotation r2(0, 2);
  831. r2.computeUnconventional(B[0][2], B[2][2]);
  832. r2.rowRotation(B);
  833. r2.columnRotation(U);
  834. process<1>(B, U, sigma, V);
  835. sort(U, sigma, V, 1);
  836. }
  837. return count;
  838. }
  839. #endif /* btImplicitQRSVD_h */